Mercurial > repos > iuc > jbrowse
changeset 1:497c6bb3b717 draft
planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/jbrowse commit 0887009a23d176b21536c9fd8a18c4fecc417d4f
| author | iuc | 
|---|---|
| date | Thu, 18 Jun 2015 12:10:51 -0400 | 
| parents | 2c9e5136b416 | 
| children | b6a0e126dbee | 
| files | blastxml_to_gapped_gff3.py gff3_rebase.py jbrowse.py jbrowse.xml macros.xml readme.rst test-data/154.bam test-data/154.bam.bai test-data/154.bw test-data/blast.xml test-data/interpro.gff test-data/merlin.fa test-data/merlin.gff test-data/test.vcf test-data/xmfa.gff test.yml tool_dependencies.xml | 
| diffstat | 14 files changed, 11319 insertions(+), 33 deletions(-) [+] | 
line wrap: on
 line diff
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/blastxml_to_gapped_gff3.py Thu Jun 18 12:10:51 2015 -0400 @@ -0,0 +1,256 @@ +#!/usr/bin/perl +import re +import sys +import copy +import argparse +from BCBio import GFF +import logging +logging.basicConfig(level=logging.INFO) +log = logging.getLogger(name='blastxml2gff3') + +__author__ = "Eric Rasche" +__version__ = "0.4.0" +__maintainer__ = "Eric Rasche" +__email__ = "esr@tamu.edu" + +__doc__ = """ +BlastXML files, when transformed to GFF3, do not normally show gaps in the +blast hits. This tool aims to fill that "gap". +""" + + +def blastxml2gff3(blastxml, min_gap=3, trim=False, trim_end=False): + from Bio.Blast import NCBIXML + from Bio.Seq import Seq + from Bio.SeqRecord import SeqRecord + from Bio.SeqFeature import SeqFeature, FeatureLocation + + blast_records = NCBIXML.parse(blastxml) + records = [] + for record in blast_records: + rec = SeqRecord(Seq("ACTG"), id=record.query) + for hit in record.alignments: + for hsp in hit.hsps: + qualifiers = { + "source": "blast", + "score": hsp.expect, + "accession": hit.accession, + "hit_id": hit.hit_id, + "length": hit.length, + "hit_titles": hit.title.split(' >') + } + desc = hit.title.split(' >')[0] + qualifiers['description'] = desc[desc.index(' '):] + + # This required a fair bit of sketching out/match to figure out + # the first time. + # + # the match_start location must account for queries and + # subjecst that start at locations other than 1 + parent_match_start = hsp.query_start - hsp.sbjct_start + # The end is the start + hit.length because the match itself + # may be longer than the parent feature, so we use the supplied + # subject/hit length to calculate the real ending of the target + # protein. + parent_match_end = hsp.query_start + hit.length + hsp.query.count('-') + + # However, if the user requests that we trim the feature, then + # we need to cut the ``match`` start to 0 to match the parent feature. + # We'll also need to cut the end to match the query's end. It (maybe) + # should be the feature end? But we don't have access to that data, so + # We settle for this. + if trim: + if parent_match_start < 1: + parent_match_start = 0 + + if trim or trim_end: + if parent_match_end > hsp.query_end: + parent_match_end = hsp.query_end + 1 + + # The ``protein_match`` feature will hold one or more ``match_part``s + top_feature = SeqFeature( + FeatureLocation(parent_match_start, parent_match_end), + type="protein_match", strand=0, + qualifiers=qualifiers + ) + + # Unlike the parent feature, ``match_part``s have sources. + part_qualifiers = { + "source": "blast", + } + top_feature.sub_features = [] + for start, end, cigar in generate_parts(hsp.query, hsp.match, + hsp.sbjct, + ignore_under=min_gap): + part_qualifiers['Gap'] = cigar + part_qualifiers['ID'] = hit.hit_id + + if trim: + # If trimming, then we start relative to the + # protein_match's start + match_part_start = parent_match_start + start + else: + # Otherwise, we have to account for the subject start's location + match_part_start = parent_match_start + hsp.sbjct_start + start - 1 + + # We used to use hsp.align_length here, but that includes + # gaps in the parent sequence + # + # Furthermore align_length will give calculation errors in weird places + # So we just use (end-start) for simplicity + match_part_end = match_part_start + (end - start) + + top_feature.sub_features.append( + SeqFeature( + FeatureLocation(match_part_start, match_part_end), + type="match_part", strand=0, + qualifiers=copy.deepcopy(part_qualifiers)) + ) + + rec.features.append(top_feature) + records.append(rec) + return records + + +def __remove_query_gaps(query, match, subject): + """remove positions in all three based on gaps in query + + In order to simplify math and calculations...we remove all of the gaps + based on gap locations in the query sequence:: + + Q:ACTG-ACTGACTG + S:ACTGAAC---CTG + + will become:: + + Q:ACTGACTGACTG + S:ACTGAC---CTG + + which greatly simplifies the process of identifying the correct location + for a match_part + """ + prev = 0 + fq = '' + fm = '' + fs = '' + for position in re.finditer('-', query): + fq += query[prev:position.start()] + fm += match[prev:position.start()] + fs += subject[prev:position.start()] + prev = position.start() + 1 + fq += query[prev:] + fm += match[prev:] + fs += subject[prev:] + + return (fq, fm, fs) + + +def generate_parts(query, match, subject, ignore_under=3): + region_q = [] + region_m = [] + region_s = [] + + (query, match, subject) = __remove_query_gaps(query, match, subject) + + region_start = -1 + region_end = -1 + mismatch_count = 0 + for i, (q, m, s) in enumerate(zip(query, match, subject)): + + # If we have a match + if m != ' ' or m == '+': + if region_start == -1: + region_start = i + # It's a new region, we need to reset or it's pre-seeded with + # spaces + region_q = [] + region_m = [] + region_s = [] + region_end = i + mismatch_count = 0 + else: + mismatch_count += 1 + + region_q.append(q) + region_m.append(m) + region_s.append(s) + + if mismatch_count >= ignore_under and region_start != -1 and region_end != -1: + region_q = region_q[0:-ignore_under] + region_m = region_m[0:-ignore_under] + region_s = region_s[0:-ignore_under] + yield region_start, region_end + 1, \ + cigar_from_string(region_q, region_m, region_s, strict_m=True) + region_q = [] + region_m = [] + region_s = [] + + region_start = -1 + region_end = -1 + mismatch_count = 0 + + yield region_start, region_end + 1, \ + cigar_from_string(region_q, region_m, region_s, strict_m=True) + + +def _qms_to_matches(query, match, subject, strict_m=True): + matchline = [] + + for (q, m, s) in zip(query, match, subject): + ret = '' + + if m != ' ' or m == '+': + ret = '=' + elif m == ' ': + if q == '-': + ret = 'D' + elif s == '-': + ret = 'I' + else: + ret = 'X' + else: + log.warn("Bad data: \n\t%s\n\t%s\n\t%s\n" % (query, match, subject)) + + + if strict_m: + if ret == '=' or ret == 'X': + ret = 'M' + + matchline.append(ret) + return matchline + + +def _matchline_to_cigar(matchline): + cigar_line = [] + last_char = matchline[0] + count = 0 + for char in matchline: + if char == last_char: + count += 1 + else: + cigar_line.append("%s%s" % (last_char, count)) + count = 1 + last_char = char + cigar_line.append("%s%s" % (last_char, count)) + return ' '.join(cigar_line) + + +def cigar_from_string(query, match, subject, strict_m=True): + matchline = _qms_to_matches(query, match, subject, strict_m=strict_m) + if len(matchline) > 0: + return _matchline_to_cigar(matchline) + else: + return "" + + +if __name__ == '__main__': + parser = argparse.ArgumentParser(description='Convert Blast XML to gapped GFF3', epilog='') + parser.add_argument('blastxml', type=file, help='Blast XML Output') + parser.add_argument('--min_gap', type=int, help='Maximum gap size before generating a new match_part', default=3) + parser.add_argument('--trim', action='store_true', help='Trim blast hits to be only as long as the parent feature') + parser.add_argument('--trim_end', action='store_true', help='Cut blast results off at end of gene') + args = parser.parse_args() + + result = blastxml2gff3(**vars(args)) + + GFF.write(result, sys.stdout)
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/gff3_rebase.py Thu Jun 18 12:10:51 2015 -0400 @@ -0,0 +1,108 @@ +#!/usr/bin/env python +import sys +import logging +logging.basicConfig(level=logging.INFO) +import argparse +from BCBio import GFF +from Bio.SeqFeature import FeatureLocation +log = logging.getLogger(__name__) + +__author__ = "Eric Rasche" +__version__ = "0.4.0" +__maintainer__ = "Eric Rasche" +__email__ = "esr@tamu.edu" + + +def __get_features(child, interpro=False): + child_features = {} + for rec in GFF.parse(child): + for feature in rec.features: + parent_feature_id = rec.id + if interpro: + if feature.type == 'polypeptide': + continue + if '_' in parent_feature_id: + parent_feature_id = parent_feature_id[parent_feature_id.index('_') + 1:] + + try: + child_features[parent_feature_id].append(feature) + except KeyError: + child_features[parent_feature_id] = [feature] + return child_features + + +def __update_feature_location(feature, parent, protein2dna): + start = feature.location.start + end = feature.location.end + if protein2dna: + start *= 3 + end *= 3 + + if parent.location.strand >= 0: + ns = parent.location.start + start + ne = parent.location.start + end + st = +1 + else: + ns = parent.location.end - end + ne = parent.location.end - start + st = -1 + + # Don't let start/stops be less than zero. It's technically valid for them + # to be (at least in the model I'm working with) but it causes numerous + # issues. + # + # Instead, we'll replace with %3 to try and keep it in the same reading + # frame that it should be in. + if ns < 0: + ns %= 3 + if ne < 0: + ne %= 3 + + feature.location = FeatureLocation(ns, ne, strand=st) + + if hasattr(feature, 'sub_features'): + for subfeature in feature.sub_features: + __update_feature_location(subfeature, parent, protein2dna) + + +def rebase(parent, child, interpro=False, protein2dna=False): + child_features = __get_features(child, interpro=interpro) + + for rec in GFF.parse(parent): + # TODO, replace with recursion in case it's matched against a + # non-parent feature. We're cheating a bit here right now... + replacement_features = [] + for feature in rec.features: + if feature.id in child_features: + new_subfeatures = child_features[feature.id] + # TODO: update starts + fixed_subfeatures = [] + for x in new_subfeatures: + # Then update the location of the actual feature + __update_feature_location(x, feature, protein2dna) + + if interpro: + for y in ('status', 'Target'): + try: + del x.qualifiers[y] + except: + pass + + fixed_subfeatures.append(x) + replacement_features.extend(fixed_subfeatures) + # We do this so we don't include the original set of features that we + # were rebasing against in our result. + rec.features = replacement_features + GFF.write([rec], sys.stdout) + + +if __name__ == '__main__': + parser = argparse.ArgumentParser(description='rebase gff3 features against parent locations', epilog="") + parser.add_argument('parent', type=file, help='Parent GFF3 annotations') + parser.add_argument('child', help='Child GFF3 annotations to rebase against parent') + parser.add_argument('--interpro', action='store_true', + help='Interpro specific modifications') + parser.add_argument('--protein2dna', action='store_true', + help='Map protein translated results to original DNA data') + args = parser.parse_args() + rebase(**vars(args))
--- a/jbrowse.py Mon May 04 17:21:38 2015 -0400 +++ b/jbrowse.py Thu Jun 18 12:10:51 2015 -0400 @@ -1,9 +1,45 @@ #!/usr/bin/env python +from string import Template import os -import shutil import argparse import subprocess import hashlib +import tempfile +import json +import yaml +import logging +logging.basicConfig() +log = logging.getLogger(__name__) + +COLOR_FUNCTION_TEMPLATE = Template(""" +function(feature, variableName, glyphObject, track) { + var score = ${score}; + ${opacity} + return 'rgba(${red}, ${green}, ${blue}, ' + opacity + ')'; +} +""") + +BLAST_OPACITY_MATH = """ +var opacity = 0; +if(score == 0.0) { + opacity = 1; +} else{ + opacity = (20 - Math.log10(score)) / 180; +} +""" + +BREWER_COLOUR_IDX = 0 +BREWER_COLOUR_SCHEMES = [ + (228, 26, 28), + (55, 126, 184), + (77, 175, 74), + (152, 78, 163), + (255, 127, 0), +] + + +# score comes from feature._parent.get('score') or feature.get('score') +# Opacity math TN_TABLE = { 'gff3': '--gff', @@ -12,40 +48,298 @@ # 'genbank': '--gbk', } - -def process_genome(jbrowse_dir, genome): - subprocess.check_output(['perl', 'bin/prepare-refseqs.pl', '--fasta', genome], cwd=jbrowse_dir) +INSTALLED_TO = os.path.dirname(os.path.realpath(__file__)) -def process_annotations(jbrowse_dir, annot_file, annot_label, annot_format, - **kwargs): - key = hashlib.md5(annot_file).hexdigest() +class JbrowseConnector(object): + + def __init__(self, jbrowse, jbrowse_dir, outdir, genome): + self.jbrowse = jbrowse + self.jbrowse_dir = jbrowse_dir + self.outdir = outdir + self.genome_path = genome + self.brewer_colour_idx = 0 + + self.clone_jbrowse(self.jbrowse, self.outdir) + self.process_genome() + + def subprocess_check_call(self, command): + log.debug('cd %s && %s', self.jbrowse_dir, ' '.join(command)) + subprocess.check_call(command, cwd=self.jbrowse_dir) + + def _get_colours(self): + r, g, b = BREWER_COLOUR_SCHEMES[self.brewer_colour_idx] + self.brewer_colour_idx += 1 + return r, g, b + + def process_genome(self): + self.subprocess_check_call(['perl', 'bin/prepare-refseqs.pl', + '--fasta', self.genome_path]) + + def _add_json(self, json_data): + if len(json_data.keys()) == 0: + return + + tmp = tempfile.NamedTemporaryFile(delete=False) + tmp.write(json.dumps(json_data)) + tmp.close() + cmd = ['perl', 'bin/add-track-json.pl', tmp.name, + os.path.join('data', 'trackList.json')] + self.subprocess_check_call(cmd) + os.unlink(tmp.name) + + def add_blastxml(self, data, key, **kwargs): + gff3_unrebased = tempfile.NamedTemporaryFile(delete=False) + cmd = ['python', os.path.join(INSTALLED_TO, 'blastxml_to_gapped_gff3.py'), + '--trim_end', '--min_gap', str(kwargs['min_gap']), data] + subprocess.check_call(cmd, cwd=self.jbrowse_dir, stdout=gff3_unrebased) + gff3_unrebased.close() + + gff3_rebased = tempfile.NamedTemporaryFile(delete=False) + cmd = ['python', os.path.join(INSTALLED_TO, 'gff3_rebase.py')] + if kwargs['protein']: + cmd.append('--protein2dna') + cmd.extend([kwargs['parent'], gff3_unrebased.name]) + subprocess.check_call(cmd, cwd=self.jbrowse_dir, stdout=gff3_rebased) + gff3_rebased.close() + + label = hashlib.md5(data).hexdigest() + + red, green, blue = self._get_colours() + color_function = COLOR_FUNCTION_TEMPLATE.substitute({ + 'score': "feature._parent.get('score')", + 'opacity': BLAST_OPACITY_MATH, + 'red': red, + 'green': green, + 'blue': blue, + }) + + clientConfig = { + 'label': 'description', + 'color': color_function.replace('\n', ''), + 'description': 'Hit_titles', + } + config = {'glyph': 'JBrowse/View/FeatureGlyph/Segments'} + if 'category' in kwargs: + config['category'] = kwargs['category'] + + cmd = ['perl', 'bin/flatfile-to-json.pl', + '--gff', gff3_rebased.name, + '--trackLabel', label, + '--key', key, + '--clientConfig', json.dumps(clientConfig), + '--config', json.dumps(config), + '--trackType', 'JBrowse/View/Track/CanvasFeatures' + ] + + self.subprocess_check_call(cmd) + os.unlink(gff3_rebased.name) + os.unlink(gff3_unrebased.name) + + def _min_max_gff(self, gff_file): + min_val = None + max_val = None + with open(gff_file, 'r') as handle: + for line in handle: + try: + value = float(line.split('\t')[5]) + min_val = min(value, (min_val or value)) + max_val = max(value, (max_val or value)) + + if value < min_val: + min_val = value + + if value > max_val: + max_val = value + except Exception: + pass + return min_val, max_val + + def add_bigwig(self, data, key, **kwargs): + label = hashlib.md5(data).hexdigest() + dest = os.path.join('data', 'raw', os.path.basename(data)) + cmd = ['ln', '-s', data, dest] + self.subprocess_check_call(cmd) + + track_data = { + "label": label, + "urlTemplate": os.path.join('..', dest), + "bicolor_pivot": "zero", + "storeClass": "JBrowse/Store/SeqFeature/BigWig", + "type": "JBrowse/View/Track/Wiggle/Density", + "key": key, + } + track_data.update(kwargs) + + if 'min' not in track_data and 'max' not in track_data \ + and 'autoscale' not in track_data: + track_data['autoscale'] = 'local' + + self._add_json(track_data) - cmd = ['perl', 'bin/flatfile-to-json.pl', TN_TABLE.get(annot_format, 'gff'), - annot_file, '--trackLabel', key, '--key', annot_label] - subprocess.check_output(cmd, cwd=jbrowse_dir) + def add_bam(self, data, key, **kwargs): + label = hashlib.md5(data).hexdigest() + dest = os.path.join('data', 'raw', os.path.basename(data)) + # ln? + cmd = ['ln', '-s', data, dest] + self.subprocess_check_call(cmd) + + bai_source = kwargs['bam_index'] + cmd = ['ln', '-s', bai_source, dest + '.bai'] + self.subprocess_check_call(cmd) + + track_data = { + "urlTemplate": os.path.join('..', dest), + "key": key, + "label": label, + "type": "JBrowse/View/Track/Alignments2", + "storeClass": "JBrowse/Store/SeqFeature/BAM", + } + if 'category' in kwargs: + track_data['category'] = kwargs['category'] + self._add_json(track_data) + + if kwargs.get('auto_snp', False): + track_data = { + "storeClass": "JBrowse/Store/SeqFeature/BAM", + "urlTemplate": os.path.join('..', dest), + "type": "JBrowse/View/Track/SNPCoverage", + "key": key + " - SNPs/Coverage", + "label": label + "_autosnp", + } + if 'category' in kwargs: + track_data['category'] = kwargs['category'] + self._add_json(track_data) + + def add_vcf(self, data, key, **kwargs): + label = hashlib.md5(data).hexdigest() + dest = os.path.join('data', 'raw', os.path.basename(data)) + # ln? + cmd = ['ln', '-s', data, dest] + self.subprocess_check_call(cmd) + cmd = ['bgzip', dest] + self.subprocess_check_call(cmd) + cmd = ['tabix', '-p', 'vcf', dest + '.gz'] + self.subprocess_check_call(cmd) + + track_data = { + "key": key, + "label": label, + "urlTemplate": os.path.join('..', dest + '.gz'), + "type": "JBrowse/View/Track/HTMLVariants", + "storeClass": "JBrowse/Store/SeqFeature/VCFTabix", + } + track_data.update(kwargs) + self._add_json(track_data) + + def add_features(self, data, key, format, **kwargs): + label = hashlib.md5(data).hexdigest() + cmd = ['perl', 'bin/flatfile-to-json.pl', + TN_TABLE.get(format, 'gff'), data, + '--trackLabel', label, + '--key', key] + + config = {} + if 'category' in kwargs: + config['category'] = kwargs['category'] + + if kwargs.get('match', False): + clientConfig = { + 'label': 'description', + 'description': 'Hit_titles', + } + + # Get min/max and build a scoring function since JBrowse doesn't + min_val, max_val = self._min_max_gff(data) + + if min_val is not None and max_val is not None: + MIN_MAX_OPACITY_MATH = Template(""" + var opacity = (score - ${min}) * (1/(${max} - ${min})); + """).substitute({ + 'max': max_val, + 'min': min_val, + }) + + red, green, blue = self._get_colours() + color_function = COLOR_FUNCTION_TEMPLATE.substitute({ + 'score': "feature.get('score')", + 'opacity': MIN_MAX_OPACITY_MATH, + 'red': red, + 'green': green, + 'blue': blue, + }) + + clientConfig['color'] = color_function.replace('\n', '') + + config['glyph'] = 'JBrowse/View/FeatureGlyph/Segments' + + cmd += ['--clientConfig', json.dumps(clientConfig), + '--trackType', 'JBrowse/View/Track/CanvasFeatures' + ] + + cmd.extend(['--config', json.dumps(config)]) + + self.subprocess_check_call(cmd) + + def process_annotations(self, data, key, format, **kwargs): + if format in ('gff', 'gff3', 'bed'): + self.add_features(data, key, format, **kwargs) + elif format == 'bigwig': + self.add_bigwig(data, key, **kwargs) + elif format == 'bam': + self.add_bam(data, key, **kwargs) + elif format == 'blastxml': + self.add_blastxml(data, key, **kwargs) + elif format == 'vcf': + self.add_vcf(data, key, **kwargs) + + def clone_jbrowse(self, jbrowse_dir, destination): + # JBrowse seems to have included some bad symlinks, cp ignores bad symlinks + # unlike copytree + cmd = ['mkdir', '-p', destination] + subprocess.check_call(cmd) + cmd = ['cp', '-r', jbrowse_dir, destination] + subprocess.check_call(cmd) + cmd = ['mkdir', '-p', os.path.join(destination, 'JBrowse-1.11.6', + 'data', 'raw')] + subprocess.check_call(cmd) + + # http://unix.stackexchange.com/a/38691/22785 + # JBrowse releases come with some broken symlinks + cmd = ['find', destination, '-type', 'l', '-xtype', 'l', '-exec', 'rm', "'{}'", '+'] + subprocess.check_call(cmd) if __name__ == '__main__': parser = argparse.ArgumentParser(description="", epilog="") parser.add_argument('genome', type=file, help='Input genome file') - - parser.add_argument('--gff3', type=file, nargs='*', help='GFF3/BED/GBK File') - parser.add_argument('--gff3_format', choices=['gff3', 'gff', 'bed', 'gbk'], nargs='*', help='GFF3/BED/GBK Format') - parser.add_argument('--gff3_label', type=str, nargs='*', help='GFF3/BED/GBK Label') + parser.add_argument('yaml', type=file, help='Track Configuration') parser.add_argument('--jbrowse', help='Folder containing a jbrowse release') parser.add_argument('--outdir', help='Output directory', default='out') args = parser.parse_args() - jbrowse_dir = os.path.join(args.outdir, 'JBrowse-1.11.6') - shutil.copytree(args.jbrowse, jbrowse_dir) + jc = JbrowseConnector( + jbrowse=args.jbrowse, + jbrowse_dir=os.path.join(args.outdir, 'JBrowse-1.11.6'), + outdir=args.outdir, + genome=os.path.realpath(args.genome.name), + ) - process_genome(jbrowse_dir, os.path.realpath(args.genome.name)) + track_data = yaml.load(args.yaml) + for track in track_data: + path = os.path.realpath(track['file']) + extra = track.get('options', {}) + if '__unused__' in extra: + del extra['__unused__'] - for gff3, gff3_format, gff3_label in zip(args.gff3, args.gff3_format, args.gff3_label): - gff3_path = os.path.realpath(gff3.name) - process_annotations(jbrowse_dir, gff3_path, gff3_label, gff3_format) + for possible_partial_path in ('bam_index', 'parent'): + if possible_partial_path in extra: + extra[possible_partial_path] = os.path.realpath( + extra[possible_partial_path]) + extra['category'] = track.get('category', 'Default') + + jc.process_annotations(path, track['label'], track['ext'], **extra) print """ <html> @@ -54,6 +348,9 @@ window.location=JBrowse-1.11.6/index.html </script> <a href="JBrowse-1.11.6/index.html">Go to JBrowse</a> + <p>Please note that JBrowse functions best on production Galaxy + instances. The paste server used in development instances has issues + serving the volumes of data regularly involved in JBrowse</p> </body> </html> """
--- a/jbrowse.xml Mon May 04 17:21:38 2015 -0400 +++ b/jbrowse.xml Thu Jun 18 12:10:51 2015 -0400 @@ -1,4 +1,4 @@ -<tool id="jbrowse" name="JBrowse" version="0.1"> +<tool id="jbrowse" name="JBrowse" version="0.3"> <description>genome browser</description> <macros> <import>macros.xml</import> @@ -8,25 +8,116 @@ <version_command>python jbrowse.py --version</version_command> <command interpreter="python"><![CDATA[jbrowse.py $positional_1 - -#set data_files = '" "'.join([ str($var.gff3) for $var in $data_tracks ]) -#set data_formats = '" "'.join([ str($var.gff3.ext) for $var in $data_tracks ]) -#set data_labels = '" "'.join([ str($var.gff3_label) for $var in $data_tracks ]) - ---gff3 "$data_files" ---gff3_format "$data_formats" ---gff3_label "$data_labels" - +$trackYaml --jbrowse \${JBROWSE_SOURCE_DIR} --outdir $default.files_path > $default]]></command> + <configfiles> + <configfile name="trackYaml"> +--- +#for $track in $data_tracks: + - + file: ${track.data_format.annotation} + ext: ${track.data_format.annotation.ext} + label: "${track.annotation_label}" + category: "${track.category}" + options: + __unused__: "Not used...just to ensure options has at least one key" + #if str($track.data_format.data_format_select) == "wiggle": + type: ${track.data_format.xyplot} + variance_band: ${track.data_format.var_band} + #if str($track.data_format.scaling.scale_select) == "auto_local": + autoscale: local + #else if str($track.data_format.scaling.scale_select) == "auto_global": + autoscale: global + #else: + min: ${track.data_format.scaling.minimum} + max: ${track.data_format.scaling.maximum} + #end if + #else if str($track.data_format.data_format_select) == "pileup": + auto_snp: ${track.data_format.auto_snp} + bam_index: ${track.data_format.annotation.metadata.bam_index} + #else if str($track.data_format.data_format_select) == "blast": + parent: ${track.data_format.blast_parent} + protein: ${track.data_format.is_protein} + min_gap: ${track.data_format.min_gap} + match: true + #else if str($track.data_format.data_format_select) == "gene_calls": + match: ${track.data_format.match_part} + #end if +#end for + </configfile> + </configfiles> <inputs> <param label="Genome" name="positional_1" type="data" format="fasta"/> <repeat name="data_tracks" title="Annotation Track"> - <param label="Annotation Data" help="in GFF, GFF3, or BED formats" - format="gff,gff3,bed" name="gff3" type="data"/> - <param label="Dataset Label" name="gff3_label" type="text"/> + <param label="Track Label" name="annotation_label" type="text"/> + <param label="Track Category" name="category" type="text" value="Default" + help="Organise your tracks into Categories for a nicer end-user experience"/> + <conditional name="data_format" label="Track Options"> + <param type="select" label="Track Type" name="data_format_select"> + <option value="gene_calls">GFF/GFF3/BED Featuers</option> + <option value="pileup">BAM Pileups</option> + <option value="blast">Blast XML</option> + <option value="wiggle">BigWig XY</option> + <option value="vcf">VCF SNPs</option> + </param> + <when value="blast"> + <param label="BlastXML Track Data" format="blastxml" name="annotation" type="data"/> + + <param label="Features used in Blast Search" help="in GFF3. This is required so we know where to map features. E.g. where results of which CDS Protein32 match up to. The query IDs in your blast results should MATCH some feature IDs in your GFF3 file." + format="gff3" name="blast_parent" type="data"/> + + <param label="Minimum Gap Size" help="before a new match_part feature is created" name="min_gap" + type="integer" value="10" min="2" /> + <param label="Is this a protein blast search?" + type="boolean" name="is_protein" truevalue="true" falsevalue="false" /> + </when> + <when value="vcf"> + <param label="SNPs" help="in VCF" + format="vcf" name="annotation" type="data"/> + </when> + <when value="gene_calls"> + <param label="Track Data" help="in GFF, GFF3, BED" + format="gff,gff3,bed" name="annotation" type="data"/> + + <param label="This is match/match_part data" + type="boolean" name="match_part" truevalue="true" falsevalue="false" /> + </when> + <when value="pileup"> + <param label="Track Data" help="in BAM" + format="bam" name="annotation" type="data"/> + <param label="Autogenerate SNP Track" help="Not recommended for deep coverage BAM files" + type="boolean" name="auto_snp" truevalue="true" falsevalue="false" /> + </when> + <when value="wiggle"> + <param label="Track Data" help="in BigWig" + format="bigwig" name="annotation" type="data"/> + <param label="Use XYPlot" help="instead of continuous coloured band" + type="boolean" name="xyplot" truevalue="JBrowse/View/Track/Wiggle/XYPlot" + falsevalue="JBrowse/View/Track/Wiggle/Density" /> + <param label="Show variance band" help="Only for XYPlots" + type="boolean" name="var_band" truevalue="true" + falsevalue="false" /> + + <conditional name="scaling" label="Scaling"> + <param type="select" label="Track Scaling" name="scale_select"> + <option value="auto_local">Autoscale (local)</option> + <option value="auto_global">Autoscale (global)</option> + <option vlue="fixed">Specify Min/Max</option> + </param> + <when value="auto_local"></when> + <when value="auto_global"></when> + <when value="fixed"> + <param label="Track minimum" name="minimum" + type="integer" value="0" /> + <param label="Track maximum" name="maximum" + type="integer" value="100" /> + </when> + </conditional> + </when> + </conditional> </repeat> </inputs> <outputs>
--- a/macros.xml Mon May 04 17:21:38 2015 -0400 +++ b/macros.xml Thu Jun 18 12:10:51 2015 -0400 @@ -3,6 +3,10 @@ <xml name="requirements"> <requirements> <requirement type="package" version="1.11.6">jbrowse</requirement> + <requirement type="package" version="2.7">python</requirement> + <requirement type="package" version="5.18">perl</requirement> + <requirement type="package" version="1.2">samtools</requirement> + <requirement type="package" version="1.0">bundle_jbrowse</requirement> <yield/> </requirements> </xml>
--- a/readme.rst Mon May 04 17:21:38 2015 -0400 +++ b/readme.rst Thu Jun 18 12:10:51 2015 -0400 @@ -13,10 +13,19 @@ It is recommended to install this wrapper via the Galaxy Tool Shed +Running Locally +=============== + +The Galaxy tool interface writes out a yaml file which is then used to generate +the visualizations. An example used during development/testing can be seen in +`test.yml`. The format is in no way rigorously defined and is likely to change +at any time. + History ======= - 0.1 Initial public release +- 0.2 Added support for BAM, Blast, VCF Wrapper License (MIT/BSD Style) ===============================
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/blast.xml Thu Jun 18 12:10:51 2015 -0400 @@ -0,0 +1,4514 @@ +<?xml version="1.0"?> +<!DOCTYPE BlastOutput PUBLIC "-//NCBI//NCBI BlastOutput/EN" "http://www.ncbi.nlm.nih.gov/dtd/NCBI_BlastOutput.dtd"> +<BlastOutput> + <BlastOutput_program>blastp</BlastOutput_program> + <BlastOutput_version>BLASTP 2.2.28+</BlastOutput_version> + <BlastOutput_reference>Stephen F. Altschul, Thomas L. Madden, Alejandro A. Sch&auml;ffer, Jinghui Zhang, Zheng Zhang, Webb Miller, and David J. Lipman (1997), "Gapped BLAST and PSI-BLAST: a new generation of protein database search programs", Nucleic Acids Res. 25:3389-3402.</BlastOutput_reference> + <BlastOutput_db>/usr/local/syncdb/community/nr/nr</BlastOutput_db> + <BlastOutput_query-ID>Query_1</BlastOutput_query-ID> + <BlastOutput_query-def>Merlin_1</BlastOutput_query-def> + <BlastOutput_query-len>229</BlastOutput_query-len> + <BlastOutput_param> + <Parameters> + <Parameters_matrix>BLOSUM62</Parameters_matrix> + <Parameters_expect>0.001</Parameters_expect> + <Parameters_gap-open>11</Parameters_gap-open> + <Parameters_gap-extend>1</Parameters_gap-extend> + <Parameters_filter>F</Parameters_filter> + </Parameters> + </BlastOutput_param> +<BlastOutput_iterations> +<Iteration> + <Iteration_iter-num>1</Iteration_iter-num> + <Iteration_query-ID>Query_1</Iteration_query-ID> + <Iteration_query-def>Merlin_1</Iteration_query-def> + <Iteration_query-len>229</Iteration_query-len> +<Iteration_hits> +<Hit> + <Hit_num>1</Hit_num> + <Hit_id>gi|422934611|ref|YP_007004572.1|</Hit_id> + <Hit_def>hypothetical protein [Enterobacteria phage ime09] >gi|339791394|gb|AEK12451.1| hypothetical protein [Enterobacteria phage ime09]</Hit_def> + <Hit_accession>YP_007004572</Hit_accession> + <Hit_len>685</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>197.593</Hsp_bit-score> + <Hsp_score>501</Hsp_score> + <Hsp_evalue>3.74548e-55</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>229</Hsp_query-to> + <Hsp_hit-from>474</Hsp_hit-from> + <Hsp_hit-to>684</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>106</Hsp_identity> + <Hsp_positive>154</Hsp_positive> + <Hsp_gaps>21</Hsp_gaps> + <Hsp_align-len>230</Hsp_align-len> + <Hsp_qseq>LDKGTLLYRGQKLDLPTFEHNAENKLFYFRNYVSTSLKPLIFGEFGRMFMALDDDTTIYTAETPDDYNRFANPEDIIDIGATQKDSFDDNNNDGTSINIGKQVNLGFVISGAENVRVIVPGSLTEYPEEAEVILPRGTLLKINKITTQVDKRS--NKFMVEGSIVPPSEQIDESVEIYDGDLFMETGEVVKLSGFMQFVNESAYDEEQNQMAAEILSGFLDIDDMPRKFR</Hsp_qseq> + <Hsp_hseq>LPPGTTLYRGQEVTFKTLRHNIENKMFYFKNFVSTSLKPNIFGEHGKNYMALDDSGAVFSGEGEGS----VDAEDLMHMGSHSAYANED-----------AETSVGMVIKGAERIKVIVPGHLSGFPSEAEVILPRGILLKINKVSTYMMKETAYNKYLIEGTIVPPSEQLEESV--YDGDHLMETGEVRPMAGFNQFLVEES--KEEENEVSQILASLVNINGMSKKFK</Hsp_hseq> + <Hsp_midline>L GT LYRGQ++ T HN ENK+FYF+N+VSTSLKP IFGE G+ +MALDD +++ E + ED++ +G+ + +D + ++G VI GAE ++VIVPG L+ +P EAEVILPRG LLKINK++T + K + NK+++EG+IVPPSEQ++ESV YDGD METGEV ++GF QF+ E + +E+ ++IL+ ++I+ M +KF+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>2</Hit_num> + <Hit_id>gi|330858714|ref|YP_004415089.1|</Hit_id> + <Hit_def>hypothetical protein Shfl2p198 [Shigella phage Shfl2] >gi|327397648|gb|AEA73150.1| hypothetical protein Shfl2p198 [Shigella phage Shfl2]</Hit_def> + <Hit_accession>YP_004415089</Hit_accession> + <Hit_len>685</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>197.593</Hsp_bit-score> + <Hsp_score>501</Hsp_score> + <Hsp_evalue>4.31042e-55</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>229</Hsp_query-to> + <Hsp_hit-from>474</Hsp_hit-from> + <Hsp_hit-to>684</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>106</Hsp_identity> + <Hsp_positive>154</Hsp_positive> + <Hsp_gaps>21</Hsp_gaps> + <Hsp_align-len>230</Hsp_align-len> + <Hsp_qseq>LDKGTLLYRGQKLDLPTFEHNAENKLFYFRNYVSTSLKPLIFGEFGRMFMALDDDTTIYTAETPDDYNRFANPEDIIDIGATQKDSFDDNNNDGTSINIGKQVNLGFVISGAENVRVIVPGSLTEYPEEAEVILPRGTLLKINKITTQVDKRS--NKFMVEGSIVPPSEQIDESVEIYDGDLFMETGEVVKLSGFMQFVNESAYDEEQNQMAAEILSGFLDIDDMPRKFR</Hsp_qseq> + <Hsp_hseq>LPPGTTLYRGQEVTFKTLRHNIENKMFYFKNFVSTSLKPNIFGEHGKNYMALDDSGAVFSGEGEGS----VDAEDLMHMGSHSAYANED-----------AETSVGMVIKGAERIKVIVPGHLSGFPSEAEVILPRGILLKINKVSTYMMKETAYNKYLIEGTIVPPSEQLEESV--YDGDHLMETGEVRPMAGFNQFLVEES--KEEENEVSQILASLVNINGMSKKFK</Hsp_hseq> + <Hsp_midline>L GT LYRGQ++ T HN ENK+FYF+N+VSTSLKP IFGE G+ +MALDD +++ E + ED++ +G+ + +D + ++G VI GAE ++VIVPG L+ +P EAEVILPRG LLKINK++T + K + NK+++EG+IVPPSEQ++ESV YDGD METGEV ++GF QF+ E + +E+ ++IL+ ++I+ M +KF+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>3</Hit_num> + <Hit_id>gi|228861509|ref|YP_002854530.1|</Hit_id> + <Hit_def>alt.-2 hypothetical protein [Enterobacteria phage RB14] >gi|227438525|gb|ACP30838.1| alt.-2 hypothetical protein [Enterobacteria phage RB14]</Hit_def> + <Hit_accession>YP_002854530</Hit_accession> + <Hit_len>685</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>197.593</Hsp_bit-score> + <Hsp_score>501</Hsp_score> + <Hsp_evalue>4.35388e-55</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>229</Hsp_query-to> + <Hsp_hit-from>474</Hsp_hit-from> + <Hsp_hit-to>684</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>108</Hsp_identity> + <Hsp_positive>152</Hsp_positive> + <Hsp_gaps>21</Hsp_gaps> + <Hsp_align-len>230</Hsp_align-len> + <Hsp_qseq>LDKGTLLYRGQKLDLPTFEHNAENKLFYFRNYVSTSLKPLIFGEFGRMFMALDDDTTIYTAETPDDYNRFANPEDIIDIGATQKDSFDDNNNDGTSINIGKQVNLGFVISGAENVRVIVPGSLTEYPEEAEVILPRGTLLKINKITTQVDKRS--NKFMVEGSIVPPSEQIDESVEIYDGDLFMETGEVVKLSGFMQFVNESAYDEEQNQMAAEILSGFLDIDDMPRKFR</Hsp_qseq> + <Hsp_hseq>LPPGTTLYRGQEVTFKTLRHNIENKMFYFKNFVSTSLKPNIFGEHGKNYMALDDSGAVFSGEGEGS----VDAEDLMHMGS-----------HSTYANEDAETSVGMVIKGAERVKVIVPGHLSGFPSEAEVILPRGILLKINKVSTYFMKETAYNKYLIEGTIVPPSEQLEESV--YDGDHLMETGEVRPMAGFNQFLVEES--KEEENEVSQILASLVNINGMSKKFK</Hsp_hseq> + <Hsp_midline>L GT LYRGQ++ T HN ENK+FYF+N+VSTSLKP IFGE G+ +MALDD +++ E + ED++ +G+ T N + ++G VI GAE V+VIVPG L+ +P EAEVILPRG LLKINK++T K + NK+++EG+IVPPSEQ++ESV YDGD METGEV ++GF QF+ E + +E+ ++IL+ ++I+ M +KF+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +</Iteration_hits> + <Iteration_stat> + <Statistics> + <Statistics_db-num>48094830</Statistics_db-num> + <Statistics_db-len>17186091396</Statistics_db-len> + <Statistics_hsp-len>143</Statistics_hsp-len> + <Statistics_eff-space>886533640716</Statistics_eff-space> + <Statistics_kappa>0.041</Statistics_kappa> + <Statistics_lambda>0.267</Statistics_lambda> + <Statistics_entropy>0.14</Statistics_entropy> + </Statistics> + </Iteration_stat> +</Iteration> +<Iteration> + <Iteration_iter-num>2</Iteration_iter-num> + <Iteration_query-ID>Query_2</Iteration_query-ID> + <Iteration_query-def>Merlin_2</Iteration_query-def> + <Iteration_query-len>95</Iteration_query-len> +<Iteration_hits> +<Hit> + <Hit_num>1</Hit_num> + <Hit_id>gi|308814559|ref|YP_003934833.1|</Hit_id> + <Hit_def>hypothetical protein SP18_gp210 [Shigella phage SP18] >gi|308206151|gb|ADO19550.1| hypothetical protein SP18gp210 [Shigella phage SP18]</Hit_def> + <Hit_accession>YP_003934833</Hit_accession> + <Hit_len>107</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>79.337</Hsp_bit-score> + <Hsp_score>194</Hsp_score> + <Hsp_evalue>9.23754e-17</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>12</Hsp_hit-from> + <Hsp_hit-to>107</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>42</Hsp_identity> + <Hsp_positive>56</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSSFRFNGQELVVENVIPASEEFDSAVGNELRRVFGEDKKFDLRPVENFVNSEQTENIFNGVVTGQLESEAPIAITVFAKKEVVMTAAGFISFRK</Hsp_hseq> + <Hsp_midline>MKS FR NG E+VVE+V+P S EF+ V EL+++ G DKK P+ F E + VVTGQLE E +A+ EV++T F+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>2</Hit_num> + <Hit_id>gi|456351278|ref|YP_007501230.1|</Hit_id> + <Hit_def>hypothetical protein [Salmonella phage S16] >gi|448913695|gb|AGE48199.1| hypothetical protein [Salmonella phage S16]</Hit_def> + <Hit_accession>YP_007501230</Hit_accession> + <Hit_len>106</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>77.7962</Hsp_bit-score> + <Hsp_score>190</Hsp_score> + <Hsp_evalue>2.9568e-16</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>94</Hsp_query-to> + <Hsp_hit-from>11</Hsp_hit-from> + <Hsp_hit-to>106</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>42</Hsp_identity> + <Hsp_positive>57</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKE-NVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFR</Hsp_qseq> + <Hsp_hseq>MKSILRIASTEIVIENAKPDSREFNEAAYELLQELYGTDKNFQLHPLPRFGVKEGQADNYISGVLSGNLVGEVPCAISIIAEDNQISNVVGFVVFR</Hsp_hseq> + <Hsp_midline>MKSI RI EIV+E+ P S EFNE ++ L+++ G DK Q P+ RFG+KE D YI V++G L GE A+ + D I + FV+FR</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>3</Hit_num> + <Hit_id>gi|408387127|gb|AFU64136.1|</Hit_id> + <Hit_def>hypothetical protein [Salmonella phage STML-198]</Hit_def> + <Hit_accession>AFU64136</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>77.0258</Hsp_bit-score> + <Hsp_score>188</Hsp_score> + <Hsp_evalue>5.19436e-16</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>94</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>42</Hsp_identity> + <Hsp_positive>57</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKE-NVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFR</Hsp_qseq> + <Hsp_hseq>MKSILRIASTETVIENVKPDSREFNEAAYELLQELYGTDKNFQLHPLPRFGVKEGQADNYISGVLSGNLVGEVPCAISIIAEDNQISNVVGFVVFR</Hsp_hseq> + <Hsp_midline>MKSI RI E V+E+V P S EFNE ++ L+++ G DK Q P+ RFG+KE D YI V++G L GE A+ + D I + FV+FR</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>4</Hit_num> + <Hit_id>gi|314121774|ref|YP_004063893.1|</Hit_id> + <Hit_def>Alt.-3 conserved hypothetical protein [Enterobacteria phage vB_EcoM-VR7] >gi|313151531|gb|ADR32587.1| Alt.-3 conserved hypothetical protein [Enterobacteria phage vB_EcoM-VR7]</Hit_def> + <Hit_accession>YP_004063893</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>76.6406</Hsp_bit-score> + <Hsp_score>187</Hsp_score> + <Hsp_evalue>7.7684e-16</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>40</Hsp_identity> + <Hsp_positive>56</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSSFRFNGQELVVENVIPASEEFDSAVGNELRRVFGEDKKFDLRPVENFVNSEQTENIFNGIVTGQLESEAPIAITVFVKKEAVMTVAGFISFRK</Hsp_hseq> + <Hsp_midline>MKS FR NG E+VVE+V+P S EF+ V EL+++ G DKK P+ F E + +VTGQLE E +A+ E ++T+ F+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>5</Hit_num> + <Hit_id>gi|161622625|ref|YP_001595321.1|</Hit_id> + <Hit_def>Alt.-3 conserved hypothetical protein [Enterobacteria phage JS98] >gi|52139951|gb|AAU29321.1| Alt.-3 conserved hypothetical protein [Enterobacteria phage JS98]</Hit_def> + <Hit_accession>YP_001595321</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>75.485</Hsp_bit-score> + <Hsp_score>184</Hsp_score> + <Hsp_evalue>2.41009e-15</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>39</Hsp_identity> + <Hsp_positive>55</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSAFRFNGQELVVENVIPASEEFDSAVGNELRRVFGEDKQFDLRPIENFSQPEQTENIFNGVVTGQLESEAPISITVFVKKQPLMTAAGFISFRK</Hsp_hseq> + <Hsp_midline>MKS FR NG E+VVE+V+P S EF+ V EL+++ G DK+ PI F E + VVTGQLE E +++ + ++T F+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>6</Hit_num> + <Hit_id>gi|422934213|ref|YP_007004249.1|</Hit_id> + <Hit_def>conserved hypothetical protein [Enterobacteria phage Bp7] >gi|345450722|gb|AEN93925.1| conserved hypothetical protein [Enterobacteria phage Bp7]</Hit_def> + <Hit_accession>YP_007004249</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>74.7146</Hsp_bit-score> + <Hsp_score>182</Hsp_score> + <Hsp_evalue>3.63965e-15</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>39</Hsp_identity> + <Hsp_positive>55</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSAFRFNGQELVVENVIPASEEFDSAVGNELRRVFGEDKQFDIRPVENFSHPEQTENIFNGVVTGQLESEAPISVTVFVKKQPLMTAAGFISFRK</Hsp_hseq> + <Hsp_midline>MKS FR NG E+VVE+V+P S EF+ V EL+++ G DK+ P+ F E + VVTGQLE E ++V + ++T F+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>7</Hit_num> + <Hit_id>gi|238695348|ref|YP_002922541.1|</Hit_id> + <Hit_def>Alt.-3 conserved hypothetical protein [Enterobacteria phage JS10] >gi|220029484|gb|ACL78418.1| Alt.-3 conserved hypothetical protein [Enterobacteria phage JS10]</Hit_def> + <Hit_accession>YP_002922541</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>74.7146</Hsp_bit-score> + <Hsp_score>182</Hsp_score> + <Hsp_evalue>4.31e-15</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>55</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSTFRFNGQELVVENVIPASEEFDSAVGNELRRVFGEDKQFDLRPVENFSQPEQTENIFNGVVTGQLESEAPISITVFVKKQPLMTAAGFISFRK</Hsp_hseq> + <Hsp_midline>MKS FR NG E+VVE+V+P S EF+ V EL+++ G DK+ P+ F E + VVTGQLE E +++ + ++T F+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>8</Hit_num> + <Hit_id>gi|299779143|ref|YP_003734337.1|</Hit_id> + <Hit_def>alt.-3 gene product [Enterobacteria phage IME08] >gi|298105872|gb|ADI55516.1| hypothetical protein [Enterobacteria phage IME08]</Hit_def> + <Hit_accession>YP_003734337</Hit_accession> + <Hit_len>106</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>74.3294</Hsp_bit-score> + <Hsp_score>181</Hsp_score> + <Hsp_evalue>6.30983e-15</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>11</Hsp_hit-from> + <Hsp_hit-to>106</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>55</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSAFRFNGQELVVENVIPASEEFDSAIGNELRRVFGEDKQFDIRPVENFSQPEQTENIFNGVVTGQLESEAPISVTVFVKKQPLMTAAGFISFRK</Hsp_hseq> + <Hsp_midline>MKS FR NG E+VVE+V+P S EF+ + EL+++ G DK+ P+ F E + VVTGQLE E ++V + ++T F+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>9</Hit_num> + <Hit_id>gi|311993190|ref|YP_004010056.1|</Hit_id> + <Hit_def>hypothetical protein CC31p198 [Enterobacteria phage CC31] >gi|284178028|gb|ADB81694.1| conserved hypothetical protein [Enterobacteria phage CC31]</Hit_def> + <Hit_accession>YP_004010056</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>68.1662</Hsp_bit-score> + <Hsp_score>165</Hsp_score> + <Hsp_evalue>1.13441e-12</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>44</Hsp_identity> + <Hsp_positive>62</Hsp_positive> + <Hsp_gaps>7</Hsp_gaps> + <Hsp_align-len>99</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILGDKKLQSTPIGRFGMKEN-VDTYIESVVTGQLEGE--FSVAVQTVE-NDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSILRMNGQETVVEGVVPVSDEFNNMVFNEIQKI-AKGMVEMVPLAPFGIPEDKCEGYIAYTLNGKFNGEVPFKITVTNIEQSSEVVLN--AFVVFRK</Hsp_hseq> + <Hsp_midline>MKSI R+NG E VVE VVP+S EFN +VF E++KI ++ P+ FG+ E+ + YI + G+ GE F + V +E + EV+L AFV+FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>10</Hit_num> + <Hit_id>gi|589889941|ref|YP_009005477.1|</Hit_id> + <Hit_def>hypothetical protein PG7_213 [Enterobacter phage PG7] >gi|583927854|gb|AHI61116.1| hypothetical protein PG7_213 [Enterobacter phage PG7]</Hit_def> + <Hit_accession>YP_009005477</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>68.1662</Hsp_bit-score> + <Hsp_score>165</Hsp_score> + <Hsp_evalue>1.18288e-12</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>45</Hsp_identity> + <Hsp_positive>62</Hsp_positive> + <Hsp_gaps>7</Hsp_gaps> + <Hsp_align-len>99</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILGDKKLQSTPIGRFGMKEN-VDTYIESVVTGQLEGE--FSVAVQTVE-NDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSILRMNGQETVVEGVVPVSDEFNNMVFNEIQKI-AKGMVEMVPLAPFGIPEDKCEGYIAYTLNGKFNGEVPFKITVTDVEQSSEVVLN--AFVVFRK</Hsp_hseq> + <Hsp_midline>MKSI R+NG E VVE VVP+S EFN +VF E++KI ++ P+ FG+ E+ + YI + G+ GE F + V VE + EV+L AFV+FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>11</Hit_num> + <Hit_id>gi|9632705|ref|NP_049808.1|</Hit_id> + <Hit_def>Alt.-3 conserved hypothetical protein [Enterobacteria phage T4] >gi|116326415|ref|YP_803135.1| hypothetical protein RB32ORF193c [Enterobacteria phage RB32] >gi|228861508|ref|YP_002854529.1| alt.-3 hypothetical protein [Enterobacteria phage RB14] >gi|330858713|ref|YP_004415088.1| hypothetical protein Shfl2p197 [Shigella phage Shfl2] >gi|731233|sp|P39493.1|Y12A_BPT4 RecName: Full=Uncharacterized 10.7 kDa protein in Gp54-alt intergenic region [Enterobacteria phage T4] >gi|5354329|gb|AAD42536.1|AF158101_123 Alt.-3 conserved hypothetical protein [Enterobacteria phage T4] >gi|984519|gb|AAA75320.1| alt.-3 [Enterobacteria phage T4] >gi|115344008|gb|ABI95017.1| hypothetical protein RB32ORF193c [Enterobacteria phage RB32] >gi|227438524|gb|ACP30837.1| alt.-3 hypothetical protein [Enterobacteria phage RB14] >gi|299780556|gb|ADJ39918.1| hypothetical protein T4Tp201 [Enterobacteria phage T4T] >gi|327397647|gb|AEA73149.1| hypothetical protein Shfl2p197 [Shigella phage Shfl2] >gi|397134212|gb|AFO10719.1| hypothetical protein ECML134_193 [Escherichia phage ECML-134] >gi|628971904|gb|AHY83625.1| hypothetical protein T4wild_197 [Enterobacteria phage T4] >gi|628972094|gb|AHY83814.1| hypothetical protein T4147_197 [Enterobacteria phage T4] >gi|628972289|gb|AHY84008.1| hypothetical protein T4GT7_197 [Enterobacteria phage T4]</Hit_def> + <Hit_accession>NP_049808</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>65.855</Hsp_bit-score> + <Hsp_score>159</Hsp_score> + <Hsp_evalue>9.33346e-12</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>52</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSSLRFLGQELVVEGVIPADNAFNEAVYDEFIKIFGTDKKFGIFPSENFSKPEQTESIFQGVVTGKFESEAPVKIEVYIEDSLVASVAAFISFRK</Hsp_hseq> + <Hsp_midline>MKS R G E+VVE V+P FNE V+ E KI G DKK P F E ++ + VVTG+ E E V ++ D ++ ++ AF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>12</Hit_num> + <Hit_id>gi|414086561|ref|YP_006986750.1|</Hit_id> + <Hit_def>hypothetical protein ACG-C40_0194 [Enterobacteria phage vB_EcoM_ACG-C40] >gi|639438845|ref|YP_009030802.1| hypothetical protein [Escherichia phage e11/2] >gi|383396342|gb|AFH20158.1| hypothetical protein ACG-C40_0194 [Enterobacteria phage vB_EcoM_ACG-C40] >gi|398313743|emb|CCI89090.1| protein of unknown function [Yersinia phage phiD1] >gi|525334461|gb|AGR46143.1| hypothetical protein [Yersinia phage PST] >gi|628971673|gb|AHY83395.1| hypothetical protein [Escherichia phage e11/2]</Hit_def> + <Hit_accession>YP_006986750</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>65.855</Hsp_bit-score> + <Hsp_score>159</Hsp_score> + <Hsp_evalue>9.52974e-12</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>52</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSSLRFLGQELVVEGVIPADNAFNEAVYDEFIKIFGTDKKFGIFPSENFSKPEQTESIFQGVVTGKFESEAPVKIEVYIEDSLVASVSAFISFRK</Hsp_hseq> + <Hsp_midline>MKS R G E+VVE V+P FNE V+ E KI G DKK P F E ++ + VVTG+ E E V ++ D ++ ++ AF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>13</Hit_num> + <Hit_id>gi|410492102|ref|YP_006907288.1|</Hit_id> + <Hit_def>hypothetical protein HX01_0247 [Enterobacteria phage HX01] >gi|407437691|gb|AFU20451.1| hypothetical protein HX01_0247 [Enterobacteria phage HX01]</Hit_def> + <Hit_accession>YP_006907288</Hit_accession> + <Hit_len>97</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>64.3142</Hsp_bit-score> + <Hsp_score>155</Hsp_score> + <Hsp_evalue>3.48235e-11</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>97</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>39</Hsp_identity> + <Hsp_positive>50</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>97</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKIL-GDKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQT-VENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSMLRFNGQELVVEDVIPADDAFNEAVIDELNRVFPGAFHIAMEPLKNFRDPEHTDQIFVGVVTGHLETEVPMVVLVKYSKDDTPFRAPAFLSFRK</Hsp_hseq> + <Hsp_midline>MKS+ R NG E+VVEDV+P FNE V EL ++ G + P+ F E+ D VVTG LE E + V D+ PAF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>14</Hit_num> + <Hit_id>gi|422934610|ref|YP_007004571.1|</Hit_id> + <Hit_def>conserved hypothetical protein [Enterobacteria phage ime09] >gi|339791393|gb|AEK12450.1| conserved hypothetical protein [Enterobacteria phage ime09]</Hit_def> + <Hit_accession>YP_007004571</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>64.3142</Hsp_bit-score> + <Hsp_score>155</Hsp_score> + <Hsp_evalue>3.60146e-11</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>52</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSSLRFLGQELVVEGVIPADNAFNEAVYDEFIKIFGTDKKFGIFPSENFLKPEQTESIFQGVVTGKFESEAPVKIEVYIEDSLVASVAAFISFRK</Hsp_hseq> + <Hsp_midline>MKS R G E+VVE V+P FNE V+ E KI G DKK P F E ++ + VVTG+ E E V ++ D ++ ++ AF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>15</Hit_num> + <Hit_id>gi|604671904|gb|AHV82898.1|</Hit_id> + <Hit_def>hypothetical protein PhAPEC2_189 [Escherichia phage vB_EcoM_PhAPEC2]</Hit_def> + <Hit_accession>AHV82898</Hit_accession> + <Hit_len>97</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>63.1586</Hsp_bit-score> + <Hsp_score>152</Hsp_score> + <Hsp_evalue>1.00057e-10</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>97</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>50</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>97</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKIL-GDKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQT-VENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSMLRFNGQELVVEDVIPADDAFNEAVIDELNRVFPGAFHIAMEPLKNFRDPEHTDQIFIGVLTGHLETEVPMVVLVKYSKDDTPFRAPAFLSFRK</Hsp_hseq> + <Hsp_midline>MKS+ R NG E+VVEDV+P FNE V EL ++ G + P+ F E+ D V+TG LE E + V D+ PAF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>16</Hit_num> + <Hit_id>gi|228861127|ref|YP_002854150.1|</Hit_id> + <Hit_def>alt.-3 hypothetical protein [Enterobacteria phage RB51] >gi|422934975|ref|YP_007004935.1| hypothetical protein [Escherichia phage wV7] >gi|227438801|gb|ACP31113.1| alt.-3 hypothetical protein [Enterobacteria phage RB51] >gi|343177529|gb|AEM00855.1| hypothetical protein [Escherichia phage wV7]</Hit_def> + <Hit_accession>YP_002854150</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>62.7734</Hsp_bit-score> + <Hsp_score>151</Hsp_score> + <Hsp_evalue>1.42584e-10</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>37</Hsp_identity> + <Hsp_positive>51</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSSLRFLGQELVVEGVIPADNAFNEAVYDEFIKIFGTDKKFGIFPSENFSKPEQTESIFQGVVTGKFESEAPVKIEVYIEETSVASVAAFISFRK</Hsp_hseq> + <Hsp_midline>MKS R G E+VVE V+P FNE V+ E KI G DKK P F E ++ + VVTG+ E E V ++ + + ++ AF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>17</Hit_num> + <Hit_id>gi|291290413|dbj|BAI83208.1|</Hit_id> + <Hit_def>conserved hypothetical protein [Enterobacteria phage AR1]</Hit_def> + <Hit_accession>BAI83208</Hit_accession> + <Hit_len>96</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>62.3882</Hsp_bit-score> + <Hsp_score>150</Hsp_score> + <Hsp_evalue>1.90349e-10</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>96</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>37</Hsp_identity> + <Hsp_positive>51</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>96</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKILG-DKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQTVENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSSLRFLGQELVVEGVIPADNAFNEAVYGEFIKIFGTDKKFGIFPSENFSKPEQTESIFQGVVTGKFESEAPVKIEVYIEETSVASVSAFISFRK</Hsp_hseq> + <Hsp_midline>MKS R G E+VVE V+P FNE V+ E KI G DKK P F E ++ + VVTG+ E E V ++ + + ++ AF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>18</Hit_num> + <Hit_id>gi|642906035|ref|YP_009037572.1|</Hit_id> + <Hit_def>hypothetical protein JS09_0249 [Escherichia phage vB_EcoM_JS09] >gi|642904189|gb|AIA80209.1| hypothetical protein JS09_0249 [Escherichia phage vB_EcoM_JS09]</Hit_def> + <Hit_accession>YP_009037572</Hit_accession> + <Hit_len>97</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>62.003</Hsp_bit-score> + <Hsp_score>149</Hsp_score> + <Hsp_evalue>2.61121e-10</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>97</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>49</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>97</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKIL-GDKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQT-VENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSMLRFNGQELVVEDAIPADDVFNEAVIDELNRVFPGAFHIAMEPLKNFRDPEHTDQIFVGVVTGHLETEVPMVVLVKYSKDDTPFRAPAFLSFRK</Hsp_hseq> + <Hsp_midline>MKS+ R NG E+VVED +P FNE V EL ++ G + P+ F E+ D VVTG LE E + V D+ PAF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>19</Hit_num> + <Hit_id>gi|32453690|ref|NP_861899.1|</Hit_id> + <Hit_def>Alt.-3 conserved hypothetical protein [Enterobacteria phage RB69] >gi|32350509|gb|AAP76108.1| Alt.-3 conserved hypothetical protein [Enterobacteria phage RB69]</Hit_def> + <Hit_accession>NP_861899</Hit_accession> + <Hit_len>97</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>61.2326</Hsp_bit-score> + <Hsp_score>147</Hsp_score> + <Hsp_evalue>5.64687e-10</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>95</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>97</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>38</Hsp_identity> + <Hsp_positive>50</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>97</Hsp_align-len> + <Hsp_qseq>MKSIFRINGVEIVVEDVVPMSYEFNEVVFKELKKIL-GDKKLQSTPIGRFGMKENVDTYIESVVTGQLEGEFSVAVQT-VENDEVILTLPAFVIFRK</Hsp_qseq> + <Hsp_hseq>MKSMLRFNGQELVVENVIPADDVFNEAVIDELNRVFPGAFHIAMEPLKNFRDPEHTDQIFIGVVTGHLETEVPMVVLVKYSKDDTPFRAPAFLSFRK</Hsp_hseq> + <Hsp_midline>MKS+ R NG E+VVE+V+P FNE V EL ++ G + P+ F E+ D VVTG LE E + V D+ PAF+ FRK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +</Iteration_hits> + <Iteration_stat> + <Statistics> + <Statistics_db-num>48094830</Statistics_db-num> + <Statistics_db-len>17186091396</Statistics_db-len> + <Statistics_hsp-len>65</Statistics_hsp-len> + <Statistics_eff-space>421797823380</Statistics_eff-space> + <Statistics_kappa>0.041</Statistics_kappa> + <Statistics_lambda>0.267</Statistics_lambda> + <Statistics_entropy>0.14</Statistics_entropy> + </Statistics> + </Iteration_stat> +</Iteration> +<Iteration> + <Iteration_iter-num>3</Iteration_iter-num> + <Iteration_query-ID>Query_3</Iteration_query-ID> + <Iteration_query-def>Merlin_3</Iteration_query-def> + <Iteration_query-len>314</Iteration_query-len> +<Iteration_hits> +<Hit> + <Hit_num>1</Hit_num> + <Hit_id>gi|456351277|ref|YP_007501229.1|</Hit_id> + <Hit_def>baseplate subunit [Salmonella phage S16] >gi|347466342|gb|AEO97128.1| baseplate subunit [Salmonella phage S16] >gi|408387126|gb|AFU64135.1| tail assembly [Salmonella phage STML-198]</Hit_def> + <Hit_accession>YP_007501229</Hit_accession> + <Hit_len>305</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>573.548</Hsp_bit-score> + <Hsp_score>1477</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>302</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>302</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>266</Hsp_identity> + <Hsp_positive>289</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>302</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVIN</Hsp_qseq> + <Hsp_hseq>MYTLDEFKNQAANIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTQGLTNIITSGTRDLTRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLIDFFNMVYPQSGLMIYSVKIPENRLSHEMDFMHNSPNIKITGRDLEPLTVSFRMDPEASNYRAMQDWVNAVQDPVTGLRALPTDVEADIQVNLHARNGIPHTVIMFTGCIPISCGAPELTYEGDNQIAVFDVTFAYRVMQAGAVGRQAAIDWLEDKTVDSIDKINPDLSLNGSLSRLSRLGGAGGGISNIVN</Hsp_hseq> + <Hsp_midline>M TLDEFKNQA NIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFT GLT+IIT+GT+ L RKSGVSKYLIGAMSNRVVQSLLGEFEVGTYL+DFFNM YPQSGLMIYSVKIPENRLSHEMDF HNSPNI+ITGR+L+PLT+SFRMDPEASNYRAMQDWVN+VQDPVTGLRALPTDVEADIQVNLHARNG+PHTVIMFTGC+P++CGAPELTYEGDNQIAVFDVTFAYRVMQ GAVGRQAA+DW+ED+ V+SI IN ++SLNGSLSRLSRLGGA GG+S+++N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>2</Hit_num> + <Hit_id>gi|311993189|ref|YP_004010055.1|</Hit_id> + <Hit_def>gp54 base plate tail tube initiator [Enterobacteria phage CC31] >gi|284178027|gb|ADB81693.1| gp54 base plate tail tube initiator [Enterobacteria phage CC31]</Hit_def> + <Hit_accession>YP_004010055</Hit_accession> + <Hit_len>320</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>539.265</Hsp_bit-score> + <Hsp_score>1388</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>314</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>320</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>258</Hsp_identity> + <Hsp_positive>286</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>320</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINST------RNSTSKILGL</Hsp_qseq> + <Hsp_hseq>MLNLDEFNNQVMNVDFQRTNMFSCVFATSPSAKSQLLLDQFGGMLYNNLPVSGDWLGLSQGEFTQGLTSIITAGTQELVRKSGVSKYLIGAMTNRVVQSLLGEFEVGTYLLDFFNMAFPTSGLMIYSAKIPDNRLSHETDWLHNSPNIRITGRELEPLTLSFRMDSEASNWRAMQDWVNSVQDPVTGLRALPVDVEADIQVNLHARNGLPHTVCMFTGCVPVSCGSPEFTWDGDNQIAVFDVQFAYRVMQVGAVGRQAAADWVEDRLVHAIGNISDDMGLDSSLSRLSRLGGAAGGITQMGNAIGRKTGMWNSTSKILGL</Hsp_hseq> + <Hsp_midline>ML LDEF NQ N+DFQRTNMFSCVFAT+PSAKSQ LLDQFGGML+NNLP++ DWLGL+QGEFT GLTSIITAGTQ+LVRKSGVSKYLIGAM+NRVVQSLLGEFEVGTYLLDFFNMA+P SGLMIYS KIP+NRLSHE D+ HNSPNIRITGREL+PLT+SFRMD EASN+RAMQDWVNSVQDPVTGLRALP DVEADIQVNLHARNGLPHTV MFTGCVPV+CG+PE T++GDNQIAVFDV FAYRVMQ GAVGRQAA DW+EDR V++I I+ +M L+ SLSRLSRLGGAAGG++ + N+ NSTSKILGL</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>3</Hit_num> + <Hit_id>gi|589889940|ref|YP_009005476.1|</Hit_id> + <Hit_def>baseplate subunit [Enterobacter phage PG7] >gi|583927853|gb|AHI61115.1| baseplate subunit [Enterobacter phage PG7]</Hit_def> + <Hit_accession>YP_009005476</Hit_accession> + <Hit_len>320</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>535.798</Hsp_bit-score> + <Hsp_score>1379</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>314</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>320</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>257</Hsp_identity> + <Hsp_positive>285</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>320</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINST------RNSTSKILGL</Hsp_qseq> + <Hsp_hseq>MLNLDEFNNQVMNVDFQRTNMFSCVFATTPSAKSQLLLDQFGGMLYNNLPVSGDWLGLSQGEFTQGITSIITAGTQELVRKSGVSKYLIGAMTNRVVQSLLGEFEVGTYLLDFFNMAFPTSGLMIYSAKIPDNRLSHETDWLHNSPNIRITGRELEPLTLSFRMDSEASNWRAMQDWVNSVQDPVTGLRALPVDVEADIQVNLHARNGLPHTVCMFTGCVPVSCGSPEFTWDGDNQIAVFDVQFAYRVMQVGAVGRQAAADWVEDRLVHAIGNISDDMGLDPSLSRLSRLGGAGGGITQMGNAIGRKTGMWNSTSKILGL</Hsp_hseq> + <Hsp_midline>ML LDEF NQ N+DFQRTNMFSCVFATTPSAKSQ LLDQFGGML+NNLP++ DWLGL+QGEFT G+TSIITAGTQ+LVRKSGVSKYLIGAM+NRVVQSLLGEFEVGTYLLDFFNMA+P SGLMIYS KIP+NRLSHE D+ HNSPNIRITGREL+PLT+SFRMD EASN+RAMQDWVNSVQDPVTGLRALP DVEADIQVNLHARNGLPHTV MFTGCVPV+CG+PE T++GDNQIAVFDV FAYRVMQ GAVGRQAA DW+EDR V++I I+ +M L+ SLSRLSRLGGA GG++ + N+ NSTSKILGL</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>4</Hit_num> + <Hit_id>gi|314121773|ref|YP_004063892.1|</Hit_id> + <Hit_def>gp54 baseplate subunit [Enterobacteria phage vB_EcoM-VR7] >gi|313151530|gb|ADR32586.1| gp54 baseplate subunit [Enterobacteria phage vB_EcoM-VR7]</Hit_def> + <Hit_accession>YP_004063892</Hit_accession> + <Hit_len>319</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>479.174</Hsp_bit-score> + <Hsp_score>1232</Hsp_score> + <Hsp_evalue>6.96493e-167</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>313</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>218</Hsp_identity> + <Hsp_positive>264</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>313</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MFTLQEFQTQAINIDLQRNNLFSVVFATAPSSKSQNLLDQFGGALFSNLPVNSDWFGLTQGDLTQGITTLVTAGTQKLIRKSGISKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPTAGLLVHSVKLPDNTLNYEMDLNHNAPNIKITGREYSPLVLSFRMDSEAGNFRAFNDWVNSVQDPVTQLRALPEDVEADIQVNLHSRNGLPHTVVMLTGCVPVSVSAPELSYEGDNQIATFDVTFAYRVMSTGAVGRNAALEWLEDKVIKGVSGISSDNNLNAEVAKLSRLSGAQSGLTSLYNTFTGSGRAVSG</Hsp_hseq> + <Hsp_midline>M TL EF+ QA NID QR N+FS VFAT PS+KSQ LLDQFGG LF+NLP+N+DW GLTQG+ T G+T+++TAGTQ+L+RKSG+SKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYP +GL+++SVK+P+N L++EMD NHN+PNI+ITGRE PL +SFRMD EA N+RA DWVNSVQDPVT LRALP DVEADIQVNLH+RNGLPHTV+M TGCVPV+ APEL+YEGDNQIA FDVTFAYRVM TGAVGR AAL+W+ED+ + ++GI+S+ +LN +++LSRL GA GL+ + N+ S + G</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>5</Hit_num> + <Hit_id>gi|308814558|ref|YP_003934832.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Shigella phage SP18] >gi|308206150|gb|ADO19549.1| baseplate tail tube initiator [Shigella phage SP18]</Hit_def> + <Hit_accession>YP_003934832</Hit_accession> + <Hit_len>314</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>478.404</Hsp_bit-score> + <Hsp_score>1230</Hsp_score> + <Hsp_evalue>1.05147e-166</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>303</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>303</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>216</Hsp_identity> + <Hsp_positive>261</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>303</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINS</Hsp_qseq> + <Hsp_hseq>MFTLQEFQTQAINIDLQRNNLFSVVFATAPSSKSQNLLDQFGGALFSNLPVNSDWFGLTQGDLTQGITTLVTAGTQKLIRKSGISKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPTAGLLVHSVKLPDNTLNYEMDLNHNAPNIKITGREYSPLVLSFRMDSEAGNFRAFNDWVNSVQDPVTQLRALPEDVEADIQVNLHSRNGLPHTVVMLTGCVPVSVSAPELSYEGDNQIATFDVTFAYRVMSTGAVGRAAALEWLEDKVIKGVSGISSDNNLNAEVAKLSRLSGAQSGLTSLYNT</Hsp_hseq> + <Hsp_midline>M TL EF+ QA NID QR N+FS VFAT PS+KSQ LLDQFGG LF+NLP+N+DW GLTQG+ T G+T+++TAGTQ+L+RKSG+SKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYP +GL+++SVK+P+N L++EMD NHN+PNI+ITGRE PL +SFRMD EA N+RA DWVNSVQDPVT LRALP DVEADIQVNLH+RNGLPHTV+M TGCVPV+ APEL+YEGDNQIA FDVTFAYRVM TGAVGR AAL+W+ED+ + ++GI+S+ +LN +++LSRL GA GL+ + N+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>6</Hit_num> + <Hit_id>gi|161622624|ref|YP_001595320.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Enterobacteria phage JS98] >gi|238695347|ref|YP_002922540.1| gp54 baseplate tail tube initiator [Enterobacteria phage JS10] >gi|52139950|gb|AAU29320.1| gp54 baseplate tail tube initiator [Enterobacteria phage JS98] >gi|220029483|gb|ACL78417.1| gp54 baseplate tail tube initiator [Enterobacteria phage JS10]</Hit_def> + <Hit_accession>YP_001595320</Hit_accession> + <Hit_len>317</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>468.389</Hsp_bit-score> + <Hsp_score>1204</Hsp_score> + <Hsp_evalue>9.66148e-163</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>303</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>303</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>210</Hsp_identity> + <Hsp_positive>260</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>303</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINS</Hsp_qseq> + <Hsp_hseq>MYTLQEFQNQAINIDLQRNNLFSVVFATVPSSKSQALLDQFGGALFNNIPLNTDLFGITQGDLTQGVTTLVTAGTQKLIRKSGISKYLIGAMSSRVVQSLLGEFEVGTYLMDFFNMAYPTAGLLVHAVKIPDNTLNYEMDLNHNSPNIKITGREYSPLVLSFRMDSEAANYRAFNDWVNSVQDPITQLRALPEDVEADIQVNLHSRNGLPHTVVMLNGCVPVSVSSPELSYDGDNQIASFDVTFAYRSVQTGAVGKQAAYEWLEDKVLKGVAGISESNSLSASVAKLSRLSGASSGLTGLVNT</Hsp_hseq> + <Hsp_midline>M TL EF+NQA NID QR N+FS VFAT PS+KSQ LLDQFGG LFNN+PLN D G+TQG+ T G+T+++TAGTQ+L+RKSG+SKYLIGAMS+RVVQSLLGEFEVGTYL+DFFNMAYP +GL++++VKIP+N L++EMD NHNSPNI+ITGRE PL +SFRMD EA+NYRA DWVNSVQDP+T LRALP DVEADIQVNLH+RNGLPHTV+M GCVPV+ +PEL+Y+GDNQIA FDVTFAYR +QTGAVG+QAA +W+ED+ + + GI+ SL+ S+++LSRL GA+ GL+ ++N+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>7</Hit_num> + <Hit_id>gi|431809134|ref|YP_007236031.1|</Hit_id> + <Hit_def>phage tail assembly [Yersinia phage phiR1-RT] >gi|398313423|emb|CCI88772.1| phage tail assembly [Yersinia phage phiR1-RT]</Hit_def> + <Hit_accession>YP_007236031</Hit_accession> + <Hit_len>312</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>464.537</Hsp_bit-score> + <Hsp_score>1194</Hsp_score> + <Hsp_evalue>2.90603e-161</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>312</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>312</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>229</Hsp_identity> + <Hsp_positive>266</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>312</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINSTRNSTSKIL</Hsp_qseq> + <Hsp_hseq>MYTLDEFNSQAINIDFQRTNLFSVVFATTPSNKTSQILDQFGGYLYNSLPLDNDWLGITRGEINQGVTALITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAFPTAGLMVNSVKMPDNTLQHEMDPNHNAPNIKITGRDYSPLILTFRMDSEASNFRAMQDWVNSVQDPITGLRSLPEDVEADIQVNLHKRNGLPHTVSMFTGCIPVSVASPELAYENDNTIAIFDVTFAYRAMQIGAVGTQAALDWLEEKAIFNIDKINPGQSLNSSLSQLSRLGGARTGLSGVIGLASGSNSRVL</Hsp_hseq> + <Hsp_midline>M TLDEF +QA NIDFQRTN+FS VFATTPS K+ Q+LDQFGG L+N+LPL+NDWLG+T+GE G+T++ITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMA+P +GLM+ SVK+P+N L HEMD NHN+PNI+ITGR+ PL ++FRMD EASN+RAMQDWVNSVQDP+TGLR+LP DVEADIQVNLH RNGLPHTV MFTGC+PV+ +PEL YE DN IA+FDVTFAYR MQ GAVG QAALDW+E++A+ +I IN SLN SLS+LSRLGGA GLS VI S S++L</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>8</Hit_num> + <Hit_id>gi|422934214|ref|YP_007004250.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Enterobacteria phage Bp7] >gi|345450723|gb|AEN93926.1| baseplate tail tube initiator [Enterobacteria phage Bp7]</Hit_def> + <Hit_accession>YP_007004250</Hit_accession> + <Hit_len>313</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>462.225</Hsp_bit-score> + <Hsp_score>1188</Hsp_score> + <Hsp_evalue>2.42235e-160</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>303</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>303</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>211</Hsp_identity> + <Hsp_positive>261</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>303</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINS</Hsp_qseq> + <Hsp_hseq>MYTLQEFQNQAINIDLQRNNLFSVVFATVPSSKSQTLLDQFGGALFNNIPLNSDLFGITQGELTQGVTTLVTAGTQKLIRKSGISKYLIGAMSSRVVQSLLGEFEVGTYLMDFFNMAYPTAGLLVHAVKIPDNTLNYEMDLNHNSPNIKITGREYSPLVLSFRMDSEAANYRAFNDWVNSVQDPITQLRALPEDVEADIQVNLHSRNGLPHTVVMLNGCVPVSVSSPELSYDGDNQIASFDVTFAYRSVQTGAVGKQAAYEWLEDKVLKGVAGISESNSLSSSVAKLSRLSGASSGLTGLVNT</Hsp_hseq> + <Hsp_midline>M TL EF+NQA NID QR N+FS VFAT PS+KSQ LLDQFGG LFNN+PLN+D G+TQGE T G+T+++TAGTQ+L+RKSG+SKYLIGAMS+RVVQSLLGEFEVGTYL+DFFNMAYP +GL++++VKIP+N L++EMD NHNSPNI+ITGRE PL +SFRMD EA+NYRA DWVNSVQDP+T LRALP DVEADIQVNLH+RNGLPHTV+M GCVPV+ +PEL+Y+GDNQIA FDVTFAYR +QTGAVG+QAA +W+ED+ + + GI+ SL+ S+++LSRL GA+ GL+ ++N+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>9</Hit_num> + <Hit_id>gi|32453689|ref|NP_861898.1|</Hit_id> + <Hit_def>baseplate subunit [Enterobacteria phage RB69] >gi|32350508|gb|AAP76107.1| gp54 baseplate tail tube initiator [Enterobacteria phage RB69]</Hit_def> + <Hit_accession>NP_861898</Hit_accession> + <Hit_len>320</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>462.225</Hsp_bit-score> + <Hsp_score>1188</Hsp_score> + <Hsp_evalue>2.72149e-160</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>314</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>320</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>225</Hsp_identity> + <Hsp_positive>267</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>320</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILGL</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSIGSFAYNNLGLDSDWLGLTQGDINQGVTTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGEFTVGAYLIDFFNMAYNNTGLMIYSVKMPENRLSYETDFNYNSPNIRITGREMDPLVISFRMDSEASNFRAMQDWVNSVQDPVTGLRALPQDVEADIQVNLHARNGLPHTAVMFTGCIPVSVSSPELTYDGDNQITVFDVTFAYRVMQSGAVNRQAALEWLESGLISSVSGMFGNNQNDSGLGSAVSRLSRLGGTAGGVSNINTLTGVVNSASRVLGL</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ G +NNL L++DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLGEF VG YL+DFFNMAY +GLMIYSVK+PENRLS+E DFN+NSPNIRITGRE+DPL ISFRMD EASN+RAMQDWVNSVQDPVTGLRALP DVEADIQVNLHARNGLPHT +MFTGC+PV+ +PELTY+GDNQI VFDVTFAYRVMQ+GAV RQAAL+W+E ++S++G+ ++ L ++SRLSRLGG AGG+S++ + NS S++LGL</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>10</Hit_num> + <Hit_id>gi|604671903|gb|AHV82897.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Escherichia phage vB_EcoM_PhAPEC2]</Hit_def> + <Hit_accession>AHV82897</Hit_accession> + <Hit_len>320</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>461.84</Hsp_bit-score> + <Hsp_score>1187</Hsp_score> + <Hsp_evalue>4.35158e-160</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>314</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>320</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>224</Hsp_identity> + <Hsp_positive>267</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>320</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILGL</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSIGSFAYNNLGLDSDWLGLTQGDINQGVTTLITAGTQKLIRKSGISKYLIGAMSQRTVQSLLGEFTVGAYLIDFFNMAYNNTGLMIYSVKMPENRLSYETDFNYNSPNIRITGREMDPLVISFRMDSEASNFRAMQDWVNSVQDPVTGLRALPQDVEADIQVNLHARNGLPHTAVMFTGCIPVSVSSPELTYDGDNQITVFDVTFAYRVMQSGAVNRQAALEWLESGLISSVSGMFGNNQNDSGLGSAVSRLSRLGGTAGGVSNINTLTGVVNSASRVLGL</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ G +NNL L++DWLGLTQG+ G+T++ITAGTQ+L+RKSG+SKYLIGAMS R VQSLLGEF VG YL+DFFNMAY +GLMIYSVK+PENRLS+E DFN+NSPNIRITGRE+DPL ISFRMD EASN+RAMQDWVNSVQDPVTGLRALP DVEADIQVNLHARNGLPHT +MFTGC+PV+ +PELTY+GDNQI VFDVTFAYRVMQ+GAV RQAAL+W+E ++S++G+ ++ L ++SRLSRLGG AGG+S++ + NS S++LGL</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>11</Hit_num> + <Hit_id>gi|299779142|ref|YP_003734336.1|</Hit_id> + <Hit_def>54 gene product [Enterobacteria phage IME08] >gi|298105871|gb|ADI55515.1| gp54 baseplate tail tube initiator [Enterobacteria phage IME08]</Hit_def> + <Hit_accession>YP_003734336</Hit_accession> + <Hit_len>319</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>461.455</Hsp_bit-score> + <Hsp_score>1186</Hsp_score> + <Hsp_evalue>5.45864e-160</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>303</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>305</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>211</Hsp_identity> + <Hsp_positive>260</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>303</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINS</Hsp_qseq> + <Hsp_hseq>MYTLQEFQNQAINIDLQRNNLFSVVFATVPSSKSQALLDQFGGALFNNIPLNSDLFGITQGELTQGVTTLVTAGTQKLIRKSGISKYLIGAMSSRVVQSLLGEFEVGTYLMDFFNMAYPTAGLLVHAVKIPDNTLNYEMDLNHNSPNIKITGREYSPLVLSFRMDSEAANYRAFNDWVNSVQDPITQLRALPEDVEADIQVNLHSRNGLPHTVVMLNGCVPVGVSSPELSYDGDNQIASFDVTFAYRSVQTGAVGKQAAYEWLEDKVLKGVAGISESNSLSSSVAKLSRLSGASSGLTGLVNT</Hsp_hseq> + <Hsp_midline>M TL EF+NQA NID QR N+FS VFAT PS+KSQ LLDQFGG LFNN+PLN+D G+TQGE T G+T+++TAGTQ+L+RKSG+SKYLIGAMS+RVVQSLLGEFEVGTYL+DFFNMAYP +GL++++VKIP+N L++EMD NHNSPNI+ITGRE PL +SFRMD EA+NYRA DWVNSVQDP+T LRALP DVEADIQVNLH+RNGLPHTV+M GCVPV +PEL+Y+GDNQIA FDVTFAYR +QTGAVG+QAA +W+ED+ + + GI+ SL+ S+++LSRL GA+ GL+ ++N+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>12</Hit_num> + <Hit_id>gi|228861126|ref|YP_002854149.1|</Hit_id> + <Hit_def>gp54 base plate-tail tube initiator [Enterobacteria phage RB51] >gi|422934974|ref|YP_007004934.1| baseplate tail tube initiator [Escherichia phage wV7] >gi|227438800|gb|ACP31112.1| gp54 base plate-tail tube initiator [Enterobacteria phage RB51] >gi|291290412|dbj|BAI83207.1| baseplate tail tube initiator [Enterobacteria phage AR1] >gi|343177528|gb|AEM00854.1| baseplate tail tube initiator [Escherichia phage wV7]</Hit_def> + <Hit_accession>YP_002854149</Hit_accession> + <Hit_len>321</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>461.455</Hsp_bit-score> + <Hsp_score>1186</Hsp_score> + <Hsp_evalue>5.48662e-160</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>319</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>226</Hsp_identity> + <Hsp_positive>259</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI--NSE--MSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFAYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNAVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFTGCIPISVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQAALEWLESATINGIQSVLGNSGGVTGLSNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVN+VQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFTGC+P++ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQAAL+W+E +N I + NS L+ SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>13</Hit_num> + <Hit_id>gi|116326414|ref|YP_803134.1|</Hit_id> + <Hit_def>base plate-tail tube initiator [Enterobacteria phage RB32] >gi|115344007|gb|ABI95016.1| base plate-tail tube initiator [Enterobacteria phage RB32]</Hit_def> + <Hit_accession>YP_803134</Hit_accession> + <Hit_len>321</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>459.914</Hsp_bit-score> + <Hsp_score>1182</Hsp_score> + <Hsp_evalue>2.9788e-159</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>319</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>227</Hsp_identity> + <Hsp_positive>258</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNSVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFTGCIPVSVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQAALEWLESAAINGIQSVLGNSGGVTGLSNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVNSVQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFTGC+PV+ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQAAL+W+E A+N I + L+ SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>14</Hit_num> + <Hit_id>gi|642905804|ref|YP_009037573.1|</Hit_id> + <Hit_def>baseplate subunit [Escherichia phage vB_EcoM_JS09] >gi|642903958|gb|AIA79978.1| baseplate subunit [Escherichia phage vB_EcoM_JS09]</Hit_def> + <Hit_accession>YP_009037573</Hit_accession> + <Hit_len>320</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>459.529</Hsp_bit-score> + <Hsp_score>1181</Hsp_score> + <Hsp_evalue>4.03338e-159</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>314</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>320</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>223</Hsp_identity> + <Hsp_positive>266</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>320</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILGL</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNHAINADFQRNNMFSCVFATTPSTKSSSLISSIGSFAYNNLGLDSDWLGLSQGDINQGVTTLITAGTQKLIRKSGASKYLIGAMSQRTVQSLLGEFTVGTYLIDFFNMAYNNTGLMIYSVKMPENRLSYETDFNYNSPNIRITGREMDPLVISFRMDSEASNFRAMQDWVNSVQDPVTGLRALPQDVEADIQVNLHARNGLPHTAVMFTGCIPVSVSSPELTYDGDNQITVFDVTFAYRVMQSGAVNRQAALEWLESGLISSVSGMFGNNQNDSGLGSAVSRLSRLGGTAGGVSNINTLTGVVNSASRVLGL</Hsp_hseq> + <Hsp_midline>M +L+EF N A N DFQR NMFSCVFATTPS KS L+ G +NNL L++DWLGL+QG+ G+T++ITAGTQ+L+RKSG SKYLIGAMS R VQSLLGEF VGTYL+DFFNMAY +GLMIYSVK+PENRLS+E DFN+NSPNIRITGRE+DPL ISFRMD EASN+RAMQDWVNSVQDPVTGLRALP DVEADIQVNLHARNGLPHT +MFTGC+PV+ +PELTY+GDNQI VFDVTFAYRVMQ+GAV RQAAL+W+E ++S++G+ ++ L ++SRLSRLGG AGG+S++ + NS S++LGL</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>15</Hit_num> + <Hit_id>gi|299780555|gb|ADJ39917.1|</Hit_id> + <Hit_def>baseplate subunit [Enterobacteria phage T4T] >gi|397134211|gb|AFO10718.1| hypothetical protein ECML134_192 [Escherichia phage ECML-134] >gi|398313742|emb|CCI89089.1| phage tail assembly [Yersinia phage phiD1]</Hit_def> + <Hit_accession>ADJ39917</Hit_accession> + <Hit_len>321</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>459.144</Hsp_bit-score> + <Hsp_score>1180</Hsp_score> + <Hsp_evalue>4.97538e-159</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>319</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>226</Hsp_identity> + <Hsp_positive>258</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNSVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFTGCIPISVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQAALEWLESAAINGIQSVLGNSGGVTGLSNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVNSVQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFTGC+P++ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQAAL+W+E A+N I + L+ SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>16</Hit_num> + <Hit_id>gi|525334460|gb|AGR46142.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Yersinia phage PST]</Hit_def> + <Hit_accession>AGR46142</Hit_accession> + <Hit_len>321</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>458.373</Hsp_bit-score> + <Hsp_score>1178</Hsp_score> + <Hsp_evalue>9.78828e-159</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>319</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>226</Hsp_identity> + <Hsp_positive>258</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNAVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFTGCIPVSVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQAALEWLESAAINGIQSVLGNSGGVTGLSNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVN+VQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFTGC+PV+ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQAAL+W+E A+N I + L+ SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>17</Hit_num> + <Hit_id>gi|330858712|ref|YP_004415087.1|</Hit_id> + <Hit_def>putative baseplate-tail tube initiator [Shigella phage Shfl2] >gi|422934609|ref|YP_007004570.1| phage baseplate tail tube initiator [Enterobacteria phage ime09] >gi|327397646|gb|AEA73148.1| putative baseplate-tail tube initiator [Shigella phage Shfl2] >gi|339791392|gb|AEK12449.1| phage baseplate tail tube initiator [Enterobacteria phage ime09]</Hit_def> + <Hit_accession>YP_004415087</Hit_accession> + <Hit_len>321</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>458.373</Hsp_bit-score> + <Hsp_score>1178</Hsp_score> + <Hsp_evalue>9.78828e-159</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>319</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>226</Hsp_identity> + <Hsp_positive>258</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNAVQDPVTGLRALPQDVEADIQVNLHARNGLPHTAVMFTGCIPVSVSAPELSYDGDNQITTFDVTFAYRVMQAGSVDRQAALEWLESAAINGIQSVLGNSGGVTGLSNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVN+VQDPVTGLRALP DVEADIQVNLHARNGLPHT +MFTGC+PV+ APEL+Y+GDNQI FDVTFAYRVMQ G+V RQAAL+W+E A+N I + L+ SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>18</Hit_num> + <Hit_id>gi|639438590|ref|YP_009030256.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Serratia phage PS2] >gi|625370663|gb|AHY25523.1| baseplate tail tube initiator [Serratia phage PS2]</Hit_def> + <Hit_accession>YP_009030256</Hit_accession> + <Hit_len>309</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>456.833</Hsp_bit-score> + <Hsp_score>1174</Hsp_score> + <Hsp_evalue>2.89005e-158</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>305</Hsp_query-to> + <Hsp_hit-from>6</Hsp_hit-from> + <Hsp_hit-to>307</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>213</Hsp_identity> + <Hsp_positive>255</Hsp_positive> + <Hsp_gaps>3</Hsp_gaps> + <Hsp_align-len>304</Hsp_align-len> + <Hsp_qseq>TLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLN-NDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHVINSTR</Hsp_qseq> + <Hsp_hseq>TLDEFKAQVTNLDFQRTNLFSCVFATAPSSKSQQLLDQFGGMLYNNIPVGVSDFIGLKPGEVTSAVTALAVAGTQQLVRKSGINKFLLGAMTNRVIQSLLGEFTVGTYLLDFFNMAFPTSGLTIYSVKLPENRISYEMDKNHNSPVVKLTGRDYDPLILSFRMDSDAMNYRAMQDWVNAVEDPVTGLRALPQDVEADIQVNLHNRRGIPHTVVMLQGCIPVTVSAPNLTYDGQSEIAVFDVTFAYRVMHTGAVGEQAALEWIEDKAVDKIDTINPDMS--ADLGRLSRVAGANGGLGRLTGSGR</Hsp_hseq> + <Hsp_midline>TLDEFK Q N+DFQRTN+FSCVFAT PS+KSQQLLDQFGGML+NN+P+ +D++GL GE TS +T++ AGTQQLVRKSG++K+L+GAM+NRV+QSLLGEF VGTYLLDFFNMA+P SGL IYSVK+PENR+S+EMD NHNSP +++TGR+ DPL +SFRMD +A NYRAMQDWVN+V+DPVTGLRALP DVEADIQVNLH R G+PHTV+M GC+PV AP LTY+G ++IAVFDVTFAYRVM TGAVG QAAL+WIED+AV+ I IN +MS L RLSR+ GA GGL + S R</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>19</Hit_num> + <Hit_id>gi|414086560|ref|YP_006986749.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Enterobacteria phage vB_EcoM_ACG-C40] >gi|383396341|gb|AFH20157.1| baseplate tail tube initiator [Enterobacteria phage vB_EcoM_ACG-C40]</Hit_def> + <Hit_accession>YP_006986749</Hit_accession> + <Hit_len>321</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>456.833</Hsp_bit-score> + <Hsp_score>1174</Hsp_score> + <Hsp_evalue>3.78835e-158</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>319</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>225</Hsp_identity> + <Hsp_positive>257</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNAVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFTGCIPVSVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQAALEWLESATINGIQSVLGNSGGVTGLSNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVN+VQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFTGC+PV+ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQAAL+W+E +N I + L+ SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>20</Hit_num> + <Hit_id>gi|228861507|ref|YP_002854528.1|</Hit_id> + <Hit_def>gp54 base plate-tail tube initiator [Enterobacteria phage RB14] >gi|227438523|gb|ACP30836.1| gp54 base plate-tail tube initiator [Enterobacteria phage RB14]</Hit_def> + <Hit_accession>YP_002854528</Hit_accession> + <Hit_len>321</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>456.447</Hsp_bit-score> + <Hsp_score>1173</Hsp_score> + <Hsp_evalue>6.12348e-158</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>319</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>225</Hsp_identity> + <Hsp_positive>257</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI----NSEMSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNAVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFTGCIPISVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQAALEWLESAAINGIQSVLGNSGGVTGLPNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVN+VQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFTGC+P++ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQAAL+W+E A+N I + L SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>21</Hit_num> + <Hit_id>gi|639438844|ref|YP_009030801.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Escherichia phage e11/2] >gi|628971672|gb|AHY83394.1| baseplate tail tube initiator [Escherichia phage e11/2]</Hit_def> + <Hit_accession>YP_009030801</Hit_accession> + <Hit_len>307</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>453.751</Hsp_bit-score> + <Hsp_score>1166</Hsp_score> + <Hsp_evalue>4.45165e-157</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>300</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>304</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>221</Hsp_identity> + <Hsp_positive>252</Hsp_positive> + <Hsp_gaps>4</Hsp_gaps> + <Hsp_align-len>304</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI--NSE--MSLNGSLSRLSRLGGAAGGLSHV</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNSVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFTGCIPISVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQAALEWLESAAINGIQSVLGNSGGVTELSNSLSRLSRLGGTAGSISNI</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVNSVQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFTGC+P++ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQAAL+W+E A+N I + NS L+ SLSRLSRLGG AG +S++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>22</Hit_num> + <Hit_id>gi|9632659|ref|NP_049807.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Enterobacteria phage T4] >gi|138062|sp|P13341.1|VG54_BPT4 RecName: Full=Tail-tube assembly protein Gp54 [Enterobacteria phage T4] >gi|5354283|gb|AAD42490.1|AF158101_77 gp54 baseplate tail tube initiator [Enterobacteria phage T4] >gi|215948|gb|AAA32540.1| tail-tube assembly protein [Enterobacteria phage T4]</Hit_def> + <Hit_accession>NP_049807</Hit_accession> + <Hit_len>320</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>440.654</Hsp_bit-score> + <Hsp_score>1132</Hsp_score> + <Hsp_evalue>8.55241e-152</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>313</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>318</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>224</Hsp_identity> + <Hsp_positive>255</Hsp_positive> + <Hsp_gaps>7</Hsp_gaps> + <Hsp_align-len>319</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGI--NSE--MSLNGSLSRLSRLGGAAGGLSHV--INSTRNSTSKILG</Hsp_qseq> + <Hsp_hseq>MYSLEEFNNQAINADFQRNNMFSCVFATTPSTKSSSLISSISNFSYNNLGLNSDWLGLTQGDINQGITTLITAGTQKLIRKSGVSKYLIGAMSQRTVQSLLGSFTVGTYLIDFFNMAYNSSGLMIYSVKMPENRLSYETDWNYNSPNIRITGRELDPLVISFRMDSEACNYRAMQDWVNSVQDPVTGLRALPQDVEADIQVNLHSRNGLPHTAVMFT-MHSISVSAPELSYDGDNQITTFDVTFAYRVMQAGAVDRQRALEWLESAAINGIQSVLGNSGGVTGLSNSLSRLSRLGGTAGSISNINTMTGIVNSQSKILG</Hsp_hseq> + <Hsp_midline>M +L+EF NQA N DFQR NMFSCVFATTPS KS L+ +NNL LN+DWLGLTQG+ G+T++ITAGTQ+L+RKSGVSKYLIGAMS R VQSLLG F VGTYL+DFFNMAY SGLMIYSVK+PENRLS+E D+N+NSPNIRITGRELDPL ISFRMD EA NYRAMQDWVNSVQDPVTGLRALP DVEADIQVNLH+RNGLPHT +MFT ++ APEL+Y+GDNQI FDVTFAYRVMQ GAV RQ AL+W+E A+N I + NS L+ SLSRLSRLGG AG +S++ + NS SKILG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>23</Hit_num> + <Hit_id>gi|157311485|ref|YP_001469528.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Enterobacteria phage Phi1] >gi|149380689|gb|ABR24694.1| gp54 baseplate tail tube initiator [Enterobacteria phage Phi1]</Hit_def> + <Hit_accession>YP_001469528</Hit_accession> + <Hit_len>310</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>402.905</Hsp_bit-score> + <Hsp_score>1034</Hsp_score> + <Hsp_evalue>4.51456e-137</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>306</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>308</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>191</Hsp_identity> + <Hsp_positive>239</Hsp_positive> + <Hsp_gaps>8</Hsp_gaps> + <Hsp_align-len>311</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLP-LNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLS----RLSRLGGAAGGLSHVINSTRN</Hsp_qseq> + <Hsp_hseq>MFDLNDFNEQAANLDFQRSNLFSVAFATTPSNKTQAILESMGGAVYDIIPNALNDYFGITRGDYTDALTNLAVQGVRRAVDSSGVKKYLLGAMSSRVVQSLLGQFDVGTYALDWFNMAYKTSGLLVYAVKVPENRLNYEMDRNHNAPNIRITGRDFDPLVLSFRMDSSASNYRAMQDWVNSVEDPVTGLRALPVDVEADIQVNLHNRMGVPHTIMMFNGCVPVGVSAPELTYENNNEITTFDVVFAYRTMQTGAVGEQAAREWIEDKAINAITNTFGNNLLDSGLSAAGNALSRLNGVGG---RVVNTVTN</Hsp_hseq> + <Hsp_midline>M L++F QA N+DFQR+N+FS FATTPS K+Q +L+ GG +++ +P ND+ G+T+G++T LT++ G ++ V SGV KYL+GAMS+RVVQSLLG+F+VGTY LD+FNMAY SGL++Y+VK+PENRL++EMD NHN+PNIRITGR+ DPL +SFRMD ASNYRAMQDWVNSV+DPVTGLRALP DVEADIQVNLH R G+PHT++MF GCVPV APELTYE +N+I FDV FAYR MQTGAVG QAA +WIED+A+N+IT L+ LS LSRL G G V+N+ N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>24</Hit_num> + <Hit_id>gi|33620696|ref|NP_891752.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Enterobacteria phage RB49] >gi|33438566|gb|AAL15122.2| baseplate tail tube initiator [Enterobacteria phage RB49]</Hit_def> + <Hit_accession>NP_891752</Hit_accession> + <Hit_len>310</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>402.905</Hsp_bit-score> + <Hsp_score>1034</Hsp_score> + <Hsp_evalue>4.9258e-137</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>306</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>308</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>191</Hsp_identity> + <Hsp_positive>239</Hsp_positive> + <Hsp_gaps>8</Hsp_gaps> + <Hsp_align-len>311</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLP-LNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLS----RLSRLGGAAGGLSHVINSTRN</Hsp_qseq> + <Hsp_hseq>MFDLNDFNEQAANLDFQRSNLFSVAFATTPSNKTQAILESMGGAVYDIIPNALNDYFGITRGDYTDALTNLAVQGVRRAVDSSGVKKYLLGAMSSRVVQSLLGQFDVGTYALDWFNMAYKTSGLLVYAVKVPENRLNYEMDRNHNAPNIRITGRDFDPLVLSFRMDSSASNYRAMQDWVNSVEDPVTGLRALPVDVEADIQVNLHNRMGVPHTIMMFNGCVPVGVSAPELNYENNNEITTFDVTFAYRTMQTGAVGEQAAREWIEDKAINAITNTFGNNLLDSGLSAAGNALSRLNGVGG---RVVNTVTN</Hsp_hseq> + <Hsp_midline>M L++F QA N+DFQR+N+FS FATTPS K+Q +L+ GG +++ +P ND+ G+T+G++T LT++ G ++ V SGV KYL+GAMS+RVVQSLLG+F+VGTY LD+FNMAY SGL++Y+VK+PENRL++EMD NHN+PNIRITGR+ DPL +SFRMD ASNYRAMQDWVNSV+DPVTGLRALP DVEADIQVNLH R G+PHT++MF GCVPV APEL YE +N+I FDVTFAYR MQTGAVG QAA +WIED+A+N+IT L+ LS LSRL G G V+N+ N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>25</Hit_num> + <Hit_id>gi|238695066|ref|YP_002922260.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Enterobacteria phage JSE] >gi|220029202|gb|ACL78137.1| baseplate tail tube initiator [Enterobacteria phage JSE]</Hit_def> + <Hit_accession>YP_002922260</Hit_accession> + <Hit_len>310</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>402.134</Hsp_bit-score> + <Hsp_score>1032</Hsp_score> + <Hsp_evalue>1.02225e-136</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>306</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>308</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>191</Hsp_identity> + <Hsp_positive>239</Hsp_positive> + <Hsp_gaps>8</Hsp_gaps> + <Hsp_align-len>311</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLP-LNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLS----RLSRLGGAAGGLSHVINSTRN</Hsp_qseq> + <Hsp_hseq>MFDLNDFNEQAANLDFQRSNLFSVAFATTPSNKTQAILESMGGAVYDIIPNALNDYFGITRGDYTDALTNLAVQGVRRAVDSSGVKKYLLGAMSSRVVQSLLGQFDVGTYALDWFNMAYKTSGLLVYAVKVPENRLNYEMDRNHNAPNIRITGRDFDPLVLSFRMDSSASNYRAMQDWVNSVEDPVTGLRALPVDVEADIQVNLHNRMGVPHTIMMFNGCVPVGVSAPELNYENNNEITTFDVTFAYRSMQTGAVGEQAAREWIEDKAINAITNTFGNNLLDSGLSAAGNALSRLNGVGG---RVVNTVTN</Hsp_hseq> + <Hsp_midline>M L++F QA N+DFQR+N+FS FATTPS K+Q +L+ GG +++ +P ND+ G+T+G++T LT++ G ++ V SGV KYL+GAMS+RVVQSLLG+F+VGTY LD+FNMAY SGL++Y+VK+PENRL++EMD NHN+PNIRITGR+ DPL +SFRMD ASNYRAMQDWVNSV+DPVTGLRALP DVEADIQVNLH R G+PHT++MF GCVPV APEL YE +N+I FDVTFAYR MQTGAVG QAA +WIED+A+N+IT L+ LS LSRL G G V+N+ N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>26</Hit_num> + <Hit_id>gi|311992949|ref|YP_004009816.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Acinetobacter phage Acj61] >gi|295815238|gb|ADG36164.1| gp54 baseplate tail tube initiator [Acinetobacter phage Acj61]</Hit_def> + <Hit_accession>YP_004009816</Hit_accession> + <Hit_len>301</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>381.333</Hsp_bit-score> + <Hsp_score>978</Hsp_score> + <Hsp_evalue>9.23112e-129</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>300</Hsp_query-to> + <Hsp_hit-from>6</Hsp_hit-from> + <Hsp_hit-to>301</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>180</Hsp_identity> + <Hsp_positive>229</Hsp_positive> + <Hsp_gaps>3</Hsp_gaps> + <Hsp_align-len>299</Hsp_align-len> + <Hsp_qseq>LTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITGINSEMSLNGSLSRLSRLGGAAGGLSHV</Hsp_qseq> + <Hsp_hseq>FTLDEFNSQVINADFQRTNMFSMVFATKPNGKTQELLNNVGNSVAEMIPETLDALGVTQGVLTQAITTVITMGSRKIVRKAGVSKVLIGAMTNRVFQSLLGELKVGTYLLDYFNMVFPTSGLMVQAVKIPDNKLNHEMDRLHNSPNIKITGRDFEPLVITFRMDSAAVNYRSMNDWVNSVEDPVTGLRALPSSVEADLQINLHARNGLPHSVVLFTGCVPVGVTSPQLSYEDNNQITTFDVIFAYRTMSMGPVELQAAKEWMEDTAIK--LG-KQAMDPNINLSSHSRLSGSANGIAKL</Hsp_hseq> + <Hsp_midline> TLDEF +Q N DFQRTNMFS VFAT P+ K+Q+LL+ G + +P D LG+TQG T +T++IT G++++VRK+GVSK LIGAM+NRV QSLLGE +VGTYLLD+FNM +P SGLM+ +VKIP+N+L+HEMD HNSPNI+ITGR+ +PL I+FRMD A NYR+M DWVNSV+DPVTGLRALP+ VEAD+Q+NLHARNGLPH+V++FTGCVPV +P+L+YE +NQI FDV FAYR M G V QAA +W+ED A+ G M N +LS SRL G+A G++ +</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>27</Hit_num> + <Hit_id>gi|109290162|ref|YP_656411.1|</Hit_id> + <Hit_def>gp54 base plate-tail tube initiator [Aeromonas phage 25] >gi|104345835|gb|ABF72735.1| gp54 base plate-tail tube initiator [Aeromonas phage 25]</Hit_def> + <Hit_accession>YP_656411</Hit_accession> + <Hit_len>285</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>380.563</Hsp_bit-score> + <Hsp_score>976</Hsp_score> + <Hsp_evalue>1.13007e-128</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>263</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>177</Hsp_identity> + <Hsp_positive>212</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>264</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>MYKLDEFQ-QELNKDFQRTNMFSVVFATTPSSKTTDLLDGFGAYLYNNLPFGKDFAGLTQGMLSSTLNKVIVQGTQNIIRKSGVSKYLIGAMTSRTIQSLLGQFEVGTYLLDFFNAGNTHTGLTVYSVKMPENRLNYEMDKFHNAPNIKLMGREYDPLIISFRMDHQAANYRAMQDWVNAVEDPVTGLRSLPADVEADIQVNLHARDGMPHTVTMFNGCIPVSVSAPELSYEDNNAITTFDVTFAYRVMNTGAVNQAMLEDWLK</Hsp_hseq> + <Hsp_midline>M LDEF+ Q N DFQRTNMFS VFATTPS+K+ LLD FG L+NNLP D+ GLTQG +S L +I GTQ ++RKSGVSKYLIGAM++R +QSLLG+FEVGTYLLDFFN +GL +YSVK+PENRL++EMD HN+PNI++ GRE DPL ISFRMD +A+NYRAMQDWVN+V+DPVTGLR+LP DVEADIQVNLHAR+G+PHTV MF GC+PV+ APEL+YE +N I FDVTFAYRVM TGAV + DW++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>28</Hit_num> + <Hit_id>gi|423262260|ref|YP_007010859.1|</Hit_id> + <Hit_def>base plate-tail tube initiator [Aeromonas phage Aes508] >gi|402762138|gb|AFQ97252.1| base plate-tail tube initiator [Aeromonas phage Aes508]</Hit_def> + <Hit_accession>YP_007010859</Hit_accession> + <Hit_len>285</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>380.563</Hsp_bit-score> + <Hsp_score>976</Hsp_score> + <Hsp_evalue>1.24647e-128</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>263</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>177</Hsp_identity> + <Hsp_positive>212</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>264</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>MYKLDEFQ-QELNKDFQRTNMFSVVFATTPSSKTTDLLDGFGAYLYNNLPFGKDFAGLTQGMLSSTLNKVIVQGTQNIIRKSGVSKYLIGAMTSRTIQSLLGQFEVGTYLLDFFNAGNTHTGLTVYSVKMPENRLNYEMDKFHNAPNIKLMGREYDPLIISFRMDHQAANYRAMQDWVNAVEDPVTGLRSLPADVEADIQVNLHARDGIPHTVTMFNGCIPVSVSAPELSYEDNNAITTFDVTFAYRVMNTGAVNQAMLEDWLK</Hsp_hseq> + <Hsp_midline>M LDEF+ Q N DFQRTNMFS VFATTPS+K+ LLD FG L+NNLP D+ GLTQG +S L +I GTQ ++RKSGVSKYLIGAM++R +QSLLG+FEVGTYLLDFFN +GL +YSVK+PENRL++EMD HN+PNI++ GRE DPL ISFRMD +A+NYRAMQDWVN+V+DPVTGLR+LP DVEADIQVNLHAR+G+PHTV MF GC+PV+ APEL+YE +N I FDVTFAYRVM TGAV + DW++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>29</Hit_num> + <Hit_id>gi|472438118|ref|YP_007677898.1|</Hit_id> + <Hit_def>baseplate-tail tube initiator [Aeromonas phage Aes012] >gi|395653256|gb|AFN69811.1| baseplate-tail tube initiator [Aeromonas phage Aes012]</Hit_def> + <Hit_accession>YP_007677898</Hit_accession> + <Hit_len>285</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>379.407</Hsp_bit-score> + <Hsp_score>973</Hsp_score> + <Hsp_evalue>3.21556e-128</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>263</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>175</Hsp_identity> + <Hsp_positive>212</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>264</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>MYKLDEFQ-QELNKDFQRTNMFSVVFATTPSSKTTDLLDGFGAYLYNNLPFGKDFAGLTQGMLSSTLNKVIVQGTQNIIRKSGISRYLIGAMTSRTIQSLLGQFEVGTYLLDFFNAGNTHTGLTVYSVKMPENRLNYEMDKFHNAPNIKLMGREYDPLIISFRMDHQAANYRAMQDWVNAVEDPVTGLRSLPADVEADIQVNLHARDGMPHTVTMFNGCIPVSVSAPELSYEDNNAITTFDVTFAYRVMHTGAVNQAMLEDWLK</Hsp_hseq> + <Hsp_midline>M LDEF+ Q N DFQRTNMFS VFATTPS+K+ LLD FG L+NNLP D+ GLTQG +S L +I GTQ ++RKSG+S+YLIGAM++R +QSLLG+FEVGTYLLDFFN +GL +YSVK+PENRL++EMD HN+PNI++ GRE DPL ISFRMD +A+NYRAMQDWVN+V+DPVTGLR+LP DVEADIQVNLHAR+G+PHTV MF GC+PV+ APEL+YE +N I FDVTFAYRVM TGAV + DW++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>30</Hit_num> + <Hit_id>gi|401824982|gb|AFQ22672.1|</Hit_id> + <Hit_def>tail assembly protein [Stenotrophomonas phage IME13]</Hit_def> + <Hit_accession>AFQ22672</Hit_accession> + <Hit_len>285</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>377.481</Hsp_bit-score> + <Hsp_score>968</Hsp_score> + <Hsp_evalue>1.7397e-127</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>263</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>173</Hsp_identity> + <Hsp_positive>212</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>264</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>MYKLDEFQ-QELNKDFQRTNMFSVVFATTPSSKTTDLLDGFGAYLYNNLPFGKDFAGLTQGMLSSTLNKVIVQGTQNIIRKSGISRYLIGAMTSRTIQSLLGQFEIGTYLLDFFNAGNTHTGLTVYSVKMPENRLNYEMDKFHNAPNIKLMGREYDPLIISFRMDHQAANYRAMQDWVNAVEDPVTGLRSLPADVEADIQVNLHSRDGMPHTVTMFNGCIPVSVSAPELSYEDNNAITTFDVTFAYRVMHTGAVNQAMLEDWLK</Hsp_hseq> + <Hsp_midline>M LDEF+ Q N DFQRTNMFS VFATTPS+K+ LLD FG L+NNLP D+ GLTQG +S L +I GTQ ++RKSG+S+YLIGAM++R +QSLLG+FE+GTYLLDFFN +GL +YSVK+PENRL++EMD HN+PNI++ GRE DPL ISFRMD +A+NYRAMQDWVN+V+DPVTGLR+LP DVEADIQVNLH+R+G+PHTV MF GC+PV+ APEL+YE +N I FDVTFAYRVM TGAV + DW++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>31</Hit_num> + <Hit_id>gi|37651666|ref|NP_932540.1|</Hit_id> + <Hit_def>baseplate subunit [Aeromonas phage 44RR2.8t] >gi|66391987|ref|YP_238912.1| baseplate tail tube initiator [Aeromonas phage 31] >gi|34732966|gb|AAQ81503.1| baseplate tail tube initiator [Aeromonas phage 44RR2.8t] >gi|62114824|gb|AAX63672.1| gp54 [Aeromonas phage 31]</Hit_def> + <Hit_accession>NP_932540</Hit_accession> + <Hit_len>285</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>373.244</Hsp_bit-score> + <Hsp_score>957</Hsp_score> + <Hsp_evalue>9.89077e-126</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>263</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>174</Hsp_identity> + <Hsp_positive>210</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>264</Hsp_align-len> + <Hsp_qseq>MLTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>MYRLDEFQ-QELNKDFQRSNMFSVVFATTPSSKTTELLDGFGGFLYNNLPFGKDFAGLTQGMISSSLNKIIVQGTQSVMRSSGVSKYLIGAMTSRTVQSILGQFEVGTYLLDFFNAGNTHTGLTVYSVQMPENRLGYEMDKFHNAPNIKLMGREYDPLVISFRMDHQASNYRAMQDWVNAVEDPVTGLRSLPADVEADIQINLHARDGIPHTVTMFGGCIPVAVSSPELSYEDNNTITTFNVTFAYRVMSVGAVNMAMVDDWLK</Hsp_hseq> + <Hsp_midline>M LDEF+ Q N DFQR+NMFS VFATTPS+K+ +LLD FGG L+NNLP D+ GLTQG +S L II GTQ ++R SGVSKYLIGAM++R VQS+LG+FEVGTYLLDFFN +GL +YSV++PENRL +EMD HN+PNI++ GRE DPL ISFRMD +ASNYRAMQDWVN+V+DPVTGLR+LP DVEADIQ+NLHAR+G+PHTV MF GC+PVA +PEL+YE +N I F+VTFAYRVM GAV DW++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>32</Hit_num> + <Hit_id>gi|392973131|ref|YP_006489089.1|</Hit_id> + <Hit_def>baseplate tail tube initiator [Acinetobacter phage ZZ1] >gi|390058272|gb|AFL47726.1| baseplate tail tube initiator [Acinetobacter phage ZZ1]</Hit_def> + <Hit_accession>YP_006489089</Hit_accession> + <Hit_len>296</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>353.214</Hsp_bit-score> + <Hsp_score>905</Hsp_score> + <Hsp_evalue>9.8716e-118</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>273</Hsp_query-to> + <Hsp_hit-from>8</Hsp_hit-from> + <Hsp_hit-to>279</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>162</Hsp_identity> + <Hsp_positive>207</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>272</Hsp_align-len> + <Hsp_qseq>LTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAVNSITG</Hsp_qseq> + <Hsp_hseq>FTLDEFNNQIGNFDFQRTNMFSMHFATRPASKSQEYLGTISQKSNDSIMSTLEAMGVTNDSIQNAIASIITIGTQKIVRKSGVTKILMGAMTNRVVQSLLGELKVGTYLLDYFDQAFPTSGLMVQSCKIPDNHLNYEMDRQHNAPNIKITGRDFEPLVITFRMDATASNHRAMNDWVNAVEDPITGLRALPIDVEADIQINLHNRKGYPHTAYMFSGCIPMIVGGPQVSYEDNNQITTFDVTFAYRSMQAGAVGLEAARAWMEDTTIDISKG</Hsp_hseq> + <Hsp_midline> TLDEF NQ GN DFQRTNMFS FAT P++KSQ+ L +++ + +G+T + + SIIT GTQ++VRKSGV+K L+GAM+NRVVQSLLGE +VGTYLLD+F+ A+P SGLM+ S KIP+N L++EMD HN+PNI+ITGR+ +PL I+FRMD ASN+RAM DWVN+V+DP+TGLRALP DVEADIQ+NLH R G PHT MF+GC+P+ G P+++YE +NQI FDVTFAYR MQ GAVG +AA W+ED ++ G</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>33</Hit_num> + <Hit_id>gi|311993475|ref|YP_004010340.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Acinetobacter phage Acj9] >gi|295917432|gb|ADG60103.1| gp54 baseplate tail tube initiator [Acinetobacter phage Acj9]</Hit_def> + <Hit_accession>YP_004010340</Hit_accession> + <Hit_len>294</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>343.969</Hsp_bit-score> + <Hsp_score>881</Hsp_score> + <Hsp_evalue>3.7432e-114</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>268</Hsp_query-to> + <Hsp_hit-from>8</Hsp_hit-from> + <Hsp_hit-to>274</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>155</Hsp_identity> + <Hsp_positive>202</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>267</Hsp_align-len> + <Hsp_qseq>LTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIEDRAV</Hsp_qseq> + <Hsp_hseq>LTLDEFGSQVANNDFQRTNLFSMYFATKPASKSQQYLGTISNKYEDSIAGTLEAMGVTDAGLQNIITSTVTIGAQKVIRKAGVEKILMGAMSNRVVQSLLGELNVGTYLLEFLESIFPTSGLMVQSCKIPDNHLNYEMDRQHNAPNIKLMGRDFEPLVITFRMDSDAANHRAMNDWVNSVEDPVTGLRALPIDVEADIQINLHKRNGLPHTAYMFSGCIPVIVGGPQVSYEDNNQITTFDMTFAYRTMSSGAVSETAAKEWMEDKAI</Hsp_hseq> + <Hsp_midline>LTLDEF +Q N DFQRTN+FS FAT P++KSQQ L +++ + +G+T + +TS +T G Q+++RK+GV K L+GAMSNRVVQSLLGE VGTYLL+F +P SGLM+ S KIP+N L++EMD HN+PNI++ GR+ +PL I+FRMD +A+N+RAM DWVNSV+DPVTGLRALP DVEADIQ+NLH RNGLPHT MF+GC+PV G P+++YE +NQI FD+TFAYR M +GAV AA +W+ED+A+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>34</Hit_num> + <Hit_id>gi|311992693|ref|YP_004009561.1|</Hit_id> + <Hit_def>gp54 baseplate-tail tube initiator protein [Acinetobacter phage Ac42] >gi|298684476|gb|ADI96437.1| gp54 baseplate-tail tube initiator protein [Acinetobacter phage Ac42]</Hit_def> + <Hit_accession>YP_004009561</Hit_accession> + <Hit_len>282</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>295.434</Hsp_bit-score> + <Hsp_score>755</Hsp_score> + <Hsp_evalue>2.8435e-95</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>263</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>266</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>146</Hsp_identity> + <Hsp_positive>189</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>266</Hsp_align-len> + <Hsp_qseq>LTLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSG---VSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQ-SGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWI</Hsp_qseq> + <Hsp_hseq>FSFEEF-GQIVNQDFQRSNMFSVVFATTPLSRADQLMSQYSNISYVD-ELSSTEFSWARPERKQSLIDRLGIKLPRLSKQSNSTQVSKYLIGAMTERVVQSLLGEFNVGTNLLEFFDMNNTKDSGLLAYAVKLPENRLNHEMDITHNAPSVKIIGREFDVLTISFRMAPDALNYIAFNDWVNSVEDPVTGLKALPIDVEADIQVNLHNRRGLPHTTAMLSGCIPISVGSPDLSYENDNQITTFDVTFAYRTMQIGQIKQADAEAWV</Hsp_hseq> + <Hsp_midline> + +EF Q N DFQR+NMFS VFATTP +++ QL+ Q+ + + + L++ + E L + +L ++S VSKYLIGAM+ RVVQSLLGEF VGT LL+FF+M + SGL+ Y+VK+PENRL+HEMD HN+P+++I GRE D LTISFRM P+A NY A DWVNSV+DPVTGL+ALP DVEADIQVNLH R GLPHT M +GC+P++ G+P+L+YE DNQI FDVTFAYR MQ G + + A W+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>35</Hit_num> + <Hit_id>gi|326536337|ref|YP_004300778.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Acinetobacter phage 133] >gi|299483418|gb|ADJ19512.1| gp54 baseplate tail tube initiator [Acinetobacter phage 133]</Hit_def> + <Hit_accession>YP_004300778</Hit_accession> + <Hit_len>276</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>272.322</Hsp_bit-score> + <Hsp_score>695</Hsp_score> + <Hsp_evalue>2.61741e-86</Hsp_evalue> + <Hsp_query-from>4</Hsp_query-from> + <Hsp_query-to>263</Hsp_query-to> + <Hsp_hit-from>5</Hsp_hit-from> + <Hsp_hit-to>257</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>133</Hsp_identity> + <Hsp_positive>181</Hsp_positive> + <Hsp_gaps>9</Hsp_gaps> + <Hsp_align-len>261</Hsp_align-len> + <Hsp_qseq>LDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQ-SGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWI</Hsp_qseq> + <Hsp_hseq>IESFASQV-RTDFQRTNLFSVMFATTPLSRADELMRKYNATEPDAV-LTGDF-GWTRDNSHPSLPRMQTDSSVQTSLK-----YIIGAMTERVMQTLVGRYTVGKHLLEFFGMNKTQESGLSVFAVKLPENRLAHEMDLTHNAPNIKVTGREFDTLVVSFRMAHDGLNFIAMHDWVNAVEDPVTGLKALPIDVESDIQVNLHGRDGLPHTVAMIGGCIPVSVSAPELSYESDNTFSTFDVTFAYRTMQMSKVSRAEAMNWI</Hsp_hseq> + <Hsp_midline>++ F +Q DFQRTN+FS +FATTP +++ +L+ ++ + + L D+ G T+ L + T + Q K Y+IGAM+ RV+Q+L+G + VG +LL+FF M Q SGL +++VK+PENRL+HEMD HN+PNI++TGRE D L +SFRM + N+ AM DWVN+V+DPVTGL+ALP DVE+DIQVNLH R+GLPHTV M GC+PV+ APEL+YE DN + FDVTFAYR MQ V R A++WI</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>36</Hit_num> + <Hit_id>gi|310722274|ref|YP_003969098.1|</Hit_id> + <Hit_def>unnamed protein product [Aeromonas phage phiAS4] >gi|306021117|gb|ADM79652.1| baseplate tail tube initiator [Aeromonas phage phiAS4]</Hit_def> + <Hit_accession>YP_003969098</Hit_accession> + <Hit_len>195</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>266.544</Hsp_bit-score> + <Hsp_score>680</Hsp_score> + <Hsp_evalue>3.48018e-85</Hsp_evalue> + <Hsp_query-from>92</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>173</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>118</Hsp_identity> + <Hsp_positive>145</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>173</Hsp_align-len> + <Hsp_qseq>MSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>MTSRTIQSLLGQFEVGTYLLDFFNAGNTHTGLTVYSVKMPENRLNYEMDKFHNAPNIKLMGREYDPLIISFRMDHQAANYRAMQDWVNAVEDPVTGLRSLPADVEADIQVNLHSRDGIPHTVTMFNGCIPVSVSAPELSYEDNNAITTFDVTFAYRVMNTGAVNQAMLEDWLK</Hsp_hseq> + <Hsp_midline>M++R +QSLLG+FEVGTYLLDFFN +GL +YSVK+PENRL++EMD HN+PNI++ GRE DPL ISFRMD +A+NYRAMQDWVN+V+DPVTGLR+LP DVEADIQVNLH+R+G+PHTV MF GC+PV+ APEL+YE +N I FDVTFAYRVM TGAV + DW++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>37</Hit_num> + <Hit_id>gi|66391557|ref|YP_239082.1|</Hit_id> + <Hit_def>gp54 baseplate-tail tube initiator [Enterobacteria phage RB43] >gi|62288645|gb|AAX78628.1| gp54 baseplate-tail tube initiator [Enterobacteria phage RB43] >gi|406718847|emb|CCL97572.1| protein of unknown function [Enterobacteria phage RB43] >gi|415434115|emb|CCK73955.1| protein of unknown function [Enterobacteria phage RB43]</Hit_def> + <Hit_accession>YP_239082</Hit_accession> + <Hit_len>287</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>161.77</Hsp_bit-score> + <Hsp_score>408</Hsp_score> + <Hsp_evalue>1.63718e-43</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>4</Hsp_hit-from> + <Hsp_hit-to>253</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>90</Hsp_identity> + <Hsp_positive>146</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>254</Hsp_align-len> + <Hsp_qseq>TLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNL------PLNNDWLGLTQGEFTSGLTSIITAGTQQLV---RKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>SVDEFLSGMANKDFQRSNLFSVVFATSPASR---ILDSTIGSIRDTLIDGTMSSINANNPNEFMNAITGGVSKLFSYTVDKAIMSLNKTGFSK-IMGALSPRLVTSLFGDSVYGQLLTEFRDKMMYNMGLSIVGVQLPGKTLGYEYVYNGGVPQIRFTRPENGELSLTFRVDSEARNLKVFNEWISAIRDDITGQFAFIDEVSSAIQVNLHNRDGVPHSTYIFQKCLPVKVSSPELSYETNNEIWTFTVDFAYK</Hsp_hseq> + <Hsp_midline>++DEF + N DFQR+N+FS VFAT+P+++ +LD G + + L +N + T G++ + + + + K+G SK ++GA+S R+V SL G+ G L +F + GL I V++P L +E +N P IR T E L+++FR+D EA N + +W+++++D +TG A +V + IQVNLH R+G+PH+ +F C+PV +PEL+YE +N+I F V FAY+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>38</Hit_num> + <Hit_id>gi|304373652|ref|YP_003858397.1|</Hit_id> + <Hit_def>gp54 baseplate-tail tube initiator [Enterobacteria phage RB16] >gi|299829608|gb|ADJ55401.1| gp54 baseplate-tail tube initiator [Enterobacteria phage RB16]</Hit_def> + <Hit_accession>YP_003858397</Hit_accession> + <Hit_len>287</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>160.229</Hsp_bit-score> + <Hsp_score>404</Hsp_score> + <Hsp_evalue>6.9702e-43</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>4</Hsp_hit-from> + <Hsp_hit-to>253</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>90</Hsp_identity> + <Hsp_positive>145</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>254</Hsp_align-len> + <Hsp_qseq>TLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNL------PLNNDWLGLTQGEFTSGLTSIITAGTQQLV---RKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>SVDEFLSGMANNDFQRSNLFSVVFATSPASR---ILDSTIGSIRDTLIDGTMSSINANNPNEFMNAITGGVRKLFSYTVDKAIMSLNKTGFSK-IMGALSPRLVTSLFGDSVYGQLLTEFRDKMMYNMGLSIVGVQLPGKTLGYEYVYNGGVPQIRFTRPENGELSLTFRVDSEARNLKVFNEWISAIRDDITGQFAFIDEVSSAIQVNLHNRDGVPHSTYIFQKCLPVKVSSPELSYETNNEIWTFTVDFAYK</Hsp_hseq> + <Hsp_midline>++DEF + N DFQR+N+FS VFAT+P+++ +LD G + + L +N + T G+ + + + + K+G SK ++GA+S R+V SL G+ G L +F + GL I V++P L +E +N P IR T E L+++FR+D EA N + +W+++++D +TG A +V + IQVNLH R+G+PH+ +F C+PV +PEL+YE +N+I F V FAY+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>39</Hit_num> + <Hit_id>gi|509141760|ref|YP_008060625.1|</Hit_id> + <Hit_def>baseplate-tail tube initiator [Escherichia phage Lw1] >gi|479258587|gb|AGJ71510.1| baseplate-tail tube initiator [Escherichia phage Lw1]</Hit_def> + <Hit_accession>YP_008060625</Hit_accession> + <Hit_len>287</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>159.073</Hsp_bit-score> + <Hsp_score>401</Hsp_score> + <Hsp_evalue>1.48333e-42</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>4</Hsp_hit-from> + <Hsp_hit-to>253</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>89</Hsp_identity> + <Hsp_positive>145</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>254</Hsp_align-len> + <Hsp_qseq>TLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNL------PLNNDWLGLTQGEFTSGLTSIITAGTQQLV---RKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>SVDEFLSGMANRDFQRSNLFSVVFATSPASR---ILDSTIGSIRDTLIDGTMSSINANNPNEFMNAITGGVRKLFSYTVDKAIMSLNKTGFSK-IMGALSPRLITSLFGDSVYGQLLTEFRDKMMYNMGLSIVGVQLPGKTLGYEYVYNGGVPQIRFTRPENGELSLTFRVDSEARNLKVFNEWMSAIRDDITGQFAFIDEVSSAIQVNLHNRDGVPHSTYVFQKCLPVKVSSPELSYENNNEIWTFTVDFAYK</Hsp_hseq> + <Hsp_midline>++DEF + N DFQR+N+FS VFAT+P+++ +LD G + + L +N + T G+ + + + + K+G SK ++GA+S R++ SL G+ G L +F + GL I V++P L +E +N P IR T E L+++FR+D EA N + +W+++++D +TG A +V + IQVNLH R+G+PH+ +F C+PV +PEL+YE +N+I F V FAY+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>40</Hit_num> + <Hit_id>gi|414086184|ref|YP_006986374.1|</Hit_id> + <Hit_def>baseplate-tail tube initiator [Cronobacter phage vB_CsaM_GAP161] >gi|378566509|gb|AFC22205.1| baseplate-tail tube initiator [Cronobacter phage vB_CsaM_GAP161]</Hit_def> + <Hit_accession>YP_006986374</Hit_accession> + <Hit_len>287</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>158.303</Hsp_bit-score> + <Hsp_score>399</Hsp_score> + <Hsp_evalue>3.02584e-42</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>4</Hsp_hit-from> + <Hsp_hit-to>253</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>89</Hsp_identity> + <Hsp_positive>145</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>254</Hsp_align-len> + <Hsp_qseq>TLDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNL------PLNNDWLGLTQGEFTSGLTSIITAGTQQLV---RKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>SVDEFLSGMANRDFQRSNLFSVVFATSPASR---ILDSTIGSIRDTLIDGTMSSINANNPNEFMNAITGGVSKLFSYTVDKAIMSLNKTGFSK-IMGALSPRLITSLFGDSVYGQMLTEFRDKMMYNMGLSIVGVQLPGKTLGYEYVYNGGVPQIRFTRPENGELSLTFRVDSEARNLKVFNEWLSAIRDDVSGQFAFIDEVSSAIQVNLHNRDGVPHSTYVFQKCLPVKVSNPELSYESNNEIWTFTVDFAYK</Hsp_hseq> + <Hsp_midline>++DEF + N DFQR+N+FS VFAT+P+++ +LD G + + L +N + T G++ + + + + K+G SK ++GA+S R++ SL G+ G L +F + GL I V++P L +E +N P IR T E L+++FR+D EA N + +W+++++D V+G A +V + IQVNLH R+G+PH+ +F C+PV PEL+YE +N+I F V FAY+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>41</Hit_num> + <Hit_id>gi|448260647|ref|YP_007348741.1|</Hit_id> + <Hit_def>baseplate-tail tube initiator [Klebsiella phage KP27] >gi|370343456|gb|AEX26585.1| baseplate-tail tube initiator [Klebsiella phage KP27]</Hit_def> + <Hit_accession>YP_007348741</Hit_accession> + <Hit_len>287</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>154.836</Hsp_bit-score> + <Hsp_score>390</Hsp_score> + <Hsp_evalue>5.9168e-41</Hsp_evalue> + <Hsp_query-from>4</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>5</Hsp_hit-from> + <Hsp_hit-to>253</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>91</Hsp_identity> + <Hsp_positive>140</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>254</Hsp_align-len> + <Hsp_qseq>LDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNL------PLN----NDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>VDEFLSGMANRDFQRSNLFSVVFATSPASR---ILDNTIGSIRDTLIDGSISSINANNPNEFINAITGGVSKLFSYTVDKAIMSL-NKTGFSK-IIGAISPRLITSLFGDSMYGQLLAEFRDKMMYNMGLSIMGVNLPGKSIGYEYVYNGGVPQIRFTRPENGELSLTFRTDSEARNLKIFNEWISAIRDDVTGQYAFIDEVTSTIQVNLHDRDGSPHTTYVFQKCLPVKISNSELSYENNNEIWTFTVDFAYK</Hsp_hseq> + <Hsp_midline>+DEF + N DFQR+N+FS VFAT+P+++ +LD G + + L +N N+++ G + + + L K+G SK +IGA+S R++ SL G+ G L +F + GL I V +P + +E +N P IR T E L+++FR D EA N + +W+++++D VTG A +V + IQVNLH R+G PHT +F C+PV EL+YE +N+I F V FAY+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>42</Hit_num> + <Hit_id>gi|294661513|ref|YP_003579966.1|</Hit_id> + <Hit_def>gp54 baseplate subunit [Klebsiella phage KP15] >gi|292660674|gb|ADE34922.1| gp54 baseplate subunit [Klebsiella phage KP15]</Hit_def> + <Hit_accession>YP_003579966</Hit_accession> + <Hit_len>288</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>154.066</Hsp_bit-score> + <Hsp_score>388</Hsp_score> + <Hsp_evalue>1.15825e-40</Hsp_evalue> + <Hsp_query-from>4</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>6</Hsp_hit-from> + <Hsp_hit-to>254</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>91</Hsp_identity> + <Hsp_positive>140</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>254</Hsp_align-len> + <Hsp_qseq>LDEFKNQAGNIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNL------PLN----NDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVSKYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQSGLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>VDEFLSGMANRDFQRSNLFSVVFATSPASR---ILDNTIGSIRDTLIDGSISSINANNPNEFINAITGGVSKLFSYTVDKAIMSL-NKTGFSK-IIGAISPRLITSLFGDSMYGQLLSEFRDEMMYNMGLSIMGVNLPGKSIGYEYVYNGGVPQIRFTRPENGELSLTFRTDSEARNLKIFNEWISAIRDDVTGQYAFIDEVTSTIQVNLHDRDGSPHTTYVFQKCLPVKISNSELSYENNNEIWTFTVDFAYK</Hsp_hseq> + <Hsp_midline>+DEF + N DFQR+N+FS VFAT+P+++ +LD G + + L +N N+++ G + + + L K+G SK +IGA+S R++ SL G+ G L +F + GL I V +P + +E +N P IR T E L+++FR D EA N + +W+++++D VTG A +V + IQVNLH R+G PHT +F C+PV EL+YE +N+I F V FAY+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>43</Hit_num> + <Hit_id>gi|593773990|ref|YP_009011613.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Aeromonas phage PX29] >gi|312262608|gb|ADQ52903.1| gp54 baseplate tail tube initiator [Aeromonas phage PX29]</Hit_def> + <Hit_accession>YP_009011613</Hit_accession> + <Hit_len>329</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>78.9518</Hsp_bit-score> + <Hsp_score>193</Hsp_score> + <Hsp_evalue>1.4396e-13</Hsp_evalue> + <Hsp_query-from>13</Hsp_query-from> + <Hsp_query-to>276</Hsp_query-to> + <Hsp_hit-from>56</Hsp_hit-from> + <Hsp_hit-to>328</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>76</Hsp_identity> + <Hsp_positive>120</Hsp_positive> + <Hsp_gaps>33</Hsp_gaps> + <Hsp_align-len>285</Hsp_align-len> + <Hsp_qseq>NIDFQRTNMFSCVFATTPS-AKSQQLLDQFGGMLFNNLPLNN------DWLGLTQGEFTSGLTSIITAGTQQLVRKSGVS------KYLIGAMSNRVVQSLLGEFEVGTYLLD-FFNMAYPQS---GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVM-QTGAVGRQAALDWIE---DRAVNSITGINS</Hsp_qseq> + <Hsp_hseq>NKDLARANTFLVRFGDFRSVAASDGILNHLG-------PLGDVIGGVGDAINKSTGGFFGG-TSFQWHRIQDIAMNQGKKLLSPKIKNIMGAIDPTLVRMIPGAGE----LLDGFLGSDYDVNRDLALMVKSVNLPGTNFDTQVNYNERKPFTEVRNRSVDNIRMTFYCSSDYAERIWFLTWMNSIHNPKNGTFGFYSNYARDIDIVTLNRRGVMTSVVHSDGCFPVHVGDVQLDYENNNQIATFEVEFTVSTMTQAAHAGKDNLVNSVESFYNRAKGMIRGIKN</Hsp_hseq> + <Hsp_midline>N D R N F F S A S +L+ G PL + D + + G F G TS Q + G K ++GA+ +V+ + G E LLD F Y + LM+ SV +P ++++N P + R +D + ++F + + W+NS+ +P G ++ DI + R G+ +V+ GC PV G +L YE +NQIA F+V F M Q G+ ++ +E +RA I GI +</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>44</Hit_num> + <Hit_id>gi|38640122|ref|NP_944078.1|</Hit_id> + <Hit_def>gp54 baseplate tail tube initiator [Aeromonas phage Aeh1] >gi|33414812|gb|AAQ17855.1| gp54 baseplate tail tube initiator [Aeromonas phage Aeh1]</Hit_def> + <Hit_accession>NP_944078</Hit_accession> + <Hit_len>331</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>73.9442</Hsp_bit-score> + <Hsp_score>180</Hsp_score> + <Hsp_evalue>9.24146e-12</Hsp_evalue> + <Hsp_query-from>13</Hsp_query-from> + <Hsp_query-to>274</Hsp_query-to> + <Hsp_hit-from>58</Hsp_hit-from> + <Hsp_hit-to>328</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>69</Hsp_identity> + <Hsp_positive>113</Hsp_positive> + <Hsp_gaps>19</Hsp_gaps> + <Hsp_align-len>276</Hsp_align-len> + <Hsp_qseq>NIDFQRTNMFSCVFATTPSAKSQQLLDQFGGMLFNNLPLNNDWLGLTQGEFTSGLTSIITAGTQQLVRKSGVS------KYLIGAMSNRVVQSLLGEFEVGTYLLD-FFNMAYPQS---GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVM-QTGAVGRQAALDWIE---DRAVNSITGI</Hsp_qseq> + <Hsp_hseq>NKDLARANTFLVRFGDFKSVASADGILGHLGPLGETIGGIGDAINKSTGGFFGG-TSFQWHRIQDIAMNQGKKLLSPKIKNIMGAIDPTLVRMIPGAGE----LLDGFLGSDYDVNRDLALMVKSVNLPGVSFDTQTNYNERKPFTEVRNRTVDPIRMTFYCSSDYAERIWFLTWMNSIHNPKKGTFGFYSNYARDIDIVTLNRRGVMTSVVHSDGCFPTRVGEVQLDFENNNQVATFEVEFTVSTMIHAEHAGKDNLINSVESFYNRAKGMVRGI</Hsp_hseq> + <Hsp_midline>N D R N F F S S + G L + D + + G F G TS Q + G K ++GA+ +V+ + G E LLD F Y + LM+ SV +P + ++N P + R +DP+ ++F + + W+NS+ +P G ++ DI + R G+ +V+ GC P G +L +E +NQ+A F+V F M G+ ++ +E +RA + GI</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>45</Hit_num> + <Hit_id>gi|310722793|ref|YP_003969616.1|</Hit_id> + <Hit_def>unnamed protein product [Aeromonas phage phiAS5] >gi|306021636|gb|ADM80170.1| baseplate tail tube initiator [Aeromonas phage phiAS5]</Hit_def> + <Hit_accession>YP_003969616</Hit_accession> + <Hit_len>323</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>70.0922</Hsp_bit-score> + <Hsp_score>170</Hsp_score> + <Hsp_evalue>2.13981e-10</Hsp_evalue> + <Hsp_query-from>86</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>128</Hsp_hit-from> + <Hsp_hit-to>307</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>46</Hsp_identity> + <Hsp_positive>83</Hsp_positive> + <Hsp_gaps>9</Hsp_gaps> + <Hsp_align-len>184</Hsp_align-len> + <Hsp_qseq>KYLIGAMSNRVVQSLLGEFEVGTYLLD-FFNMAYPQS---GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYRVM-QTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>KNIMGAIDPTIVRMIPGAGE----LMDGFLGTGYDVNRDLALMVKSVTLPGTGFETQTNINERTPFTEVRSRTVDPIRMTFYCSPDYAERIWFLTWMGSIHNQKKGTFGFYHNYARDIDIVTLNRRGVMTSVVHSEGCFPTRVGEVQLDFENNNQVATFEVEFTVSTMTQAAHAGKDNLINSVE</Hsp_hseq> + <Hsp_midline>K ++GA+ +V+ + G E L+D F Y + LM+ SV +P + + N +P + R +DP+ ++F P+ + W+ S+ + G + DI + R G+ +V+ GC P G +L +E +NQ+A F+V F M Q G+ ++ +E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>46</Hit_num> + <Hit_id>gi|423261834|ref|YP_007010370.1|</Hit_id> + <Hit_def>baseplate-tail tube initiator [Aeromonas phage CC2] >gi|394778355|gb|AFN39562.1| baseplate-tail tube initiator [Aeromonas phage CC2]</Hit_def> + <Hit_accession>YP_007010370</Hit_accession> + <Hit_len>318</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>68.5514</Hsp_bit-score> + <Hsp_score>166</Hsp_score> + <Hsp_evalue>6.9619e-10</Hsp_evalue> + <Hsp_query-from>86</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>125</Hsp_hit-from> + <Hsp_hit-to>304</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>47</Hsp_identity> + <Hsp_positive>80</Hsp_positive> + <Hsp_gaps>7</Hsp_gaps> + <Hsp_align-len>183</Hsp_align-len> + <Hsp_qseq>KYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQS---GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR-VMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>KKIFGAWDPSLIRIIPGAGEI---LDGFLGTDYDVNRDLALMVKSVGLPSSTLETTINRTDKLPRHEVRGRNYGTMSMTFYCSPSYEERSLMLTWQNTIVNPRNGQFGFYNTYAKDIDVITLDRHGVKQSTVHNTGCFPIEVGEVQLDFENNSQVATFTVTFAVSTTVHVPTKGEENGIDSIE</Hsp_hseq> + <Hsp_midline>K + GA +++ + G E+ L F Y + LM+ SV +P + L ++ P + GR ++++F P M W N++ +P G DI V R+G+ + + TGC P+ G +L +E ++Q+A F VTFA + G + +D IE</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>47</Hit_num> + <Hit_id>gi|326536523|ref|YP_004300954.1|</Hit_id> + <Hit_def>gp54 baseplate-tail tube initiator [Aeromonas phage 65] >gi|312262869|gb|ADQ53125.1| gp54 baseplate-tail tube initiator [Aeromonas phage 65]</Hit_def> + <Hit_accession>YP_004300954</Hit_accession> + <Hit_len>315</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>66.2402</Hsp_bit-score> + <Hsp_score>160</Hsp_score> + <Hsp_evalue>4.67582e-09</Hsp_evalue> + <Hsp_query-from>86</Hsp_query-from> + <Hsp_query-to>264</Hsp_query-to> + <Hsp_hit-from>122</Hsp_hit-from> + <Hsp_hit-to>301</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>47</Hsp_identity> + <Hsp_positive>79</Hsp_positive> + <Hsp_gaps>7</Hsp_gaps> + <Hsp_align-len>183</Hsp_align-len> + <Hsp_qseq>KYLIGAMSNRVVQSLLGEFEVGTYLLDFFNMAYPQS---GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAY-RVMQTGAVGRQAALDWIE</Hsp_qseq> + <Hsp_hseq>KKIFGAWDPSLIRIIPG---AGDILDGFLGTDYDVNKDLALMVKSVGLPSSTLETTINRIDKLPRHEVKGRNYGTMTMTFYCSPGYEERSLMLTWQNTIVNPNNGRFGFYQQYAKPIDVITLDRHGVKRSTVHNTGCFPIEVGEVQLDFENNSQVATFTVTFAVATTVHVPTQGKETGIDSIE</Hsp_hseq> + <Hsp_midline>K + GA +++ + G G L F Y + LM+ SV +P + L ++ P + GR +T++F P M W N++ +P G I V R+G+ + + TGC P+ G +L +E ++Q+A F VTFA + G++ +D IE</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>48</Hit_num> + <Hit_id>gi|34419563|ref|NP_899576.1|</Hit_id> + <Hit_def>gp19 [Vibrio phage KVP40] >gi|34333244|gb|AAQ64399.1| gp19 [Vibrio phage KVP40]</Hit_def> + <Hit_accession>NP_899576</Hit_accession> + <Hit_len>248</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>52.373</Hsp_bit-score> + <Hsp_score>124</Hsp_score> + <Hsp_evalue>9.87211e-05</Hsp_evalue> + <Hsp_query-from>122</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>81</Hsp_hit-from> + <Hsp_hit-to>206</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>27</Hsp_identity> + <Hsp_positive>54</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>126</Hsp_align-len> + <Hsp_qseq>GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>GMMVKSVNIPGSSYETDVDKTRRKPHHVVKAKTDETVTMSLYLSPTHPERKMLLGWFKQIYSNDSAQVGFFSNYARTIEIYTYNRNAEMVTMTSLKNAYPIRVGGVQLGYENNNAVAEFEVEFVYE</Hsp_hseq> + <Hsp_midline>G+M+ SV IP + ++D P+ + + + +T+S + P + + W + + ++ I++ + RN T+ P+ G +L YE +N +A F+V F Y </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>49</Hit_num> + <Hit_id>gi|394774889|gb|AFN37561.1|</Hit_id> + <Hit_def>phage baseplate-tail tube initiator [Vibriophage phi-pp2]</Hit_def> + <Hit_accession>AFN37561</Hit_accession> + <Hit_len>248</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>52.373</Hsp_bit-score> + <Hsp_score>124</Hsp_score> + <Hsp_evalue>0.000105334</Hsp_evalue> + <Hsp_query-from>122</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>81</Hsp_hit-from> + <Hsp_hit-to>206</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>27</Hsp_identity> + <Hsp_positive>54</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>126</Hsp_align-len> + <Hsp_qseq>GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>GMMVKSVNIPGSSYETDVDKTRRKPHHVVKAKTDETVTMSLYLSPTHPERKMLLGWFKQIYSNDSAQVGFFSNYARTIEIYTYNRNAEMVTMTSLKNAYPIRVGGVQLGYENNNAVAEFEVEFVYE</Hsp_hseq> + <Hsp_midline>G+M+ SV IP + ++D P+ + + + +T+S + P + + W + + ++ I++ + RN T+ P+ G +L YE +N +A F+V F Y </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>50</Hit_num> + <Hit_id>gi|514050755|ref|YP_008125529.1|</Hit_id> + <Hit_def>hypothetical protein VPFG_00383 [Vibrio phage nt-1] >gi|509419912|gb|AGN30380.1| baseplate tail tube initiator [Vibrio phage nt-1]</Hit_def> + <Hit_accession>YP_008125529</Hit_accession> + <Hit_len>248</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>50.447</Hsp_bit-score> + <Hsp_score>119</Hsp_score> + <Hsp_evalue>0.000428314</Hsp_evalue> + <Hsp_query-from>122</Hsp_query-from> + <Hsp_query-to>247</Hsp_query-to> + <Hsp_hit-from>81</Hsp_hit-from> + <Hsp_hit-to>206</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>26</Hsp_identity> + <Hsp_positive>53</Hsp_positive> + <Hsp_gaps>0</Hsp_gaps> + <Hsp_align-len>126</Hsp_align-len> + <Hsp_qseq>GLMIYSVKIPENRLSHEMDFNHNSPNIRITGRELDPLTISFRMDPEASNYRAMQDWVNSVQDPVTGLRALPTDVEADIQVNLHARNGLPHTVIMFTGCVPVACGAPELTYEGDNQIAVFDVTFAYR</Hsp_qseq> + <Hsp_hseq>GMMVKSVNLPGSSYETDVDKTRRRPHHVVKAKTDETVTMSLYLSPSHPERKMLMGWFKQIYSNDSAQVGFFANYARTIEIYTYDRNSNMATMTSLKNAFPIRVGGVQLGYENNNAVAEFEVEFVYE</Hsp_hseq> + <Hsp_midline>G+M+ SV +P + ++D P+ + + + +T+S + P + + W + + + I++ + RN T+ P+ G +L YE +N +A F+V F Y </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +</Iteration_hits> + <Iteration_stat> + <Statistics> + <Statistics_db-num>48094830</Statistics_db-num> + <Statistics_db-len>17186091396</Statistics_db-len> + <Statistics_hsp-len>147</Statistics_hsp-len> + <Statistics_eff-space>1689397281462</Statistics_eff-space> + <Statistics_kappa>0.041</Statistics_kappa> + <Statistics_lambda>0.267</Statistics_lambda> + <Statistics_entropy>0.14</Statistics_entropy> + </Statistics> + </Iteration_stat> +</Iteration> +<Iteration> + <Iteration_iter-num>4</Iteration_iter-num> + <Iteration_query-ID>Query_4</Iteration_query-ID> + <Iteration_query-def>Merlin_4</Iteration_query-def> + <Iteration_query-len>351</Iteration_query-len> +<Iteration_hits> +<Hit> + <Hit_num>1</Hit_num> + <Hit_id>gi|456351276|ref|YP_007501228.1|</Hit_id> + <Hit_def>baseplate subunit [Salmonella phage S16] >gi|347466341|gb|AEO97127.1| baseplate subunit [Salmonella phage S16]</Hit_def> + <Hit_accession>YP_007501228</Hit_accession> + <Hit_len>350</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>590.882</Hsp_bit-score> + <Hsp_score>1522</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>5</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>350</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>291</Hsp_identity> + <Hsp_positive>319</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>348</Hsp_align-len> + <Hsp_qseq>VRELDDKTDALIS-GVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>VKELKDTAKELWNKGEKISAGQSSQSSKIKSTVTVQYPSERSAGNDVTGNLRVHDLYKNGLLFTAYDMNSRTSGDMRNMRLGELRRTSQDIVKSVTGKNTKQVDKIPVANILLPRSKSDVDSTSHKFNDVADSLISRGGGTATGVLSNVASTAVFGALESVTQGLMADNNEQIYNTARSMYAGADNRTKVFTWDLTPRSVHDLIAIVEIYEYFNYYSYGETGNSTFAKEVKSTLDEWYKSTFLDTLTPTGAPQNDTVFEKITSFLSNVIVVSNPTVWYVRNFGNTSKFDGKTDIFGPCQIQSIRFDKTPNGVFNGLAVAPNLPSTFTLEITMREILTLNRSSIYSEGF</Hsp_hseq> + <Hsp_midline>V+EL D L + G K SAGQSSQS+KIKST+T QYPSERSAGND +G+LRVHDLYKNGLLFTAYDMNSRT+GDMR+MRLGE++RT+ +VKS+TG NT +VDKIPV NILLPRSKSDV+S SHKFNDV DSLISRGGGTATGVLSNVASTAVFG LES+TQGLMAD+NEQIYNTARSMY GADNRTKVFTWDLTPRSV DLIAI+EIYEYFNYYSYGETG ST+AKEVKS LDEWYKSTFLDTLTP A +NDTVFEKITSFLSNVIVVSNPTVW+VRNFG TSKFDG+ ++FGPCQIQSIRFDKTPNG FNGLA+APNLPSTFTLEITMREILTLNR+S+Y+EGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>2</Hit_num> + <Hit_id>gi|408387125|gb|AFU64134.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Salmonella phage STML-198]</Hit_def> + <Hit_accession>AFU64134</Hit_accession> + <Hit_len>350</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>590.497</Hsp_bit-score> + <Hsp_score>1521</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>5</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>350</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>291</Hsp_identity> + <Hsp_positive>319</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>348</Hsp_align-len> + <Hsp_qseq>VRELDDKTDALIS-GVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>VKELKDTAKELWNKGEKISAGQSSQSSKIKSTVTVQYPSERSAGNDVTGNLRVHDLYKNGLLFTAYDMNSRTSGDMRNMRLGELRRTSQDIVKSVTGKNTKQVDKIPVANILLPRSKSDVDSTSHKFNDVADSLISRGGGTATGVLSNVASTAVFGALESVTQGLMADNNEQIYNTARSMYAGADNRTKVFTWDLTPRSVHDLIAIVEIYEYFNYYSYGETGNSTFAKEVKSTLDEWYKSTFLDTLTPTGAPQNDTVFEKITSFLSNVIVVSNPTVWYVRNFGNTSKFDGKTDIFGPCQIQSIRFDKTPNGIFNGLAVAPNLPSTFTLEITMREILTLNRSSIYSEGF</Hsp_hseq> + <Hsp_midline>V+EL D L + G K SAGQSSQS+KIKST+T QYPSERSAGND +G+LRVHDLYKNGLLFTAYDMNSRT+GDMR+MRLGE++RT+ +VKS+TG NT +VDKIPV NILLPRSKSDV+S SHKFNDV DSLISRGGGTATGVLSNVASTAVFG LES+TQGLMAD+NEQIYNTARSMY GADNRTKVFTWDLTPRSV DLIAI+EIYEYFNYYSYGETG ST+AKEVKS LDEWYKSTFLDTLTP A +NDTVFEKITSFLSNVIVVSNPTVW+VRNFG TSKFDG+ ++FGPCQIQSIRFDKTPNG FNGLA+APNLPSTFTLEITMREILTLNR+S+Y+EGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>3</Hit_num> + <Hit_id>gi|311993188|ref|YP_004010054.1|</Hit_id> + <Hit_def>gp48 base plate tail tube cap [Enterobacteria phage CC31] >gi|284178026|gb|ADB81692.1| gp48 base plate tail tube cap [Enterobacteria phage CC31]</Hit_def> + <Hit_accession>YP_004010054</Hit_accession> + <Hit_len>349</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>559.296</Hsp_bit-score> + <Hsp_score>1440</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>349</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>270</Hsp_identity> + <Hsp_positive>310</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>351</Hsp_align-len> + <Hsp_qseq>MSIKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MAIRATEILDK--AFGSGEKTSAGQSSISSTRRSTVTAQYPAERSAGNDAAGDLRVHDLYKNGLLFTAYDMSSRTTPDLRSMRQSQLSKSASSILNSLGIKNNGQVDKSPIANILLPRSKSDVESISHKFNDVGDSLMTRGNNSATGVLSNVASTAVFGALDSITQGLMADNNEQIYNTARSMYAGADNRTKVFTWDLTPRSVADLVSIIQIYEYFNYFSYGETGNSTYAKELKGQLDEWYKTTLLSPLTPDGADLNNTMFENITSFLSNVIVVTNPTVWFIRNFGKTSKFDGRAEVFGPCQIQSIRFDKTPNGQFNGLAIAPNMPSTFTLEITFREILTLNRASLYAEGF</Hsp_hseq> + <Hsp_midline>M+I+ E+ DK A SG KTSAGQSS S+ +ST+TAQYP+ERSAGND +G LRVHDLYKNGLLFTAYDM+SRTT D+RSMR ++ ++A+S++ S+ N +VDK P+ NILLPRSKSDVES+SHKFNDVGDSL++RG +ATGVLSNVASTAVFG L+S+TQGLMAD+NEQIYNTARSMY GADNRTKVFTWDLTPRSV DL++II+IYEYFNY+SYGETG STYAKE+K QLDEWYK+T L LTPD A+ N+T+FE ITSFLSNVIVV+NPTVWF+RNFG TSKFDGRAEVFGPCQIQSIRFDKTPNG FNGLAIAPN+PSTFTLEIT REILTLNRAS+YAEGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>4</Hit_num> + <Hit_id>gi|589889939|ref|YP_009005475.1|</Hit_id> + <Hit_def>baseplate subunit [Enterobacter phage PG7] >gi|583927852|gb|AHI61114.1| baseplate subunit [Enterobacter phage PG7]</Hit_def> + <Hit_accession>YP_009005475</Hit_accession> + <Hit_len>349</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>536.954</Hsp_bit-score> + <Hsp_score>1382</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>349</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>260</Hsp_identity> + <Hsp_positive>305</Hsp_positive> + <Hsp_gaps>2</Hsp_gaps> + <Hsp_align-len>351</Hsp_align-len> + <Hsp_qseq>MSIKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MAIRATEILDKD--FGSGEKTSAGQSSISSTRRSTIVAQYPAQRAAGNDAAGDLRVHDLYKNGLLFTAYDMSSRTSPDLRNMRQSQLSKSASSILNSLGIKNNGQVDKSPIANILLPRSKSDVESTSHKFNDVGESLITRGNNSATGVLSNVASTAVFGALDSVTQGLMADNNEQIYNTARSMYAGADNRTKVFTWDLTPRSVADLVSIIQIYECFNYFSYGETGNSSYAKELKGQLDEWYKTTLLSPLTPDGADLNNTMFENITSFLSNVIVVTNPTVWFIRNFGKTSKFDGRTELFGPCQIQSIRFDKTPNGQFNGLAIAPNMPSTFTLEITFREILTLSRASLYAEGF</Hsp_hseq> + <Hsp_midline>M+I+ E+ DK SG KTSAGQSS S+ +STI AQYP++R+AGND +G LRVHDLYKNGLLFTAYDM+SRT+ D+R+MR ++ ++A+S++ S+ N +VDK P+ NILLPRSKSDVES SHKFNDVG+SLI+RG +ATGVLSNVASTAVFG L+S+TQGLMAD+NEQIYNTARSMY GADNRTKVFTWDLTPRSV DL++II+IYE FNY+SYGETG S+YAKE+K QLDEWYK+T L LTPD A+ N+T+FE ITSFLSNVIVV+NPTVWF+RNFG TSKFDGR E+FGPCQIQSIRFDKTPNG FNGLAIAPN+PSTFTLEIT REILTL+RAS+YAEGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>5</Hit_num> + <Hit_id>gi|414086559|ref|YP_006986748.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Enterobacteria phage vB_EcoM_ACG-C40] >gi|383396340|gb|AFH20156.1| baseplate tail tube cap [Enterobacteria phage vB_EcoM_ACG-C40]</Hit_def> + <Hit_accession>YP_006986748</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>494.197</Hsp_bit-score> + <Hsp_score>1271</Hsp_score> + <Hsp_evalue>1.69091e-171</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>15</Hsp_hit-from> + <Hsp_hit-to>364</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>236</Hsp_identity> + <Hsp_positive>287</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMR------LGEMKRTANSVVKS---------ITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>SGETISAGQSTKSEVGTKTYTAQFPTGRASGNDTTGDFQVTDLYKNGLLFTAYNMSSRDSGSLRTMRSNYSSSSSSILRTARNTISNTVSKLSNGLISDNNSGTISKVPVANILLPRSKSDVDTSSHRFNDVQDSLITKGGGTATGVLSNMASTAVFGALESITQGIMADNNEQIYTTARSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAAEIKGYLDEWYRSTFIEPLTPEDAVKNKTLFEKMTSSLTNVLVVSNPTIWMVKNFGATSKFDGKTEIFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREIITLNRASLYAGTF</Hsp_hseq> + <Hsp_midline>SG SAGQS++S T TAQ+P+ R++GNDT+G +V DLYKNGLLFTAY+M+SR +G +R+MR + RTA + + + I+ N+ + K+PV NILLPRSKSDV++ SH+FNDV DSLI++GGGTATGVLSN+ASTAVFG LES+TQG+MAD+NEQIY TARSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA E+K LDEWY+STF++ LTP++A KN T+FEK+TS L+NV+VVSNPT+W V+NFG TSKFDG+ E+FGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREI+TLNRAS+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>6</Hit_num> + <Hit_id>gi|431809133|ref|YP_007236030.1|</Hit_id> + <Hit_def>phage baseplate tail tube cap (T4-like gp48) [Yersinia phage phiR1-RT] >gi|398313422|emb|CCI88771.1| phage baseplate tail tube cap (T4-like gp48) [Yersinia phage phiR1-RT]</Hit_def> + <Hit_accession>YP_007236030</Hit_accession> + <Hit_len>348</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>492.656</Hsp_bit-score> + <Hsp_score>1267</Hsp_score> + <Hsp_evalue>3.88245e-171</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>347</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>242</Hsp_identity> + <Hsp_positive>290</Hsp_positive> + <Hsp_gaps>6</Hsp_gaps> + <Hsp_align-len>352</Hsp_align-len> + <Hsp_qseq>MSIKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSI-TGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MSIRATEITEST-IKSAGISTSAGQVTQSTAIK-TIQAQFPAERASGNDSTLDLQITDLYKNGLLFTAYDFTSRTSPDLRQNR-ADIQIAAQKKPSSIFTGTKT--VQQTPVANILLPRSKSDVDNTSHKFNDVGESLVTRGGGNATGILSNMASTAVFGALESLTQGYMSDHGEQIYNTARSMYGGADNRQKVFTWDLTPRNVQDLVQIIKIYETFNYYSYGQTGSSSFAKGLKGDLDTWYKNTFLKNMTPDGANLDNTMFEQITSFLTNVIVVSNPTVWYVRNFGATSSFDGRADVFGPCQIASIRFDKSPNGHFNGLAIAPNLPSTFVLEITFREILTLNRNSLYAGGL</Hsp_hseq> + <Hsp_midline>MSI+ E+ + T +G+ TSAGQ +QS IK TI AQ+P+ER++GND++ L++ DLYKNGLLFTAYD SRT+ D+R R +++ A SI TGT T V + PV NILLPRSKSDV++ SHKFNDVG+SL++RGGG ATG+LSN+ASTAVFG LESLTQG M+DH EQIYNTARSMYGGADNR KVFTWDLTPR+VQDL+ II+IYE FNYYSYG+TG+S++AK +K LD WYK+TFL +TPD AN ++T+FE+ITSFL+NVIVVSNPTVW+VRNFG TS FDGRA+VFGPCQI SIRFDK+PNG+FNGLAIAPNLPSTF LEIT REILTLNR S+YA G </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>7</Hit_num> + <Hit_id>gi|228861125|ref|YP_002854148.1|</Hit_id> + <Hit_def>gp48 base plate [Enterobacteria phage RB51] >gi|422934973|ref|YP_007004933.1| baseplate tail tube cap [Escherichia phage wV7] >gi|227438799|gb|ACP31111.1| gp48 base plate [Enterobacteria phage RB51] >gi|291290411|dbj|BAI83206.1| baseplate tail tube cap [Enterobacteria phage AR1] >gi|343177527|gb|AEM00853.1| baseplate tail tube cap [Escherichia phage wV7]</Hit_def> + <Hit_accession>YP_002854148</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>491.5</Hsp_bit-score> + <Hsp_score>1264</Hsp_score> + <Hsp_evalue>1.72752e-170</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>15</Hsp_hit-from> + <Hsp_hit-to>364</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>235</Hsp_identity> + <Hsp_positive>286</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMR------LGEMKRTANSVVKS---------ITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>SGETISAGQSTKSEVGTKTYTAQFPTGRASGNDTTGDFQVTDLYKNGLLFTAYNMSSRDSGSLRTMRSNYSSSSSSILRTARNTISNTVSKLSNGLISDNNSGTISKVPVANILLPRSKSDVDTSSHRFNDVQDSLITKGGGTATGVLSNMASTAVFGALESITQGIMADNNEQIYTTARSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAAEIKGYLDEWYRSTFIEPLTPEDAIKNKTLFEKMTSSLTNVLVVSNPTIWMVKNFGATSKFDGKTEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSSFTLEITMREIITLNRASLYTGTF</Hsp_hseq> + <Hsp_midline>SG SAGQS++S T TAQ+P+ R++GNDT+G +V DLYKNGLLFTAY+M+SR +G +R+MR + RTA + + + I+ N+ + K+PV NILLPRSKSDV++ SH+FNDV DSLI++GGGTATGVLSN+ASTAVFG LES+TQG+MAD+NEQIY TARSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA E+K LDEWY+STF++ LTP++A KN T+FEK+TS L+NV+VVSNPT+W V+NFG TSKFDG+ EVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPS+FTLEITMREI+TLNRAS+Y F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>8</Hit_num> + <Hit_id>gi|116326413|ref|YP_803133.1|</Hit_id> + <Hit_def>base plate [Enterobacteria phage RB32] >gi|228861506|ref|YP_002854527.1| gp48 base plate [Enterobacteria phage RB14] >gi|115344006|gb|ABI95015.1| base plate [Enterobacteria phage RB32] >gi|227438522|gb|ACP30835.1| gp48 base plate [Enterobacteria phage RB14] >gi|398313741|emb|CCI89088.1| phage baseplate tail tube cap (T4-like gp48) [Yersinia phage phiD1] >gi|525334459|gb|AGR46141.1| baseplate tail tube cap [Yersinia phage PST]</Hit_def> + <Hit_accession>YP_803133</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>488.419</Hsp_bit-score> + <Hsp_score>1256</Hsp_score> + <Hsp_evalue>3.32248e-169</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>15</Hsp_hit-from> + <Hsp_hit-to>364</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>237</Hsp_identity> + <Hsp_positive>286</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGE------MKRTANSVVKS---------ITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>SGEKISAGQSTKSEVGTKTYTAQFPTGRASGNDTTGDFQVTDLYKNGLLFTAYNMSSRDSGSLRSMRSNYSSSSSSILRTARNTISSTVSKLSNGLISNNNSGTISKAPIANILLPRSKSDVDTSSHRFNDVQESLISRGGGTATGVLSNIASTAVFGALESITQGIMADNNEQIYTTARSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAAEIKGYLDDWYRSTLIEPLSPEDAAKNKTLFEKMTSSLTNVLVVSNPTVWMVKNFGATSKFDGKTEIFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREIITLNRASLYAGTF</Hsp_hseq> + <Hsp_midline>SG K SAGQS++S T TAQ+P+ R++GNDT+G +V DLYKNGLLFTAY+M+SR +G +RSMR + RTA + + S I+ N+ + K P+ NILLPRSKSDV++ SH+FNDV +SLISRGGGTATGVLSN+ASTAVFG LES+TQG+MAD+NEQIY TARSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA E+K LD+WY+ST ++ L+P++A KN T+FEK+TS L+NV+VVSNPTVW V+NFG TSKFDG+ E+FGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREI+TLNRAS+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>9</Hit_num> + <Hit_id>gi|639438843|ref|YP_009030800.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Escherichia phage e11/2] >gi|628971671|gb|AHY83393.1| baseplate tail tube cap [Escherichia phage e11/2]</Hit_def> + <Hit_accession>YP_009030800</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>486.878</Hsp_bit-score> + <Hsp_score>1252</Hsp_score> + <Hsp_evalue>1.3135e-168</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>15</Hsp_hit-from> + <Hsp_hit-to>364</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>236</Hsp_identity> + <Hsp_positive>286</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGE------MKRTANSVVKS---------ITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>SGEKISAGQSTKSEVGTKTYTAQFPTGRASGNDTTGDFQVTDLYKNGLLFTAYNMSSRDSGSLRSMRSNYSSSSSSILRTARNTISNTVSKLSNGLISNNNSGTISKAPIANILLPRSKSDVDTSSHRFNDVQESLISRGGGTATGVLSNIASTAVFGALESITQGIMADNNEQIYTTARSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAAEIKGYLDDWYRSTLIEPLSPEDAAKNKTLFEKMTSSLTNVLVVSNPTVWMVKNFGATSKFDGKTEIFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREIITLNRASLYAGTF</Hsp_hseq> + <Hsp_midline>SG K SAGQS++S T TAQ+P+ R++GNDT+G +V DLYKNGLLFTAY+M+SR +G +RSMR + RTA + + + I+ N+ + K P+ NILLPRSKSDV++ SH+FNDV +SLISRGGGTATGVLSN+ASTAVFG LES+TQG+MAD+NEQIY TARSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA E+K LD+WY+ST ++ L+P++A KN T+FEK+TS L+NV+VVSNPTVW V+NFG TSKFDG+ E+FGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREI+TLNRAS+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>10</Hit_num> + <Hit_id>gi|330858711|ref|YP_004415086.1|</Hit_id> + <Hit_def>putative baseplate tail tube cap [Shigella phage Shfl2] >gi|422934608|ref|YP_007004569.1| phage baseplate protein [Enterobacteria phage ime09] >gi|327397645|gb|AEA73147.1| putative baseplate tail tube cap [Shigella phage Shfl2] >gi|339791391|gb|AEK12448.1| phage baseplate protein [Enterobacteria phage ime09]</Hit_def> + <Hit_accession>YP_004415086</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>486.493</Hsp_bit-score> + <Hsp_score>1251</Hsp_score> + <Hsp_evalue>1.49721e-168</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>15</Hsp_hit-from> + <Hsp_hit-to>364</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>236</Hsp_identity> + <Hsp_positive>284</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKR------TANSVVKS---------ITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>SGEKISAGQSTKSEVATKTYTAQFPTGRASGNDTTGDFQVTDLYKNGLLFTAYNMSSRDSGSLRSMRSNYSSSSSSILSTARNTISSTVSKLSNGLISNNNSGTISKAPVANILLPRSKSDVDTSSHRFNDVQESLISRGGGTATGVLSNIASTAVFGALESITQGIMADNNEQIYTTARSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAAEIKGYLDDWYRSTLIEPLSPEDAAKNKTLFEKMTSSLTNVLVVSNPTIWMVKNFGATSKFDGKTEIFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREIITLNRASLYAGTF</Hsp_hseq> + <Hsp_midline>SG K SAGQS++S T TAQ+P+ R++GNDT+G +V DLYKNGLLFTAY+M+SR +G +RSMR TA + + S I+ N+ + K PV NILLPRSKSDV++ SH+FNDV +SLISRGGGTATGVLSN+ASTAVFG LES+TQG+MAD+NEQIY TARSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA E+K LD+WY+ST ++ L+P++A KN T+FEK+TS L+NV+VVSNPT+W V+NFG TSKFDG+ E+FGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREI+TLNRAS+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>11</Hit_num> + <Hit_id>gi|397134210|gb|AFO10717.1|</Hit_id> + <Hit_def>baseplate protein [Escherichia phage ECML-134]</Hit_def> + <Hit_accession>AFO10717</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>485.337</Hsp_bit-score> + <Hsp_score>1248</Hsp_score> + <Hsp_evalue>4.36088e-168</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>15</Hsp_hit-from> + <Hsp_hit-to>364</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>236</Hsp_identity> + <Hsp_positive>285</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGE------MKRTANSVVKS---------ITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>SGEKISAGQSTKSEVGTKTYTAQFPTGRASGNDTTGDFQVTDLYKNGLLFTAYNMSSRDSGSLRSMRSNYSSSSSSILRTARNTISSTVSKLSNGLISNNNSGTISKSPIANTLLPRSKSDVDTSSHRFNDVQESLISRGGGTATGVLSNIASTAVFGALESITQGIMADNNEQIYTTARSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAAEIKGYLDDWYRSTLIEPLSPEDAAKNKTLFEKMTSSLTNVLVVSNPTVWMVKNFGATSKFDGKTEIFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREIITLNRASLYAGTF</Hsp_hseq> + <Hsp_midline>SG K SAGQS++S T TAQ+P+ R++GNDT+G +V DLYKNGLLFTAY+M+SR +G +RSMR + RTA + + S I+ N+ + K P+ N LLPRSKSDV++ SH+FNDV +SLISRGGGTATGVLSN+ASTAVFG LES+TQG+MAD+NEQIY TARSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA E+K LD+WY+ST ++ L+P++A KN T+FEK+TS L+NV+VVSNPTVW V+NFG TSKFDG+ E+FGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREI+TLNRAS+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>12</Hit_num> + <Hit_id>gi|9632645|ref|NP_049806.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Enterobacteria phage T4] >gi|138041|sp|P13339.3|VG48_BPT4 RecName: Full=Tail-tube assembly protein Gp48 [Enterobacteria phage T4] >gi|5354269|gb|AAD42476.1|AF158101_63 gp48 baseplate tail tube cap [Enterobacteria phage T4] >gi|215947|gb|AAA32539.1| tail-tube assembly protein [Enterobacteria phage T4] >gi|299780554|gb|ADJ39916.1| baseplate subunit [Enterobacteria phage T4T] >gi|628971799|gb|AHY83520.1| baseplate subunit [Enterobacteria phage T4] >gi|628972001|gb|AHY83721.1| baseplate subunit [Enterobacteria phage T4] >gi|628972192|gb|AHY83911.1| baseplate subunit [Enterobacteria phage T4]</Hit_def> + <Hit_accession>NP_049806</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>484.567</Hsp_bit-score> + <Hsp_score>1246</Hsp_score> + <Hsp_evalue>8.86163e-168</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>15</Hsp_hit-from> + <Hsp_hit-to>364</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>236</Hsp_identity> + <Hsp_positive>285</Hsp_positive> + <Hsp_gaps>15</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGE------MKRTANSVVKS---------ITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>SGEKISAGQSTKSEVGTKTYTAQFPTGRASGNDTTEDFQVTDLYKNGLLFTAYNMSSRDSGSLRSMRSNYSSSSSSILRTARNTISSTVSKLSNGLISNNNSGTISKSPIANILLPRSKSDVDTSSHRFNDVQESLISRGGGTATGVLSNIASTAVFGALESITQGIMADNNEQIYTTARSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAAEIKGYLDDWYRSTLIEPLSPEDAAKNKTLFEKMTSSLTNVLVVSNPTVWMVKNFGATSKFDGKTEIFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREIITLNRASLYAGTF</Hsp_hseq> + <Hsp_midline>SG K SAGQS++S T TAQ+P+ R++GNDT+ +V DLYKNGLLFTAY+M+SR +G +RSMR + RTA + + S I+ N+ + K P+ NILLPRSKSDV++ SH+FNDV +SLISRGGGTATGVLSN+ASTAVFG LES+TQG+MAD+NEQIY TARSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA E+K LD+WY+ST ++ L+P++A KN T+FEK+TS L+NV+VVSNPTVW V+NFG TSKFDG+ E+FGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREI+TLNRAS+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>13</Hit_num> + <Hit_id>gi|642905805|ref|YP_009037574.1|</Hit_id> + <Hit_def>baseplate subunit [Escherichia phage vB_EcoM_JS09] >gi|642903959|gb|AIA79979.1| baseplate subunit [Escherichia phage vB_EcoM_JS09]</Hit_def> + <Hit_accession>YP_009037574</Hit_accession> + <Hit_len>369</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>484.952</Hsp_bit-score> + <Hsp_score>1247</Hsp_score> + <Hsp_evalue>9.36795e-168</Hsp_evalue> + <Hsp_query-from>19</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>20</Hsp_hit-from> + <Hsp_hit-to>369</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>227</Hsp_identity> + <Hsp_positive>285</Hsp_positive> + <Hsp_gaps>17</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>VKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSIT-----------------GTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>VSESAGQSTKTETTTKTYVAQFPTGRAAGNDSTGDFQVTDLYKNGLLFTAYNMSARDSGSLRNLRPAYAGTSSNGIISDLTDNVKDAVTKFSNGLLPAGANKSTINKTPVANILLPRSKSDVDTTSHRFNDVGDSLITKGGGTATGVLSNIASTAVFGALDSITQGLMADNNEQIYTTSRSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAQEIKSYLDEWYRSTFIEPMTPDDAVKNKTLFEKITASLTNVLVVSNPTIWMVKNFGYTSKFDGLTDVFGPCQIQSVRFDKTPNGQFNGLAVAPNLPSTFTLEITMREIITLNRSSLYAGTF</Hsp_hseq> + <Hsp_midline>V SAGQS+++ T AQ+P+ R+AGND++G +V DLYKNGLLFTAY+M++R +G +R++R ++N ++ +T G N + ++K PV NILLPRSKSDV++ SH+FNDVGDSLI++GGGTATGVLSN+ASTAVFG L+S+TQGLMAD+NEQIY T+RSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA+E+KS LDEWY+STF++ +TPD+A KN T+FEKIT+ L+NV+VVSNPT+W V+NFG TSKFDG +VFGPCQIQS+RFDKTPNG FNGLA+APNLPSTFTLEITMREI+TLNR+S+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>14</Hit_num> + <Hit_id>gi|32453688|ref|NP_861897.1|</Hit_id> + <Hit_def>baseplate subunit [Enterobacteria phage RB69] >gi|32350507|gb|AAP76106.1| gp48 baseplate tail tube cap [Enterobacteria phage RB69] >gi|604671902|gb|AHV82896.1| baseplate tail tube cap [Escherichia phage vB_EcoM_PhAPEC2]</Hit_def> + <Hit_accession>NP_861897</Hit_accession> + <Hit_len>369</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>484.567</Hsp_bit-score> + <Hsp_score>1246</Hsp_score> + <Hsp_evalue>1.0678e-167</Hsp_evalue> + <Hsp_query-from>19</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>20</Hsp_hit-from> + <Hsp_hit-to>369</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>226</Hsp_identity> + <Hsp_positive>285</Hsp_positive> + <Hsp_gaps>17</Hsp_gaps> + <Hsp_align-len>350</Hsp_align-len> + <Hsp_qseq>VKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSIT-----------------GTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>VSESAGQSTKTETTTKTYVAQFPTGRAAGNDSTGDFQVTDLYKNGLLFTAYNMSARDSGSLRNLRPAYAGTSSNGIISDLTDNVKDAVTKFSNGLLPAGANKSTINKTPVANILLPRSKSDVDTTSHRFNDIGDSLITKGGGTATGVLSNIASTAVFGALDSITQGLMADNNEQIYTTSRSMYGGAENRTKVFTWDLTPRSTEDLMAIINIYQYFNYFSYGETGKSQYAQEIKSYLDEWYRSTFIEPMTPDDAVKNKTLFEKITASLTNVLVVSNPTIWMVKNFGHTSKFDGLTDVFGPCQIQSVRFDKTPNGQFNGLAVAPNLPSTFTLEITMREIITLNRSSLYAGTF</Hsp_hseq> + <Hsp_midline>V SAGQS+++ T AQ+P+ R+AGND++G +V DLYKNGLLFTAY+M++R +G +R++R ++N ++ +T G N + ++K PV NILLPRSKSDV++ SH+FND+GDSLI++GGGTATGVLSN+ASTAVFG L+S+TQGLMAD+NEQIY T+RSMYGGA+NRTKVFTWDLTPRS +DL+AII IY+YFNY+SYGETG S YA+E+KS LDEWY+STF++ +TPD+A KN T+FEKIT+ L+NV+VVSNPT+W V+NFG TSKFDG +VFGPCQIQS+RFDKTPNG FNGLA+APNLPSTFTLEITMREI+TLNR+S+YA F</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>15</Hit_num> + <Hit_id>gi|314121772|ref|YP_004063891.1|</Hit_id> + <Hit_def>gp48 baseplate subunit [Enterobacteria phage vB_EcoM-VR7] >gi|313151529|gb|ADR32585.1| gp48 baseplate subunit [Enterobacteria phage vB_EcoM-VR7]</Hit_def> + <Hit_accession>YP_004063891</Hit_accession> + <Hit_len>368</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>461.84</Hsp_bit-score> + <Hsp_score>1187</Hsp_score> + <Hsp_evalue>1.08287e-158</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>368</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>228</Hsp_identity> + <Hsp_positive>285</Hsp_positive> + <Hsp_gaps>21</Hsp_gaps> + <Hsp_align-len>369</Hsp_align-len> + <Hsp_qseq>IKVRELD---DKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMR---LGEMKRTANSV----VKSIT----------GTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MKVKELDFDFDIAGLFNGGSKTSAGQS-KAAQTQATIVAQYPAERASGNDSSDDMRVNDLYKNGLLFTAYNFSSRTSPELRSDRSSQLTSLKKVSNGASFNPVKSLTSFAKSKLTGSGSTGKSFDSNAVANILLPRSKSDVESVSHRFNDVGESLITKGGGSATGILSNIASTAVFGALESVTNGVMADHGEQIYTTARSMYAGPDNRTKVYTWEMTPRSAQDLIQIVKIYEIFNYYSYGETGKSSFASELKDKIDTWYKSTFPSKRKAIDNFDGKLLGEEITSFLTNVLVVSNPTIWYIRNFGDTSSYDGRGELFGPCQIQSIRFDKSPDGHFGGLAIAPNLPSTFVLEITFREIITLNRGSLYAEGF</Hsp_hseq> + <Hsp_midline>+KV+ELD D G KTSAGQS ++A+ ++TI AQYP+ER++GND+S +RV+DLYKNGLLFTAY+ +SRT+ ++RS R L +K+ +N VKS+T G+ D V NILLPRSKSDVESVSH+FNDVG+SLI++GGG+ATG+LSN+ASTAVFG LES+T G+MADH EQIY TARSMY G DNRTKV+TW++TPRS QDLI I++IYE FNYYSYGETG S++A E+K ++D WYKSTF + + E+ITSFL+NV+VVSNPT+W++RNFG TS +DGR E+FGPCQIQSIRFDK+P+G+F GLAIAPNLPSTF LEIT REI+TLNR S+YAEGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>16</Hit_num> + <Hit_id>gi|308814557|ref|YP_003934831.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Shigella phage SP18] >gi|308206149|gb|ADO19548.1| baseplate tail tube cap [Shigella phage SP18]</Hit_def> + <Hit_accession>YP_003934831</Hit_accession> + <Hit_len>362</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>460.299</Hsp_bit-score> + <Hsp_score>1183</Hsp_score> + <Hsp_evalue>3.47109e-158</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>362</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>228</Hsp_identity> + <Hsp_positive>285</Hsp_positive> + <Hsp_gaps>21</Hsp_gaps> + <Hsp_align-len>366</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMR---LGEMKRTANSV----VKSIT----------GTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MKVKELD-IAGLFNGGSKTSAGQS-KAAQTQATIVAQYPAERASGNDSSDDMRVNDLYKNGLLFTAYNFSSRTSPELRSDRSSQLTSLKKVSNGASFNPVKSLTSFAKSKLTGAGSTGKSFDSNAVANILLPRSKSDVESVSHRFNDVGESLITKGGGSATGILSNIASTAVFGALESVTNGVMADHGEQIYTTARSMYAGPDNRTKVYTWEMTPRSAQDLIQIVKIYEIFNYYSYGETGKSSFASELKEKIDTWYKSTFKKEAIDNFDGK--LLGEEITSFLTNVLVVSNPTIWYIRNFGDTSSYDGRGELFGPCQIQSIRFDKSPDGHFGGLAIAPNLPSTFVLEITFREIITLNRGSLYAEGF</Hsp_hseq> + <Hsp_midline>+KV+ELD G KTSAGQS ++A+ ++TI AQYP+ER++GND+S +RV+DLYKNGLLFTAY+ +SRT+ ++RS R L +K+ +N VKS+T G+ D V NILLPRSKSDVESVSH+FNDVG+SLI++GGG+ATG+LSN+ASTAVFG LES+T G+MADH EQIY TARSMY G DNRTKV+TW++TPRS QDLI I++IYE FNYYSYGETG S++A E+K ++D WYKSTF + K + E+ITSFL+NV+VVSNPT+W++RNFG TS +DGR E+FGPCQIQSIRFDK+P+G+F GLAIAPNLPSTF LEIT REI+TLNR S+YAEGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>17</Hit_num> + <Hit_id>gi|422934215|ref|YP_007004251.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Enterobacteria phage Bp7] >gi|345450724|gb|AEN93927.1| baseplate tail tube cap [Enterobacteria phage Bp7]</Hit_def> + <Hit_accession>YP_007004251</Hit_accession> + <Hit_len>362</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>458.759</Hsp_bit-score> + <Hsp_score>1179</Hsp_score> + <Hsp_evalue>1.18966e-157</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>362</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>233</Hsp_identity> + <Hsp_positive>284</Hsp_positive> + <Hsp_gaps>23</Hsp_gaps> + <Hsp_align-len>367</Hsp_align-len> + <Hsp_qseq>IKVRELD-DKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEM---------KRTANS----VVKSITGTNTN--KVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKND--TVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MKVKELDFDVASLFKGGSKTSAGQSKTPA-IKTTVTAQYPAERASGNDTSTDMVLNDLYKNGLLFTAYNFSSRVSPDLRNDRSSQMTKKFSSAASKLTGNSGTYSAVKNLFGGNTKGVKFDTQALANILLPRSKSDVDSVSHKFNDVGESLITKGGGTATGILSNVASTAVFGALESVTNGVMADSGEQIYTTARSMYAGPDNRTKVFTWEMTPRNAQDLIQIIKIYEIFNYYSYGETGNSAFAGELKEKIDTWYRSTF----KKEAIDKFDGKLLGESITSFLSNVIVVSNPTIWYIRNFGDSSSYDGREDIFGPCQIQSIRFDKTPDGHFNGLAIAPNLPSTFSLEVTFREIITLNRGSLYTEGF</Hsp_hseq> + <Hsp_midline>+KV+ELD D G KTSAGQS A IK+T+TAQYP+ER++GNDTS + ++DLYKNGLLFTAY+ +SR + D+R+ R +M K T NS VK++ G NT K D + NILLPRSKSDV+SVSHKFNDVG+SLI++GGGTATG+LSNVASTAVFG LES+T G+MAD EQIY TARSMY G DNRTKVFTW++TPR+ QDLI II+IYE FNYYSYGETG S +A E+K ++D WY+STF + +K D + E ITSFLSNVIVVSNPT+W++RNFG +S +DGR ++FGPCQIQSIRFDKTP+G+FNGLAIAPNLPSTF+LE+T REI+TLNR S+Y EGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>18</Hit_num> + <Hit_id>gi|299779141|ref|YP_003734335.1|</Hit_id> + <Hit_def>48 gene product [Enterobacteria phage IME08] >gi|298105870|gb|ADI55514.1| gp48 baseplate tail tube cap [Enterobacteria phage IME08]</Hit_def> + <Hit_accession>YP_003734335</Hit_accession> + <Hit_len>363</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>451.825</Hsp_bit-score> + <Hsp_score>1161</Hsp_score> + <Hsp_evalue>7.00414e-155</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>2</Hsp_hit-from> + <Hsp_hit-to>363</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>228</Hsp_identity> + <Hsp_positive>283</Hsp_positive> + <Hsp_gaps>23</Hsp_gaps> + <Hsp_align-len>367</Hsp_align-len> + <Hsp_qseq>IKVRELD-DKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEM---------KRTAN----SVVKSITGTNTN--KVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKND--TVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MKVKELDFDVASLFKGGSKTSAGQS-KAKPIQTTVTAQYPAERASGNDTSTDMVLSDLYKNGLLFTAYNFSSRVSPDLRNDRSSQMTKKFSKATGKLTGNTGGFSAVKNLFSNNSKGVKFDNQALANILLPRSKSDVDSVTHKFNDVGESLITKGGGTATGILSNVASTAVFGALESVTNGVMADSGEQIYTTARSMYAGPDNRTKVFTWEMTPRNAQDLIQIIKIYEIFNYYSYGETGNSAFAGELKEKIDTWYRSTF----KKEAIDKFDGKLLGESITSFLSNVIVVSNPTIWYIRNFGDSSSYDGREDIFGPCQIQSIRFDKTPDGHFNGLAIAPNLPSTFSLEVTFREIITLNRGSLYTEGF</Hsp_hseq> + <Hsp_midline>+KV+ELD D G KTSAGQS ++ I++T+TAQYP+ER++GNDTS + + DLYKNGLLFTAY+ +SR + D+R+ R +M K T N S VK++ N+ K D + NILLPRSKSDV+SV+HKFNDVG+SLI++GGGTATG+LSNVASTAVFG LES+T G+MAD EQIY TARSMY G DNRTKVFTW++TPR+ QDLI II+IYE FNYYSYGETG S +A E+K ++D WY+STF + +K D + E ITSFLSNVIVVSNPT+W++RNFG +S +DGR ++FGPCQIQSIRFDKTP+G+FNGLAIAPNLPSTF+LE+T REI+TLNR S+Y EGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>19</Hit_num> + <Hit_id>gi|161622626|ref|YP_001595319.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Enterobacteria phage JS98] >gi|238695346|ref|YP_002922539.1| gp48 baseplate tail tube cap [Enterobacteria phage JS10] >gi|52139949|gb|AAU29319.1| gp48 baseplate tail tube cap [Enterobacteria phage JS98] >gi|220029482|gb|ACL78416.1| gp48 baseplate tail tube cap [Enterobacteria phage JS10]</Hit_def> + <Hit_accession>YP_001595319</Hit_accession> + <Hit_len>362</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>450.669</Hsp_bit-score> + <Hsp_score>1158</Hsp_score> + <Hsp_evalue>1.82386e-154</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>351</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>362</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>226</Hsp_identity> + <Hsp_positive>282</Hsp_positive> + <Hsp_gaps>19</Hsp_gaps> + <Hsp_align-len>365</Hsp_align-len> + <Hsp_qseq>IKVRELD-DKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEM---------KRTAN----SVVKSITGTNTN--KVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEGF</Hsp_qseq> + <Hsp_hseq>MKVKEIDIDVASLFKGGSKTSAGQS-KAKPAQTTVTAQYPAERASGNDTSTDMVLNDLYKNGLLFTAYNFSSRVSPDLRNDRSSQMTKKFSKAAGKLTSNTGGFSAVKNLFSNNSKGVKFDSQALANILLPRSKSDVDSVTHKFNDVGESLITKGGGTATGILSNVASTAVFGALESVTNGVMADSGEQIYTTARSMYAGPDNRTKVFTWEMTPRNAQDLIQIIKIYEIFNYYSYGETGNSAFAGELKEKIDTWYRSTFKKEAIDNFDGK--LLGEGITSFLSNVIVVSNPTIWYIRNFGNTSSYDGREDIFGPCQIQSIRFDKTPDGHFNGLAIAPNLPSTFSLEVTFREIITLNRGSLYTEGF</Hsp_hseq> + <Hsp_midline>+KV+E+D D G KTSAGQS ++ ++T+TAQYP+ER++GNDTS + ++DLYKNGLLFTAY+ +SR + D+R+ R +M K T+N S VK++ N+ K D + NILLPRSKSDV+SV+HKFNDVG+SLI++GGGTATG+LSNVASTAVFG LES+T G+MAD EQIY TARSMY G DNRTKVFTW++TPR+ QDLI II+IYE FNYYSYGETG S +A E+K ++D WY+STF + K + E ITSFLSNVIVVSNPT+W++RNFG TS +DGR ++FGPCQIQSIRFDKTP+G+FNGLAIAPNLPSTF+LE+T REI+TLNR S+Y EGF</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>20</Hit_num> + <Hit_id>gi|311992692|ref|YP_004009560.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Acinetobacter phage Ac42] >gi|298684475|gb|ADI96436.1| gp48 baseplate tail tube cap [Acinetobacter phage Ac42]</Hit_def> + <Hit_accession>YP_004009560</Hit_accession> + <Hit_len>358</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>447.588</Hsp_bit-score> + <Hsp_score>1150</Hsp_score> + <Hsp_evalue>2.52876e-153</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>355</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>217</Hsp_identity> + <Hsp_positive>280</Hsp_positive> + <Hsp_gaps>14</Hsp_gaps> + <Hsp_align-len>358</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMR---------LGEMKRTA-NSVVKSITGTNTNK-VDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>MKVKEIT-IANIVQAGTDVSAGYTNKRSEPK-TMIAQYPSERSSGNDAS-DMQISDLYRNGLLFTAYDYKSRTTPDMRGMRKREQNKVKALYEQTRTQFNRITSGITSESPKKSVSQDPVANILMPRSKSDSENINHKFNDVGDSLITKGGGTMTGAISNMASTAVFGAIESMTQGLLSDKGEQIYTTARSMYAGPENRTKVYSWELTPRTIDDLVQIIRIYEIFNFYSYGMTGNSQYAKELKSQIDEWYKKTFINNLTPEGSDRSGTMMESVTAFLSNVIVVTNPTVWFVRNFGKTTKFDGRPDVFGPAQIQSIRFDKAPDGNFRGLSIAPNMPSTFVLEVTMREILTLSRGTLYGD</Hsp_hseq> + <Hsp_midline>+KV+E+ + + +G SAG +++ ++ K T+ AQYPSERS+GND S +++ DLY+NGLLFTAYD SRTT DMR MR L E RT N + IT + K V + PV NIL+PRSKSD E+++HKFNDVGDSLI++GGGT TG +SN+ASTAVFG +ES+TQGL++D EQIY TARSMY G +NRTKV++W+LTPR++ DL+ II IYE FN+YSYG TG S YAKE+KSQ+DEWYK TF++ LTP+ ++++ T+ E +T+FLSNVIVV+NPTVWFVRNFG T+KFDGR +VFGP QIQSIRFDK P+GNF GL+IAPN+PSTF LE+TMREILTL+R ++Y +</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>21</Hit_num> + <Hit_id>gi|326536336|ref|YP_004300777.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Acinetobacter phage 133] >gi|299483417|gb|ADJ19511.1| gp48 baseplate tail tube cap [Acinetobacter phage 133]</Hit_def> + <Hit_accession>YP_004300777</Hit_accession> + <Hit_len>356</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>438.343</Hsp_bit-score> + <Hsp_score>1126</Hsp_score> + <Hsp_evalue>1.19665e-149</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>13</Hsp_hit-from> + <Hsp_hit-to>354</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>210</Hsp_identity> + <Hsp_positive>264</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>344</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRT-----------ANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>AGTEISAGYTKQDT-TQQTFSAQYPAERSAGNDATKTSN-GDLYRNGLLFTAYDYKARATPDMTRQRQGELDKARSLYTRISSGLADAGKRSSTQGQDKKIVKDPVANILLPRSKSDSDVVSHKFNDVQDSLITRGGGTATGILSNIASTAVFGTIESVTQGWMADKGEQIFNASRSMYNGAENRSKVYTWELTPRTLEDLVEIMKIYEIFNYYSYGMTGTSAYAKELKAYIDDWYKKTFLNNLTPEGSDKSGTAMESVTSFLSNVITVSNPTIWFVRNFGKSTKFDGRPDVFGPAQIQSIRFDKAPEGHFKGLAIAPNMPSTFVLEITMREVIALSRGSIYGE</Hsp_hseq> + <Hsp_midline>+G + SAG + Q + T +AQYP+ERSAGND + + DLY+NGLLFTAYD +R T DM R GE+ + A++ +S T K+ K PV NILLPRSKSD + VSHKFNDV DSLI+RGGGTATG+LSN+ASTAVFG +ES+TQG MAD EQI+N +RSMY GA+NR+KV+TW+LTPR+++DL+ I++IYE FNYYSYG TGTS YAKE+K+ +D+WYK TFL+ LTP+ ++K+ T E +TSFLSNVI VSNPT+WFVRNFG ++KFDGR +VFGP QIQSIRFDK P G+F GLAIAPN+PSTF LEITMRE++ L+R S+Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>22</Hit_num> + <Hit_id>gi|311992948|ref|YP_004009815.1|</Hit_id> + <Hit_def>gp48 baseplate [Acinetobacter phage Acj61] >gi|295815237|gb|ADG36163.1| gp48 baseplate [Acinetobacter phage Acj61]</Hit_def> + <Hit_accession>YP_004009815</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>416.001</Hsp_bit-score> + <Hsp_score>1068</Hsp_score> + <Hsp_evalue>9.51542e-141</Hsp_evalue> + <Hsp_query-from>5</Hsp_query-from> + <Hsp_query-to>348</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>360</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>203</Hsp_identity> + <Hsp_positive>264</Hsp_positive> + <Hsp_gaps>14</Hsp_gaps> + <Hsp_align-len>358</Hsp_align-len> + <Hsp_qseq>VRELDDKTDALIS--GVKTSAGQSSQSAKIKSTI-TAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSV---------VKSITGTNTNKVDKI--PVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYA</Hsp_qseq> + <Hsp_hseq>VKEIVDSETNLIERIGSFVAAGRSSKEEESKTKIFEAQYPDGRAAATDSVDDARIQDLYANGLLFTAVEYKGRTTPEMTDMRGQVMKNMVDAIDQAKGVFNQLRGKSGGNKKISSAIKNPVCQILLPRSKTDTDTISHKFNDVNESLITRGNGTATGILSNLASTAVFGAVESISQGVMADHGEQIYNTSRAMYGGAENRTKTYTWELTPRTEGDLVQIIRIYELFSFFSYGVTGNSAYAKEIKGQIDDWYKKTFINNLTPEGADRSGTMMESVTSFLSNVIVVSNPTVWFIQNFGTMTTYDKHADVFGPAQISNIRFDKAPDGNFSGLAIAPNMPSTFVLEITFREILTLNRGSLYG</Hsp_hseq> + <Hsp_midline>V+E+ D LI G +AG+SS+ + K+ I AQYP R+A D+ R+ DLY NGLLFTA + RTT +M MR MK +++ ++ +G N I PV ILLPRSK+D +++SHKFNDV +SLI+RG GTATG+LSN+ASTAVFG +ES++QG+MADH EQIYNT+R+MYGGA+NRTK +TW+LTPR+ DL+ II IYE F+++SYG TG S YAKE+K Q+D+WYK TF++ LTP+ A+++ T+ E +TSFLSNVIVVSNPTVWF++NFGT + +D A+VFGP QI +IRFDK P+GNF+GLAIAPN+PSTF LEIT REILTLNR S+Y </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>23</Hit_num> + <Hit_id>gi|311993474|ref|YP_004010339.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Acinetobacter phage Acj9] >gi|295917431|gb|ADG60102.1| gp48 baseplate tail tube cap [Acinetobacter phage Acj9]</Hit_def> + <Hit_accession>YP_004010339</Hit_accession> + <Hit_len>360</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>412.92</Hsp_bit-score> + <Hsp_score>1060</Hsp_score> + <Hsp_evalue>1.46922e-139</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>357</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>212</Hsp_identity> + <Hsp_positive>267</Hsp_positive> + <Hsp_gaps>22</Hsp_gaps> + <Hsp_align-len>363</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALIS--GVKTSAGQSSQSAKIKSTI-TAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMR-----LGEMKRTANSVVKSI---TGTNTNKVDKI--PVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEA---NKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>MQIEEITD----LVSKAGSDISAGQSMRSQESETKILTAQYPAERSASVANTADVGVGQSYSNGLLFTAFEYKSRTTNDLRSMRTKAQNAAKVLRSSKSVTKAIQAVTGGNPNDPNTIKNPVANILMPRSKTDTDVTGHKFNDVGESLISRGGGTATGILSNVASTAVFGTIESVTKGAMADHGEQIYNTSRSMYAGAENRVKTYTWELTPRTYDDLTQIVKIYEIFNYLSYGMTGKSAFAKGVKDEIDKWYRKTFINPL--NEATGSNVQSTTMESVTSFLSNVIVVSNPTVWTIQNFGTASKFDGLADVFGPAQISNIRFDKAPDGQFNGLAAAPNMPSSFVLEVTFREILTLNRATIYGE</Hsp_hseq> + <Hsp_midline>+++ E+ D L+S G SAGQS +S + ++ I TAQYP+ERSA + + V Y NGLLFTA++ SRTT D+RSMR ++ R++ SV K+I TG N N + I PV NIL+PRSK+D + HKFNDVG+SLISRGGGTATG+LSNVASTAVFG +ES+T+G MADH EQIYNT+RSMY GA+NR K +TW+LTPR+ DL I++IYE FNY SYG TG S +AK VK ++D+WY+ TF++ L +EA N T E +TSFLSNVIVVSNPTVW ++NFGT SKFDG A+VFGP QI +IRFDK P+G FNGLA APN+PS+F LE+T REILTLNRA++Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>24</Hit_num> + <Hit_id>gi|639438515|ref|YP_009030255.1|</Hit_id> + <Hit_def>baseplate subunit [Serratia phage PS2] >gi|625370588|gb|AHY25448.1| baseplate subunit [Serratia phage PS2]</Hit_def> + <Hit_accession>YP_009030255</Hit_accession> + <Hit_len>358</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>411.379</Hsp_bit-score> + <Hsp_score>1056</Hsp_score> + <Hsp_evalue>4.21058e-139</Hsp_evalue> + <Hsp_query-from>18</Hsp_query-from> + <Hsp_query-to>350</Hsp_query-to> + <Hsp_hit-from>20</Hsp_hit-from> + <Hsp_hit-to>357</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>201</Hsp_identity> + <Hsp_positive>252</Hsp_positive> + <Hsp_gaps>7</Hsp_gaps> + <Hsp_align-len>339</Hsp_align-len> + <Hsp_qseq>GVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTA----NSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANK--NDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAEG</Hsp_qseq> + <Hsp_hseq>GETIGAGSTGQKKLIQKTLQAQFPAERSAGTDGSSDLRVNDLYRNGLLFTAYDFDARTTQALRDFRKKNNTKTVLDQWNPIKFLTNYGSTFQLNQEAVANILMPRSQSDVDNISHKFNDVGESLTGRNGGDVGKTISNMASTAVFGALESVTQGIMADKGEQVYNSARSMYAGPDNRTKIFVWNLTPRTVYDLLEILKIYEIFAYYSYGRVGYSPWAKDLKSQIDAWYKET-LTKATFDQAKGEVKDTFFEGITDFLTNVITVSNPTIWTVKNFGRTSSFDGKTDIFGPCQIQSIRFDKSPNGHFNGLAIAPNLPSTFVLEITMREIMTLNRDVLFAEG</Hsp_hseq> + <Hsp_midline>G AG + Q I+ T+ AQ+P+ERSAG D S LRV+DLY+NGLLFTAYD ++RTT +R R +T N + +T ++++ V NIL+PRS+SDV+++SHKFNDVG+SL R GG +SN+ASTAVFG LES+TQG+MAD EQ+YN+ARSMY G DNRTK+F W+LTPR+V DL+ I++IYE F YYSYG G S +AK++KSQ+D WYK T L T D+A DT FE IT FL+NVI VSNPT+W V+NFG TS FDG+ ++FGPCQIQSIRFDK+PNG+FNGLAIAPNLPSTF LEITMREI+TLNR ++AEG</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>25</Hit_num> + <Hit_id>gi|33620542|ref|NP_891751.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Enterobacteria phage RB49] >gi|33348009|gb|AAQ15410.1| gp48 baseplate tail tube cap [Enterobacteria phage RB49]</Hit_def> + <Hit_accession>NP_891751</Hit_accession> + <Hit_len>352</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>408.683</Hsp_bit-score> + <Hsp_score>1049</Hsp_score> + <Hsp_evalue>4.9384e-138</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>348</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>349</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>200</Hsp_identity> + <Hsp_positive>260</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>354</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSIT--------GTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYA</Hsp_qseq> + <Hsp_hseq>MKISVINDAVDSFKAGVKTSAGFTSKNKG--KTLTAQFPAERASGNDASG-YYINDLYNNGLLFTAYDYTSRTTGSLRDFR--KKKNVASGFGGSVNIAGFDLNLGGRNAAFDREAIANILLPRSQSDVDAASHKFNDVGESVISRGGGTLGGALSNMASTAVFGGIESITGGYLADHGEQIYNTARSMYAGADARTKNYVWHLTPRSIEDLRNILIIYETFLELSYGSSGISSTAKELKAEVDAWYKNTLLRKSTPEEAKRNDTLFEGITDFLSNVITVSNPTIWMISNFGKRTSFEGRSDAFGPAQISSVRLDKSPDGKFNGLAISPNLPSTFVLEVTFREILTLSRGTIFG</Hsp_hseq> + <Hsp_midline>+K+ ++D D+ +GVKTSAG +S++ T+TAQ+P+ER++GND SG ++DLY NGLLFTAYD SRTTG +R R + K A+ S+ G D+ + NILLPRS+SDV++ SHKFNDVG+S+ISRGGGT G LSN+ASTAVFGG+ES+T G +ADH EQIYNTARSMY GAD RTK + W LTPRS++DL I+ IYE F SYG +G S+ AKE+K+++D WYK+T L TP+EA +NDT+FE IT FLSNVI VSNPT+W + NFG + F+GR++ FGP QI S+R DK+P+G FNGLAI+PNLPSTF LE+T REILTL+R +++ </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>26</Hit_num> + <Hit_id>gi|238695065|ref|YP_002922259.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Enterobacteria phage JSE] >gi|220029201|gb|ACL78136.1| gp48 baseplate tail tube cap [Enterobacteria phage JSE]</Hit_def> + <Hit_accession>YP_002922259</Hit_accession> + <Hit_len>352</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>406.757</Hsp_bit-score> + <Hsp_score>1044</Hsp_score> + <Hsp_evalue>2.44502e-137</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>348</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>349</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>199</Hsp_identity> + <Hsp_positive>259</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>354</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSIT--------GTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYA</Hsp_qseq> + <Hsp_hseq>MKISVINDAVDSFKAGVKTSAGFTSKNKG--KTLTAQFPAERASGNDASG-YYINDLYNNGLLFTAYDYTSRTTGSLRDFR--KKKNVASGFGGSVNIAGFDLNLGGRNAAFDREAIANILLPRSQSDVDAASHKFNDVGESVISRGGGTLGGALSNMASTAVFGGIESITGGYLADHGEQIYNTARSMYAGADARTKNYVWHLTPRSIEDLRNILIIYETFLELSYGSSGISSTAKELKAEVDAWYKNTLLSKSTPAEAKRNDTLFEGITDFLSNVITVSNPTIWMISNFGKRTSFEGRSDAFGPAQISSVRLDKSPDGKFNGLAISPNLPSTFVLEVSFREILTLSRGTIFG</Hsp_hseq> + <Hsp_midline>+K+ ++D D+ +GVKTSAG +S++ T+TAQ+P+ER++GND SG ++DLY NGLLFTAYD SRTTG +R R + K A+ S+ G D+ + NILLPRS+SDV++ SHKFNDVG+S+ISRGGGT G LSN+ASTAVFGG+ES+T G +ADH EQIYNTARSMY GAD RTK + W LTPRS++DL I+ IYE F SYG +G S+ AKE+K+++D WYK+T L TP EA +NDT+FE IT FLSNVI VSNPT+W + NFG + F+GR++ FGP QI S+R DK+P+G FNGLAI+PNLPSTF LE++ REILTL+R +++ </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>27</Hit_num> + <Hit_id>gi|157311484|ref|YP_001469527.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Enterobacteria phage Phi1] >gi|149380688|gb|ABR24693.1| gp48 baseplate tail tube cap [Enterobacteria phage Phi1]</Hit_def> + <Hit_accession>YP_001469527</Hit_accession> + <Hit_len>352</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>405.601</Hsp_bit-score> + <Hsp_score>1041</Hsp_score> + <Hsp_evalue>6.50999e-137</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>348</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>349</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>198</Hsp_identity> + <Hsp_positive>259</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>354</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSIT--------GTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYA</Hsp_qseq> + <Hsp_hseq>MKISVINDAVDSFKAGVKTSAGFTSKNKG--KTLTAQFPAERASGNDASG-YYINDLYNNGLLFTAYDYTSRTTGSLRDFR--KKKNVASGFGGSVNIAGFDLNLGGRNAAFDREAIANILLPRSQSDVDAASHKFNDVGESVISRGGGTLGGALSNMASTAVFGGIESITGGYLADHGEQIYNTARSMYAGADARTKNYVWHLTPRSIEDLRNILIIYETFLELSYGSSGISSTAKELKAEVDAWYKNTLLRKSTPEEAKRNDTLFEGITDFLSNAITVSNPTIWMISNFGKRTSFEGRSDAFGPAQISSVRLDKSPDGKFNGLAISPNLPSTFVLEVSFREILTLSRGTIFG</Hsp_hseq> + <Hsp_midline>+K+ ++D D+ +GVKTSAG +S++ T+TAQ+P+ER++GND SG ++DLY NGLLFTAYD SRTTG +R R + K A+ S+ G D+ + NILLPRS+SDV++ SHKFNDVG+S+ISRGGGT G LSN+ASTAVFGG+ES+T G +ADH EQIYNTARSMY GAD RTK + W LTPRS++DL I+ IYE F SYG +G S+ AKE+K+++D WYK+T L TP+EA +NDT+FE IT FLSN I VSNPT+W + NFG + F+GR++ FGP QI S+R DK+P+G FNGLAI+PNLPSTF LE++ REILTL+R +++ </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>28</Hit_num> + <Hit_id>gi|401824981|gb|AFQ22671.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Stenotrophomonas phage IME13]</Hit_def> + <Hit_accession>AFQ22671</Hit_accession> + <Hit_len>342</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>368.237</Hsp_bit-score> + <Hsp_score>944</Hsp_score> + <Hsp_evalue>2.03823e-122</Hsp_evalue> + <Hsp_query-from>8</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>7</Hsp_hit-from> + <Hsp_hit-to>341</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>181</Hsp_identity> + <Hsp_positive>241</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>345</Hsp_align-len> + <Hsp_qseq>LDDKTDALISGV---KTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>LDGGVQDVVGGILKGENPATGSSPRRPISKIAIAQFPAERNSANDSAQDFNVNDLYKNGLILSAFNYAGRQTGDLRSFRSGQ-----NNI-----GDYRKGVVKEAIANILMPRGQTDVDTISHKFNDVQQSLVERGDSSVTGALSSMASHALFGGLESITQGAFADRGEQVYITSRAMYAGADNRTKTYTWQLTPRNVYDLMQILIIYEMLSYYSYGAVEKSKTASQIKSTLDKAYKETFINPLTPEATHGQTTMFERITSFLSNVNVVSNPIIWTIRNFGETSSFDMRSDVFGPAQIQSIRFDKSPDGHFGGLAIAPNLPSSFVLEVTFREILALNRSDLYDE</Hsp_hseq> + <Hsp_midline>LD ++ G+ + A SS I AQ+P+ER++ ND++ V+DLYKNGL+ +A++ R TGD+RS R G+ N++ G V K + NIL+PR ++DV+++SHKFNDV SL+ RG + TG LS++AS A+FGGLES+TQG AD EQ+Y T+R+MY GADNRTK +TW LTPR+V DL+ I+ IYE +YYSYG S A ++KS LD+ YK TF++ LTP+ + T+FE+ITSFLSNV VVSNP +W +RNFG TS FD R++VFGP QIQSIRFDK+P+G+F GLAIAPNLPS+F LE+T REIL LNR+ +Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>29</Hit_num> + <Hit_id>gi|472438117|ref|YP_007677897.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Aeromonas phage Aes012] >gi|395653255|gb|AFN69810.1| baseplate tail tube cap [Aeromonas phage Aes012]</Hit_def> + <Hit_accession>YP_007677897</Hit_accession> + <Hit_len>342</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>364.385</Hsp_bit-score> + <Hsp_score>934</Hsp_score> + <Hsp_evalue>7.92274e-121</Hsp_evalue> + <Hsp_query-from>8</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>7</Hsp_hit-from> + <Hsp_hit-to>341</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>178</Hsp_identity> + <Hsp_positive>240</Hsp_positive> + <Hsp_gaps>13</Hsp_gaps> + <Hsp_align-len>345</Hsp_align-len> + <Hsp_qseq>LDDKTDALISGV---KTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>LDGGVQDVVGGILKGENPATGSSPRRPISKIAIAQFPAERNSANDSAQDFNVNDLYKNGLILSAFNYAGRQTGDLRSFRSGQ-----NNI-----GDYRKGVVKEAIANILMPRGQTDVDTISHKFNDVQQSLVERGDSSVTGALSSMASHALYGGLESITQGAFADRGEQVYIASRAMYAGADNRTKTYTWQLTPRNVYDLMQILIIYEMLSYYSYGAVEKSKTASQIKSTLDKAYKETFINPLTPEATHGQTTMFERITSFLSNVNVVSNPIIWTIRNFGETSSFDMRSDMFGPAQIQSIRFDKSPDGHFGGLAIAPNLPSSFVLEVTFREILALNRSDLYDE</Hsp_hseq> + <Hsp_midline>LD ++ G+ + A SS I AQ+P+ER++ ND++ V+DLYKNGL+ +A++ R TGD+RS R G+ N++ G V K + NIL+PR ++DV+++SHKFNDV SL+ RG + TG LS++AS A++GGLES+TQG AD EQ+Y +R+MY GADNRTK +TW LTPR+V DL+ I+ IYE +YYSYG S A ++KS LD+ YK TF++ LTP+ + T+FE+ITSFLSNV VVSNP +W +RNFG TS FD R+++FGP QIQSIRFDK+P+G+F GLAIAPNLPS+F LE+T REIL LNR+ +Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>30</Hit_num> + <Hit_id>gi|310722276|ref|YP_003969100.1|</Hit_id> + <Hit_def>unnamed protein product [Aeromonas phage phiAS4] >gi|306021119|gb|ADM79654.1| baseplate protein [Aeromonas phage phiAS4]</Hit_def> + <Hit_accession>YP_003969100</Hit_accession> + <Hit_len>342</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>363.999</Hsp_bit-score> + <Hsp_score>933</Hsp_score> + <Hsp_evalue>1.00609e-120</Hsp_evalue> + <Hsp_query-from>8</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>11</Hsp_hit-from> + <Hsp_hit-to>341</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>177</Hsp_identity> + <Hsp_positive>239</Hsp_positive> + <Hsp_gaps>11</Hsp_gaps> + <Hsp_align-len>342</Hsp_align-len> + <Hsp_qseq>LDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>VQDVVGGILKGENPATG-SSPRRPISKIAIAQFPAERNSANDSAQDFNVNDLYKNGLILSAFNYAGRQTGDLRSFRSGQ-----NNI-----GDYRKGVVKEAIANILMPRGQTDVDTISHKFNDVQQSLVERGDSSVTGALSSMASHALYGGLESITQGAFADRGEQVYIASRAMYAGAENRTKTYTWQLTPRNVYDLMQILIIYEMLSYYSYGAVEKSKTASQIKSTLDKAYKETFINPLTPEATHGQTTMFERITSFLSNVNVVSNPIIWTIRNFGETSSFDMRSDVFGPAQIQSIRFDKSPDGHFGGLAIAPNLPSSFVLEVTFREILALNRSDLYDE</Hsp_hseq> + <Hsp_midline>+ D ++ G + G SS I AQ+P+ER++ ND++ V+DLYKNGL+ +A++ R TGD+RS R G+ N++ G V K + NIL+PR ++DV+++SHKFNDV SL+ RG + TG LS++AS A++GGLES+TQG AD EQ+Y +R+MY GA+NRTK +TW LTPR+V DL+ I+ IYE +YYSYG S A ++KS LD+ YK TF++ LTP+ + T+FE+ITSFLSNV VVSNP +W +RNFG TS FD R++VFGP QIQSIRFDK+P+G+F GLAIAPNLPS+F LE+T REIL LNR+ +Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>31</Hit_num> + <Hit_id>gi|109290161|ref|YP_656410.1|</Hit_id> + <Hit_def>gp48 base plate protein [Aeromonas phage 25] >gi|423262259|ref|YP_007010858.1| baseplate tail tube cap [Aeromonas phage Aes508] >gi|104345834|gb|ABF72734.1| gp48 base plate protein [Aeromonas phage 25] >gi|402762137|gb|AFQ97251.1| baseplate tail tube cap [Aeromonas phage Aes508]</Hit_def> + <Hit_accession>YP_656410</Hit_accession> + <Hit_len>342</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>362.459</Hsp_bit-score> + <Hsp_score>929</Hsp_score> + <Hsp_evalue>3.78445e-120</Hsp_evalue> + <Hsp_query-from>8</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>11</Hsp_hit-from> + <Hsp_hit-to>341</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>176</Hsp_identity> + <Hsp_positive>238</Hsp_positive> + <Hsp_gaps>11</Hsp_gaps> + <Hsp_align-len>342</Hsp_align-len> + <Hsp_qseq>LDDKTDALISGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>IQDVVGGILKGENPATG-SSPRRPISKIAIAQFPAERNSANDSAQDFNVNDLYKNGLILSAFNYAGRQTGDLRSFRSGQ-----NNI-----GDYRKGVVKEAIANILMPRGQTDVDTISHKFNDVQQSLVERGDSSVTGALSSMASHALYGGLESITQGAFADRGEQVYIASRAMYAGAENRTKTYTWQLTPRNVYDLMQILTIYEMLSYYSYGAVEKSKTASQIKSTLDNAYKETFINPLTPEATHGQTTMFERITSFLSNVNVVSNPIIWTIRNFGETSSFDMRSDMFGPAQIQSIRFDKSPDGHFGGLAIAPNLPSSFVLEVTFREILALNRSDLYDE</Hsp_hseq> + <Hsp_midline>+ D ++ G + G SS I AQ+P+ER++ ND++ V+DLYKNGL+ +A++ R TGD+RS R G+ N++ G V K + NIL+PR ++DV+++SHKFNDV SL+ RG + TG LS++AS A++GGLES+TQG AD EQ+Y +R+MY GA+NRTK +TW LTPR+V DL+ I+ IYE +YYSYG S A ++KS LD YK TF++ LTP+ + T+FE+ITSFLSNV VVSNP +W +RNFG TS FD R+++FGP QIQSIRFDK+P+G+F GLAIAPNLPS+F LE+T REIL LNR+ +Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>32</Hit_num> + <Hit_id>gi|37651665|ref|NP_932539.1|</Hit_id> + <Hit_def>baseplate subunit [Aeromonas phage 44RR2.8t] >gi|66391986|ref|YP_238911.1| baseplate tail tube cap [Aeromonas phage 31] >gi|34732965|gb|AAQ81502.1| baseplate tail tube cap [Aeromonas phage 44RR2.8t] >gi|62114823|gb|AAX63671.1| gp48 [Aeromonas phage 31]</Hit_def> + <Hit_accession>NP_932539</Hit_accession> + <Hit_len>342</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>362.073</Hsp_bit-score> + <Hsp_score>928</Hsp_score> + <Hsp_evalue>5.01898e-120</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>341</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>174</Hsp_identity> + <Hsp_positive>245</Hsp_positive> + <Hsp_gaps>14</Hsp_gaps> + <Hsp_align-len>351</Hsp_align-len> + <Hsp_qseq>IKVREL-DDKTDALISGV---KTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>MKVTELIDGGVQDVVKGILKGENPAGGSTPRQPLSKITIAQFPAERNAANDSTQDFNVNDLYKNGLLLSAFNYSGRQTGDLRSFRTDQ-----NNI-----GDYRKGVVKEAIANILMPKGQTDIDTINHKFNDVQQSLVERGNGSITGALSSMASHAVYGGLESITQGAFADRGEQVYIASRAMYAGAENRTKTYTWQLTPRNVYDLVEIIKIYEMLSYYSYGSVEKSNTANDIRKSVDAAYKETIINPLTPEATHGQTTMFERITSFLSNVNVVSNPIIWTIRNFGQSSSFDSRSDIFGPAQIQSIRFDKSPDGHFGGLAVAPNLPSSFVLEVTFREILALNRSDLYSE</Hsp_hseq> + <Hsp_midline>+KV EL D ++ G+ + AG S+ + AQ+P+ER+A ND++ V+DLYKNGLL +A++ + R TGD+RS R + N++ G V K + NIL+P+ ++D+++++HKFNDV SL+ RG G+ TG LS++AS AV+GGLES+TQG AD EQ+Y +R+MY GA+NRTK +TW LTPR+V DL+ II+IYE +YYSYG S A +++ +D YK T ++ LTP+ + T+FE+ITSFLSNV VVSNP +W +RNFG +S FD R+++FGP QIQSIRFDK+P+G+F GLA+APNLPS+F LE+T REIL LNR+ +Y+E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>33</Hit_num> + <Hit_id>gi|582955110|gb|AHI44678.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Acinetobacter phage ZZ1]</Hit_def> + <Hit_accession>AHI44678</Hit_accession> + <Hit_len>216</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>302.753</Hsp_bit-score> + <Hsp_score>774</Hsp_score> + <Hsp_evalue>1.69313e-98</Hsp_evalue> + <Hsp_query-from>138</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>213</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>139</Hsp_identity> + <Hsp_positive>171</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>213</Hsp_align-len> + <Hsp_qseq>ISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEA-NKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>MTRGNGSPTGILSNMASTAVFGAIESATQGAMADHGEQIYNTSRSMYAGAENRTKTYSWDLTPRTPEDLSQILKIYEIFNYLSYGMTGNSAFAKSIKDEIDNWYKKTFIKPINDATGTTTQSTVMESVTSFLSNVIVVSNPTVWFIQNFGTQSKYDGLADIFGPAQISNIRFEKTSDGNFNGLAIAPNMPSTFVLEVTFREILTLNRASLYGE</Hsp_hseq> + <Hsp_midline>++RG G+ TG+LSN+ASTAVFG +ES TQG MADH EQIYNT+RSMY GA+NRTK ++WDLTPR+ +DL I++IYE FNY SYG TG S +AK +K ++D WYK TF+ + TV E +TSFLSNVIVVSNPTVWF++NFGT SK+DG A++FGP QI +IRF+KT +GNFNGLAIAPN+PSTF LE+T REILTLNRAS+Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>34</Hit_num> + <Hit_id>gi|392973134|ref|YP_006489092.1|</Hit_id> + <Hit_def>putative split baseplate tail tube cap [Acinetobacter phage ZZ1]</Hit_def> + <Hit_accession>YP_006489092</Hit_accession> + <Hit_len>202</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>284.263</Hsp_bit-score> + <Hsp_score>726</Hsp_score> + <Hsp_evalue>1.55814e-91</Hsp_evalue> + <Hsp_query-from>152</Hsp_query-from> + <Hsp_query-to>349</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>199</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>131</Hsp_identity> + <Hsp_positive>159</Hsp_positive> + <Hsp_gaps>1</Hsp_gaps> + <Hsp_align-len>199</Hsp_align-len> + <Hsp_qseq>VASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANK-NDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVYAE</Hsp_qseq> + <Hsp_hseq>MASTAVFGAIESATQGAMADHGEQIYNTSRSMYAGAENRTKTYSWDLTPRTPEDLSQILKIYEIFNYLSYGMTGNSAFAKSIKDEIDNWYKKTFIKPINDATGTTTQSTVMESVTSFLSNVIVVSNPTVWFIQNFGTQSKYDGLADIFGPAQISNIRFEKTSDGNFNGLAIAPNMPSTFVLEVTFREILTLNRASLYGE</Hsp_hseq> + <Hsp_midline>+ASTAVFG +ES TQG MADH EQIYNT+RSMY GA+NRTK ++WDLTPR+ +DL I++IYE FNY SYG TG S +AK +K ++D WYK TF+ + TV E +TSFLSNVIVVSNPTVWF++NFGT SK+DG A++FGP QI +IRF+KT +GNFNGLAIAPN+PSTF LE+T REILTLNRAS+Y E</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>35</Hit_num> + <Hit_id>gi|294661512|ref|YP_003579965.1|</Hit_id> + <Hit_def>gp48 baseplate subunit [Klebsiella phage KP15] >gi|448260646|ref|YP_007348740.1| baseplate tail tube cap [Klebsiella phage KP27] >gi|292660673|gb|ADE34921.1| gp48 baseplate subunit [Klebsiella phage KP15] >gi|370343455|gb|AEX26584.1| baseplate tail tube cap [Klebsiella phage KP27]</Hit_def> + <Hit_accession>YP_003579965</Hit_accession> + <Hit_len>357</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>170.244</Hsp_bit-score> + <Hsp_score>430</Hsp_score> + <Hsp_evalue>1.23976e-45</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>347</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>353</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>111</Hsp_identity> + <Hsp_positive>191</Hsp_positive> + <Hsp_gaps>32</Hsp_gaps> + <Hsp_align-len>365</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALIS----GVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGD-MRSMRLGEMKRTANSVVKSITGT-------NTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYK---STFLDTLTPDE-----ANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVY</Hsp_qseq> + <Hsp_hseq>MKFSIIDDSINTLKNIKNRGIPSGGAAITESVLKQTIVTAEFPAQRAAGIDNA--YNASSLYNNGLLFTAYDFNGVGSKDNYRSLR--QAAQNPKQILSSATGNVKYKQVLNSSIGTMEPVCQILLPRSLNDNEVNSHRYQDANDSFLTKG-------LSRVVSNMVWGAVESISGGIMADRREALDVGTKAAFQGSDKRTKMYYNTFVIESRNDLLELIKIYYLFTVLGYGTTSGGT-AKEVAALVKQYYGVLGAKTANAISPSSNPVTASDFDNSLGNDVVDFISNVEVIKSPPVWFIRDFQSGDSLRLPHSTFGPAGITSVRFGRSIDNIVNTLRESPNTPISLEVEIQFMELIDMRQDSIF</Hsp_hseq> + <Hsp_midline>+K +DD + L + G+ + ++S ++ +TA++P++R+AG D + LY NGLLFTAYD N + D RS+R + + ++ S TG N++ PV ILLPRS +D E SH++ D DS +++G LS V S V+G +ES++ G+MAD E + ++ + G+D RTK++ S DL+ +I+IY F YG T T AKEV + + ++Y + + ++P ++ ++++ + F+SNV V+ +P VWF+R+F + FGP I S+RF ++ + N L +PN P + +EI E++ + + S++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>36</Hit_num> + <Hit_id>gi|66391556|ref|YP_239081.1|</Hit_id> + <Hit_def>gp48 baseplate [Enterobacteria phage RB43] >gi|62288644|gb|AAX78627.1| gp48 baseplate [Enterobacteria phage RB43] >gi|406718846|emb|CCL97571.1| protein of unknown function [Enterobacteria phage RB43] >gi|415434114|emb|CCK73954.1| protein of unknown function [Enterobacteria phage RB43]</Hit_def> + <Hit_accession>YP_239081</Hit_accession> + <Hit_len>361</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>168.703</Hsp_bit-score> + <Hsp_score>426</Hsp_score> + <Hsp_evalue>6.23176e-45</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>347</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>357</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>111</Hsp_identity> + <Hsp_positive>191</Hsp_positive> + <Hsp_gaps>36</Hsp_gaps> + <Hsp_align-len>369</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALI----SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYD----MNSRTTGDMRSMRLGEMKRTANSVVKSITGT-------NTNKVDKI-PVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKST---FLDTLTPDE-----ANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVY</Hsp_qseq> + <Hsp_hseq>MKIKVLQDTVQSFAEIKNAGIPSGGATTTKNALSQPIVTAEFPSQRAAGIDNA--YNASSLYNNGLLFTAYDFTGGLAPGSKDNYRSLR--QAAQNAKQILSANTGNVRYKQVLNTRTMGTLNPICQILLPRSLNDNEVNSHRYQDATDSIVAKG-------LSRAVSNVIWGAVESVSGGILADRREAIDIGTKAAFQGSDKRTKMYYNTFVIESRYDLLELIKIYYLFTVLGYGTTSGGTPA-ELAGLVKTAYNNTASKVANVFAPSSNQTTASDFNDSIGDQIVDFVSNVEVIKSPPVWFIRDFQTGDSLRFPHSTFGPAGITSVRFGRTMDNIVNTLRESPNTPISVEIEIQFMELIDMRQDSIF</Hsp_hseq> + <Hsp_midline>+K++ L D + +G+ + ++++A + +TA++PS+R+AG D + LY NGLLFTAYD + + + RS+R + + A ++ + TG NT + + P+ ILLPRS +D E SH++ D DS++++G LS S ++G +ES++ G++AD E I ++ + G+D RTK++ S DL+ +I+IY F YG T T A E+ + Y +T + P ++ ND++ ++I F+SNV V+ +P VWF+R+F T FGP I S+RF +T + N L +PN P + +EI E++ + + S++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>37</Hit_num> + <Hit_id>gi|509141759|ref|YP_008060624.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Escherichia phage Lw1] >gi|479258586|gb|AGJ71509.1| baseplate tail tube cap [Escherichia phage Lw1]</Hit_def> + <Hit_accession>YP_008060624</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>156.377</Hsp_bit-score> + <Hsp_score>394</Hsp_score> + <Hsp_evalue>2.35983e-40</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>347</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>360</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>106</Hsp_identity> + <Hsp_positive>187</Hsp_positive> + <Hsp_gaps>39</Hsp_gaps> + <Hsp_align-len>372</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALI----SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSR----TTGDMRSMRLGEMKRTANSVVKSITGT-------NTNKVDKI-PVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGET--GTSTYAKEVKSQLDEWYKSTFLDTL---------TPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVY</Hsp_qseq> + <Hsp_hseq>MKIKVLQDTVQSFAKIKNAGIPSGGATTTKNALTQPIVTAEFPSQRAAGIDNA--YNASSLYNNGLLFTAYEFTGGFAPGSKDNYRSLR--QAAQNAQQILSANTGNVRYKQVLNTRTMGTLNPICQILLPRSLNDNEVNSHRYQDATDSIVAKGP-------SRVVSNVIWGVIESASGGILADRREAVDVGTKAAFQGSDKRTKMYYNTFVIESRYDLLELIKIYYLFTVLGYGTTSGGTAAEIAELAKQTINKASTTGAKLINNAAAGNGPTPTVSN-GSIISDQMVDFVTNIEVIKSPPVWFIRDFQTGDSLRFPHSTFGPAGITSVRFGRTMDNIVNTLRESPNTPISVEIEIQFMELIDMRQDSIF</Hsp_hseq> + <Hsp_midline>+K++ L D + +G+ + ++++A + +TA++PS+R+AG D + LY NGLLFTAY+ + + RS+R + + A ++ + TG NT + + P+ ILLPRS +D E SH++ D DS++++G S V S ++G +ES + G++AD E + ++ + G+D RTK++ S DL+ +I+IY F YG T GT+ E+ Q +T + TP +N + +++ F++N+ V+ +P VWF+R+F T FGP I S+RF +T + N L +PN P + +EI E++ + + S++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>38</Hit_num> + <Hit_id>gi|304373651|ref|YP_003858396.1|</Hit_id> + <Hit_def>gp48 baseplate tail tube cap [Enterobacteria phage RB16] >gi|299829607|gb|ADJ55400.1| gp48 baseplate tail tube cap [Enterobacteria phage RB16]</Hit_def> + <Hit_accession>YP_003858396</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>155.221</Hsp_bit-score> + <Hsp_score>391</Hsp_score> + <Hsp_evalue>6.71724e-40</Hsp_evalue> + <Hsp_query-from>3</Hsp_query-from> + <Hsp_query-to>347</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>360</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>106</Hsp_identity> + <Hsp_positive>186</Hsp_positive> + <Hsp_gaps>39</Hsp_gaps> + <Hsp_align-len>372</Hsp_align-len> + <Hsp_qseq>IKVRELDDKTDALI----SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSR----TTGDMRSMRLGEMKRTANSVVKSITGT-------NTNKVDKI-PVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGET--GTSTYAKEVKSQLDEWYKSTFLDTL---------TPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVY</Hsp_qseq> + <Hsp_hseq>MKIKVLQDTVQSFAEIKNAGIPSGGATTTKNALTQPIVTAEFPSQRAAGIDNA--YNASSLYNNGLLFTAYEFTGGFAPGSKDNYRSLR--QAAQNAQQILSANTGNVRYKQVLNTRTMGTLNPICQILLPRSLNDNEVNSHRYQDATDSIVAKGP-------SRVVSNVIWGVIESASGGILADRREAVDVGTKAAFQGSDKRTKMYYNTFVIESRYDLLELIKIYYLFTVLGYGTTSGGTAAEIAELAKQTINKSSTTGAKLINNAVAGNGPTPTVSN-GSIISDQMVDFVINIEVIKSPPVWFIRDFQTGDSLRFPHSTFGPAGITSVRFGRTMDNIVNTLRESPNTPISVEIEIQFMELIDMRQDSIF</Hsp_hseq> + <Hsp_midline>+K++ L D + +G+ + ++++A + +TA++PS+R+AG D + LY NGLLFTAY+ + + RS+R + + A ++ + TG NT + + P+ ILLPRS +D E SH++ D DS++++G S V S ++G +ES + G++AD E + ++ + G+D RTK++ S DL+ +I+IY F YG T GT+ E+ Q +T + TP +N + +++ F+ N+ V+ +P VWF+R+F T FGP I S+RF +T + N L +PN P + +EI E++ + + S++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>39</Hit_num> + <Hit_id>gi|414086183|ref|YP_006986373.1|</Hit_id> + <Hit_def>baseplate tail tube cap [Cronobacter phage vB_CsaM_GAP161] >gi|378566508|gb|AFC22204.1| baseplate tail tube cap [Cronobacter phage vB_CsaM_GAP161]</Hit_def> + <Hit_accession>YP_006986373</Hit_accession> + <Hit_len>364</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>153.68</Hsp_bit-score> + <Hsp_score>387</Hsp_score> + <Hsp_evalue>2.64906e-39</Hsp_evalue> + <Hsp_query-from>17</Hsp_query-from> + <Hsp_query-to>347</Hsp_query-to> + <Hsp_hit-from>19</Hsp_hit-from> + <Hsp_hit-to>360</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>102</Hsp_identity> + <Hsp_positive>178</Hsp_positive> + <Hsp_gaps>43</Hsp_gaps> + <Hsp_align-len>358</Hsp_align-len> + <Hsp_qseq>SGVKTSAGQSSQSAKIKSTITAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYD----MNSRTTGDMRSMRLGEMKRTANSVVKSITGT-------NTNKVDKI-PVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLT--------------PDEANKNDTVF-EKITSFLSNVIVVSNPTVWFVRNFGTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASVY</Hsp_qseq> + <Hsp_hseq>AGIPSGGAATTKNALTQPIVTAEFPSQRAAGIDNA--YNASSLYNNGLLFTAYEFTGGLAPGSKDNYRSLR--QAAQNAQQILSANTGNVRYKQVLNSRTIGTLNPICQILLPRSLNDNEVNSHRYQDATDSIVAKGP-------SRVVSNVIWGAIESASGGILADRREAVDVGTKAAFQGSDKRTKMYYNTFVIESRYDLLELIKIYYLFTVLGYGTTSGGTAA-----EIAELAKQTINKSSTAGAKLINNAIAGNGPTPTVSNGSIISDQAVDFVTNIEVIKSPPVWFIRDFQTGDSLRFPHSTFGPAGITSVRFGRTMDNIVNTLRESPNTPIAVEIEIQFMELIDMRQDSIF</Hsp_hseq> + <Hsp_midline>+G+ + ++++A + +TA++PS+R+AG D + LY NGLLFTAY+ + + + RS+R + + A ++ + TG N+ + + P+ ILLPRS +D E SH++ D DS++++G S V S ++G +ES + G++AD E + ++ + G+D RTK++ S DL+ +I+IY F YG T T A ++ E K T + T P N ++ ++ F++N+ V+ +P VWF+R+F T FGP I S+RF +T + N L +PN P +EI E++ + + S++</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>40</Hit_num> + <Hit_id>gi|392973135|ref|YP_006489093.1|</Hit_id> + <Hit_def>putative split baseplate tail tube cap [Acinetobacter phage ZZ1]</Hit_def> + <Hit_accession>YP_006489093</Hit_accession> + <Hit_len>143</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>107.071</Hsp_bit-score> + <Hsp_score>266</Hsp_score> + <Hsp_evalue>1.55074e-24</Hsp_evalue> + <Hsp_query-from>22</Hsp_query-from> + <Hsp_query-to>136</Hsp_query-to> + <Hsp_hit-from>19</Hsp_hit-from> + <Hsp_hit-to>143</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>59</Hsp_identity> + <Hsp_positive>80</Hsp_positive> + <Hsp_gaps>10</Hsp_gaps> + <Hsp_align-len>125</Hsp_align-len> + <Hsp_qseq>SAGQSSQSAKIKSTI-TAQYPSERSAGNDTSGSLRVHDLYKNGLLFTAYDMNSRTTGDMRSMRLGEMK-----RTANSVVKSITG----TNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDS</Hsp_qseq> + <Hsp_hseq>SAGQSQKSKETKTKIMTAQFPAERAASVDTTNAAEVGQNYQNGLLFTAYEYTSRTTPDLRSMRQRVQKSYKVLESTQKILSAVAGVSGQTEGRSTSKAPVANILMPRSKTDSDNTSHKFNDVGES</Hsp_hseq> + <Hsp_midline>SAGQS +S + K+ I TAQ+P+ER+A DT+ + V Y+NGLLFTAY+ SRTT D+RSMR K + ++ ++ G T K PV NIL+PRSK+D ++ SHKFNDVG+S</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>41</Hit_num> + <Hit_id>gi|646519388|ref|WP_025548737.1|</Hit_id> + <Hit_def>hypothetical protein [Vibrio parahaemolyticus] >gi|655769907|gb|KEE53216.1| hypothetical protein EM88_01435 [Vibrio parahaemolyticus] >gi|655811799|gb|KEE89780.1| hypothetical protein EM91_01710 [Vibrio parahaemolyticus]</Hit_def> + <Hit_accession>WP_025548737</Hit_accession> + <Hit_len>356</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>60.8474</Hsp_bit-score> + <Hsp_score>146</Hsp_score> + <Hsp_evalue>3.83249e-07</Hsp_evalue> + <Hsp_query-from>87</Hsp_query-from> + <Hsp_query-to>346</Hsp_query-to> + <Hsp_hit-from>109</Hsp_hit-from> + <Hsp_hit-to>342</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>65</Hsp_identity> + <Hsp_positive>105</Hsp_positive> + <Hsp_gaps>44</Hsp_gaps> + <Hsp_align-len>269</Hsp_align-len> + <Hsp_qseq>MKRTANSVVKSITGTNTNKVDKIPVVNILLPRSKSDVESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNT-ARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNF--------GTTSKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRASV</Hsp_qseq> + <Hsp_hseq>MPLLQDSLVHDIGGS----VDDITSVALAAGLDVADLEGDLSKLSSGVKSLVQNAKDITVGTVSQQAG-------QGSRQSTLASGNKVIQNNPGTDSWQGTQLREQTLIWQFNPKSLPELKAVASIIKTFKLLSLGSIGNSS------------------NELT--QANNNDRLNNPYGHIAS---CIKTPPLWFLEEVSDYYTGQDGAGARYTDRL-VFGPAAIASIKVNRTPDQYWKTFKGTAGDPASLDLEITFIELLPLDKETV</Hsp_hseq> + <Hsp_midline>M +S+V I G+ VD I V + +D+E K + SL+ G +S A + Q +A N+ I N + G R + W P+S+ +L A+ I + F S G G S+ + LT +AN ND + S + P +WF+ G +++ R VFGP I SI+ ++TP+ + P++ LEIT E+L L++ +V</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>42</Hit_num> + <Hit_id>gi|589286464|ref|YP_009006262.1|</Hit_id> + <Hit_def>tail-tube assembly protein [Vibrio phage VH7D] >gi|432142395|gb|AGB06975.1| tail-tube assembly protein [Vibrio phage VH7D]</Hit_def> + <Hit_accession>YP_009006262</Hit_accession> + <Hit_len>378</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>58.5362</Hsp_bit-score> + <Hsp_score>140</Hsp_score> + <Hsp_evalue>2.65852e-06</Hsp_evalue> + <Hsp_query-from>60</Hsp_query-from> + <Hsp_query-to>344</Hsp_query-to> + <Hsp_hit-from>61</Hsp_hit-from> + <Hsp_hit-to>339</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>73</Hsp_identity> + <Hsp_positive>122</Hsp_positive> + <Hsp_gaps>50</Hsp_gaps> + <Hsp_align-len>307</Hsp_align-len> + <Hsp_qseq>YKNGLLFTAYDMNSRTTGDMRSMR----------------LGEMKRTANSVVKSITGTNTNKVDKIP--VVNILLPRSKSDV--ESVSHKFNDVGDSLISRGGGTATGVLSNVASTAVFGGLESLTQGLMADHNEQIYNTARSMYGGADNRTKVFTWDLTPRSVQDLIAIIEIYEYFNYYSYGETGTSTYAKEVKSQLDEWYKSTFLDTLTPDEANKNDTVFEKITSFLSNVIVVSNPTVWFVRNFGTT--SKFDGRAEVFGPCQIQSIRFDKTPNGNFNGLAIAPNLPSTFTLEITMREILTLNRA</Hsp_qseq> + <Hsp_hseq>HPNFFIFRAYDLAHTTKQHYTDMRSSFTAAQTENEQSGEVPSELKATLALYAPNIVEEVSHEYDKTPTSVLNDFLASAASAAGSDTVSEGVDRGKRAVATAAGATLAQIKRSFIQSNAAGQLEK-NSSVVTD------NVTVTAYKGTAQRTQTMVYQFHPKSLDELKVVAEIIKTF----YG------LSLPVKGQID----SQLLDTGTANLGSGFAAGFAKYATLLKT------PPVWMIEEVSDTDATRYTPRF-IFGPAGITSVKLNRTPDQYWRTFRGTAGDPAGIELEITFSELIPLDRA</Hsp_hseq> + <Hsp_midline>+ N +F AYD+ T MR E+K T +I +++ DK P V+N L + S ++VS + ++ + G T + + + G LE ++ D N + Y G RT+ + P+S+ +L + EI + F YG + VK Q+D S LDT T + + F K + L P VW + T +++ R +FGP I S++ ++TP+ + P+ LEIT E++ L+RA</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +</Iteration_hits> + <Iteration_stat> + <Statistics> + <Statistics_db-num>48094830</Statistics_db-num> + <Statistics_db-len>17186091396</Statistics_db-len> + <Statistics_hsp-len>148</Statistics_hsp-len> + <Statistics_eff-space>2043815480868</Statistics_eff-space> + <Statistics_kappa>0.041</Statistics_kappa> + <Statistics_lambda>0.267</Statistics_lambda> + <Statistics_entropy>0.14</Statistics_entropy> + </Statistics> + </Iteration_stat> +</Iteration> +<Iteration> + <Iteration_iter-num>5</Iteration_iter-num> + <Iteration_query-ID>Query_5</Iteration_query-ID> + <Iteration_query-def>Merlin_5</Iteration_query-def> + <Iteration_query-len>576</Iteration_query-len> +<Iteration_hits> +<Hit> + <Hit_num>1</Hit_num> + <Hit_id>gi|456351275|ref|YP_007501227.1|</Hit_id> + <Hit_def>baseplate hub [Salmonella phage S16] >gi|347466340|gb|AEO97126.1| baseplate hub [Salmonella phage S16] >gi|408387124|gb|AFU64133.1| baseplate hub [Salmonella phage STML-198]</Hit_def> + <Hit_accession>YP_007501227</Hit_accession> + <Hit_len>577</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>675.626</Hsp_bit-score> + <Hsp_score>1742</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>577</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>345</Hsp_identity> + <Hsp_positive>442</Hsp_positive> + <Hsp_gaps>3</Hsp_gaps> + <Hsp_align-len>578</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPE--NNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKTENMTSFRRRKVIADSKGERDAAAAASNQVESLDSIGYKLDSVQSATELTSEVIEQKSNDIISAVNDTTAGVELTAEFAENTSKTVRELTDVTSAISDKISKLTDMLEQKIQAVQQKFVDSSKVTDDTLKVIGDSIPEPVESNLPAIPEKIFDKPEENNS-PDADFFPTLPSKAEEVDNKKDSDKKILDTENLLKDLVGTTKTGFKATVSITDKISNMLFKYTVSALAESAKLAGTIFAIVLGIDLLRAHFKYWSDKFSSNFDEFSQSAGEWGSLLQSVLGSLQEIKKFWENNDWSGLAVAIVKGLADVLYNLSELMSLGISKISAAILSALGFDNAALSIKGAALEGFQARTGNELNEEDQDTLARYQTRRIQEGPDAFDKFSEYKTRAFDFITGRDNKNTTTTEQEREAEVKKLKSLPEEELNEINKKSNNARAALVRFEKYMGDVDPENATNIESLDKAYNNVKSLVNDSELNKAPAIKKELEVRLQKAEARYQKIKTESKPEPAAPSASEDVQKVQNIEKAEQAKKSDANQSSSSSVVNAQVNNVNNSRTIQTINPVTATPAPGVFKATGVN</Hsp_hseq> + <Hsp_midline>MK+ENM++ RRRKVIADSKGERDAA+ AS+QV+SL+ IG KLD VQSA EL +EVIE+K N++I +V++ G EL AE +E T+++++ LT V S ISDK+SKL MLE K+QAV+QK +S L VI D +P+P E P +PE+I ++NN+ PD DFFP +P + E +NKKD K ++L DL+ TTK GFKAT+SITDKIS+MLFKYTV+ALAE+AK+A +FA+VLGIDLLR HFKYW+DKF SNFDEFS AGEWG LLQS+ G L +IKKFWE DWSGLAVAIVKGLADV+YNLSE+MSLGISKISA+IL ALGF+NAA +I+G+ALEGFQ RTGN L+E+DQ LA+YQ++RI+EGP DK E+KTRAFD++ GR+NK +T +R+ E + LK++ E+ E K N ARAA+ R EKY+GDVDPEN TN++SL+KAYN+ K ++DS ++ PA KKEL+ R Q+ E++YQK+K ++ P+PAAP+ SED Q+VQNI+KAE AK+ + +V N QVNNVNNS+TI + VTATPAPGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>2</Hit_num> + <Hit_id>gi|589889938|ref|YP_009005474.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Enterobacter phage PG7] >gi|583927851|gb|AHI61113.1| baseplate hub subunit tail length determinator [Enterobacter phage PG7]</Hit_def> + <Hit_accession>YP_009005474</Hit_accession> + <Hit_len>586</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>549.28</Hsp_bit-score> + <Hsp_score>1414</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>586</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>297</Hsp_identity> + <Hsp_positive>414</Hsp_positive> + <Hsp_gaps>20</Hsp_gaps> + <Hsp_align-len>591</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAE-------GTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPE---RILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDD--KKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANT-QVNNV-NNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKTENMKTMRR-KVIEEGRSERDAAKAASTQAESLSVLSSQLDDLQTQAELTSEVIEDKGNQVIDALNRVDQSIIDTTAGAELTAEASERTTEAVKQQTEVSNKISDKLSKLTELLNERLSAITPNLPQISV-PDTSLSVVEDAVPV--DIVTPGLPELLQELIPDPVNNTNNPNDAFFPTVPENPESDSKKGADEERKKKDSDTLSNLLKATKSGFKASMSITDRIAGMLFKYTVTAVIEAAKTAALLFSIVLGIDVIMKHFKYWSDKFTSDFDKFSAEAGEWGSTLSSIFGTLENIQKFWEAGDWSGLTVAIVKGVTEIIYNLSELISLGMSKVAAAILSIIPGLGDAALSVEGAALEGFQERTGNSLSKEDQDTLAKYQSSKIEKGENFFDKVSQGKTWIVNKITGDANISDFVTDEERESQNEKLRQMKPEEREQVLKKGNEARAAIVRFEKYMEQINPDDKRSVESADKAYANLQTQLNDTDLNNSPVTKKELSARMNIVTAKYDKLK-GKEPQPAPSSQSEDVKKVESIEKNKAAKEASLGTSAGAAAANLFNTNNVINNSRTINTVSPVTSTNAPGVFGATGVN</Hsp_hseq> + <Hsp_midline>MK+ENM TMRR KVI + + ERDAA AS Q +SL ++ +LDD+Q+ EL +EVIE+KGN +ID+++ V + G EL AEASERTTE++K T V++ ISDKLSKL +L ++ A+ + + T LSV+ED +P + +PGLPE ++P +N N P++ FFP VP+ PE++ K ++ KK +D L +LLK TK GFKA++SITD+I+ MLFKYTVTA+ EAAK AA+LF++VLGID++ HFKYW+DKF S+FD+FSAEAGEWG L SIFG L +I+KFWEAGDWSGL VAIVKG+ ++IYNLSE++SLG+SK++A+IL + G +AA ++ G+ALEGFQERTGNSLS++DQ LAKYQS +IE+G DK + KT + + G N D +R+ + + L+ M PE+RE+ L K NEARAA+ R EKY+ ++P++ +++S +KAY + + ++D+ +++ P TKKEL R V +KY KLK P+PA + SED ++V++I+K + AKE S ++ AN NNV NNS+TI+ V VT+T APGVFGATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>3</Hit_num> + <Hit_id>gi|311993187|ref|YP_004010053.1|</Hit_id> + <Hit_def>gp29 base plate hub subunit, tail length determinator [Enterobacteria phage CC31] >gi|284178025|gb|ADB81691.1| gp29 base plate hub subunit, tail length determinator [Enterobacteria phage CC31]</Hit_def> + <Hit_accession>YP_004010053</Hit_accession> + <Hit_len>586</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>546.584</Hsp_bit-score> + <Hsp_score>1407</Hsp_score> + <Hsp_evalue>0</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>586</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>296</Hsp_identity> + <Hsp_positive>412</Hsp_positive> + <Hsp_gaps>22</Hsp_gaps> + <Hsp_align-len>592</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAE-------GTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPE---RILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDD--KKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQK---AENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKTENMKTMRR-KVIEEGRSERDAAKAASTQAESLSVLSSQLDDLQTQAELTSEVIEDKGNQVIDALNRVDQSIIDTTAGAELTAEASERTTEAVKQQTEVSNKISDKLSKLTELLNERLSAITPNLPQISV-PDTSLSVVEDAVPV--DIVTPGLPELLQELIPDPVNNTNNPNDAFFPTVPENPESDSKKGADEERKKKDSDTLSNLLKATKSGFKASMSITDRIAGMLFKYTVTAVIEAAKTAALLFSIVLGIDVIMKHFKYWSDKFTSDFDKFSAEAGEWGSTLSSIFGTLENIQKFWEAGDWSGLTVAIVKGVTEIIYNLSELISLGMSKVAAAILSLIPGLGDAALSVEGAALEGFQERTGNSLSKEDQDTLAKYQSSKIEKGENFFDKVSQGKTWIVNKITGDANISDFVTDEERTAQNEKLRQMKPEEREQVLKKGNEARAAIVRFEKYMEQINPDDKRSVQSADKAYANLQTQLNDTDLNNSPITKKELNARMNIVTAKYDKLK-GKEPQPAPSSQSEDVKKVESIEKNKAAEKASLGTGAGAAAANLFNTN-NVINNSRTINTVSPVTSTNAPGVFGATGVN</Hsp_hseq> + <Hsp_midline>MK+ENM TMRR KVI + + ERDAA AS Q +SL ++ +LDD+Q+ EL +EVIE+KGN +ID+++ V + G EL AEASERTTE++K T V++ ISDKLSKL +L ++ A+ + + T LSV+ED +P + +PGLPE ++P +N N P++ FFP VP+ PE++ K ++ KK +D L +LLK TK GFKA++SITD+I+ MLFKYTVTA+ EAAK AA+LF++VLGID++ HFKYW+DKF S+FD+FSAEAGEWG L SIFG L +I+KFWEAGDWSGL VAIVKG+ ++IYNLSE++SLG+SK++A+IL + G +AA ++ G+ALEGFQERTGNSLS++DQ LAKYQS +IE+G DK + KT + + G N D +R + + L+ M PE+RE+ L K NEARAA+ R EKY+ ++P++ ++QS +KAY + + ++D+ +++ P TKKEL+ R V +KY KLK P+PA + SED ++V++I+K AE A + N+ NT N +NNS+TI+ V VT+T APGVFGATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>4</Hit_num> + <Hit_id>gi|422934607|ref|YP_007004568.1|</Hit_id> + <Hit_def>phage baseplate hub [Enterobacteria phage ime09] >gi|339791390|gb|AEK12447.1| phage baseplate hub [Enterobacteria phage ime09]</Hit_def> + <Hit_accession>YP_007004568</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>447.588</Hsp_bit-score> + <Hsp_score>1150</Hsp_score> + <Hsp_evalue>1.35305e-146</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>267</Hsp_identity> + <Hsp_positive>374</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKSTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKDAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMTAMILAVVVGIDLLMVHFKYWSDKFSQAWDLFSTDFTKFSSETGTWGPLLQSIFSSIDEIKKFWEAGDWGGLTVAIVEGLGKVLYNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNDDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKKD + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + +IKKFWEAGDW GL VAIV+GL V+YNL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ + G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>5</Hit_num> + <Hit_id>gi|228861124|ref|YP_002854147.1|</Hit_id> + <Hit_def>gp29 base plate hub [Enterobacteria phage RB51] >gi|227438798|gb|ACP31110.1| gp29 base plate hub [Enterobacteria phage RB51] >gi|291290410|dbj|BAI83205.1| baseplate hub subunit/tail length determinator [Enterobacteria phage AR1]</Hit_def> + <Hit_accession>YP_002854147</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>442.965</Hsp_bit-score> + <Hsp_score>1138</Hsp_score> + <Hsp_evalue>9.14277e-145</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>264</Hsp_identity> + <Hsp_positive>378</Hsp_positive> + <Hsp_gaps>49</Hsp_gaps> + <Hsp_align-len>606</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLP----DPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIVGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTG----TSLAVVENAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPIEPKQESPEEKQKRDAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMVALIMAVVIGIDLLMVHFKYWSDKFSKAWDLFSTDFTKFSSETGTWGPLLQSIFDSIDEIKKFWEAGDWGGLTVAIVEGLGSVLYNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNDDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSIEAAHEDLKKRMNDPDLNNSPAVKKELASRFAKIDATYQELKK-NQPEAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFGATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N ++ ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G T L+V+E+ +P + D ES G +LP + NN PD DFFP P P EP E+ ++ QK+D + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM A++ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + +IKKFWEAGDW GL VAIV+GL V+YNL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ + G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E A+ KK ++D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVFGATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>6</Hit_num> + <Hit_id>gi|422934972|ref|YP_007004932.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Escherichia phage wV7] >gi|343177526|gb|AEM00852.1| baseplate hub subunit tail length determinator [Escherichia phage wV7]</Hit_def> + <Hit_accession>YP_007004932</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>442.58</Hsp_bit-score> + <Hsp_score>1137</Hsp_score> + <Hsp_evalue>1.58375e-144</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>263</Hsp_identity> + <Hsp_positive>378</Hsp_positive> + <Hsp_gaps>49</Hsp_gaps> + <Hsp_align-len>606</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLP----DPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIVGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTG----TSLAVVENAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPIEPKQESPEEKQKRDAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMVALIMAVVIGIDLLMVHFKYWSDKFSKAWDLFSTDFTKFSSETGTWGPLLQSIFDSIDEIKKFWEAGDWGGLTVAIIEGLGSVLYNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNDDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSIEAAHEDLKKRMNDPDLNNSPAVKKELASRFAKIDATYQELKK-NQPEAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFGATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N ++ ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G T L+V+E+ +P + D ES G +LP + NN PD DFFP P P EP E+ ++ QK+D + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM A++ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + +IKKFWEAGDW GL VAI++GL V+YNL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ + G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E A+ KK ++D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVFGATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>7</Hit_num> + <Hit_id>gi|604671901|gb|AHV82895.1|</Hit_id> + <Hit_def>baseplate hub subunit, tail length determinator [Escherichia phage vB_EcoM_PhAPEC2]</Hit_def> + <Hit_accession>AHV82895</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>441.425</Hsp_bit-score> + <Hsp_score>1134</Hsp_score> + <Hsp_evalue>3.83095e-144</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>269</Hsp_identity> + <Hsp_positive>375</Hsp_positive> + <Hsp_gaps>30</Hsp_gaps> + <Hsp_align-len>598</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSV-------DNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLP-DPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKD-DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMS-------NFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEF----KTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKE-DNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQT-VTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKPEEMKSMRRNKVIADNKPQKVAATAATDSLEALNNISSKLDDVQAASELTSQSVEDKGNGIIESIGDLKNSTDNTAEGTELIAEVIEKQTEVTKSINEVSSAISSKLDRLATLLEQKLQ-TSTAIQNTGG---TSLEVIENAIPVKVVENETSDELFKALPTPEKIDNKPDEDFFPVPVQESANSTSDSKGGISFKLSDKIAMLTKTVQTGFNKSISISDRIAGMLFKYTITAAIEAAKMAALILGIVIGIDLLIVHFKYWTDKFTSAWDLFDENFTKFSDEAKEWGKFLSDIFTSIDSIKQLWEAGDWGGLTVAIVKGVGTALMNLGELIQLGMAKLSASILRAIGFGDTADEIEGRALEGFQETTGNKLKKEDQEKVAKYQMKRDDGELGTVSKGLDMLQRGKTFVTNWVRGNDNKEEFSTSDERAAESAKLKELPEEERKEAYIKANETRAALVRFEDYIDKIDMTNPENAKNVEKSYADLSKLIKDPELNKTPVVKKELDARFEKLNNKMAEAKKAQTTVKPESSSKSPEAKQVQSIEKGRAS--ESKQQQPVAAISNT--NNVVKKNTVVQNMTPVTSTTAPGIFHATGVN</Hsp_hseq> + <Hsp_midline>MK E M +MRR KVIAD+K ++ AA+ A+D +++L I KLDDVQ+A+EL ++ +E+KGN +I+S+ DN AEGTEL AE E+ TE K++ V+S IS KL +LA++LE K+Q +Q +G T L VIE+ +P E E+ + LP + +N PDEDFFP QE N+ D K K +D + L KT + GF +ISI+D+I+ MLFKYT+TA EAAKMAA++ +V+GIDLL +HFKYWTDKF S NF +FS EA EWG L IF + IK+ WEAGDW GL VAIVKG+ + NL E++ LG++K+SASIL A+GF + A I G ALEGFQE TGN L ++DQ+ +AKYQ KR + G + K + KT +WV G +NK + + + +R E+ LK + E+R+E IK NE RAA+ R E YI +D NP N +++EK+Y K I D ++ P KKELD RF+++ +K + K+ T KP + + S + ++VQ+I+K + +SK+ ++NT NNV T+ Q T VT+T APG+F ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>8</Hit_num> + <Hit_id>gi|32453687|ref|NP_861896.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit, tail length determinator [Enterobacteria phage RB69] >gi|32350506|gb|AAP76105.1| gp29 baseplate hub subunit, tail length determinator [Enterobacteria phage RB69]</Hit_def> + <Hit_accession>NP_861896</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>441.425</Hsp_bit-score> + <Hsp_score>1134</Hsp_score> + <Hsp_evalue>4.26665e-144</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>270</Hsp_identity> + <Hsp_positive>376</Hsp_positive> + <Hsp_gaps>34</Hsp_gaps> + <Hsp_align-len>600</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSV-------DNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLP-DPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKD-DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMS-------NFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEF----KTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKE-DNTPKPAAPATSEDNQRVQNIQK--AENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQT-VTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKPEEMKSMRRNKVIADNKPQKVAATAATDSLEALNNISSKLDDVQAASELTSQSVEDKGNGIIESIGDLKNSTDNTAEGTELIAEVIEKQTEVTKSINEVSSAISSKLDRLATLLEQKLQ-TSTAIQNTGG---TSLEVIENAIPVKVVENETSDELFKAFPTPEKIDNKPDEDFFPTPVQESANSTSDSKGGISFKLSDKIAMLTKTVQTGFNKSISISDRIAGMLFKYTITAAIEAAKMAALILGIVIGIDLLIVHFKYWTDKFTSAWDLFDENFTKFSDEAKEWGKFLSDIFTSIDSIKQLWEAGDWGGLTVAIVKGVGTALMNLGELIQLGMAKLSASILRAIGFGDTADEIEGRALEGFQETTGNKLKKEDQEKVAKYQMKRDDGELGTVSKGLDMLQRGKTFVTNWVRGNDNKEEFSTSDERAAESAKLKELPEEERKEAYIKANETRAALVRFEDYIDKIDMTNPENAKNVEKSYADLSKLIKDPELNKTPVVKKELDARFEKLNNKMAEAKKAQTTVKPESSSKSPEAKQVQSIEKGRASESKQQQPVAT----ISNT--NNVVKKNTVVQNMTPVTSTTAPGIFHATGVN</Hsp_hseq> + <Hsp_midline>MK E M +MRR KVIAD+K ++ AA+ A+D +++L I KLDDVQ+A+EL ++ +E+KGN +I+S+ DN AEGTEL AE E+ TE K++ V+S IS KL +LA++LE K+Q +Q +G T L VIE+ +P E E+ + P + +N PDEDFFP QE N+ D K K +D + L KT + GF +ISI+D+I+ MLFKYT+TA EAAKMAA++ +V+GIDLL +HFKYWTDKF S NF +FS EA EWG L IF + IK+ WEAGDW GL VAIVKG+ + NL E++ LG++K+SASIL A+GF + A I G ALEGFQE TGN L ++DQ+ +AKYQ KR + G + K + KT +WV G +NK + + + +R E+ LK + E+R+E IK NE RAA+ R E YI +D NP N +++EK+Y K I D ++ P KKELD RF+++ +K + K+ T KP + + S + ++VQ+I+K A +K+Q +T ++NT NNV T+ Q T VT+T APG+F ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>9</Hit_num> + <Hit_id>gi|642905806|ref|YP_009037575.1|</Hit_id> + <Hit_def>baseplate hub subunit, tail length determinator [Escherichia phage vB_EcoM_JS09] >gi|642903960|gb|AIA79980.1| baseplate hub subunit, tail length determinator [Escherichia phage vB_EcoM_JS09]</Hit_def> + <Hit_accession>YP_009037575</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>441.039</Hsp_bit-score> + <Hsp_score>1133</Hsp_score> + <Hsp_evalue>6.28771e-144</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>267</Hsp_identity> + <Hsp_positive>375</Hsp_positive> + <Hsp_gaps>30</Hsp_gaps> + <Hsp_align-len>598</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSV-------DNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLP-DPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKD-DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMS-------NFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEF----KTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKE-DNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQT-VTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKPEEMKSMRRNKVIADNKPQKVAATAATDSLEALNDISSKLDDVQAASELTSQSVEDKGNGIIESIGDLKNSTDNTAEGTELIAEVIEKQTEVTKSINEVSSAISSKLDRLATLLEQKLQ-TSTAIQNTGG---TSLEVIENAIPVKVVENETSDELFKAFPTPEKIDNKPDEDFFPAPVQESANSTSDSKGGISFKLSDKIAMLTKTVQTGFNKSISISDRIAGMLFKYTITAAIEAAKLAALILGIVIGIDLLIVHFKYWTDKFTSAWDLFDENFTKFSDEAKEWGKFLSDIFTSIDSIKQLWEAGDWGGLTVAIVKGVGTALMNLGELIQLGMAKLSASILRAIGFGDTADEIEGRALEGFQETTGNTLKKEDQEKVAKYQMKRDDGELGTVSKGLDMLQRGKTFVTNWVRGNDNKEEFSTSDERAAESAKLKELPEEERKEAYIKANETRAALVRFEDYIDKIDMTNPENAKNVEKSYADLSKLIKDPELNKTPVVKKELDARFEKLNNKMAEAKKAQTTVKPESSSKSPEAKQVQSIEKGRAS--ESKQQQPVAAISNT--NNVVKKNTVVQNMTPVTSTTAPGIFHATGVN</Hsp_hseq> + <Hsp_midline>MK E M +MRR KVIAD+K ++ AA+ A+D +++L I KLDDVQ+A+EL ++ +E+KGN +I+S+ DN AEGTEL AE E+ TE K++ V+S IS KL +LA++LE K+Q +Q +G T L VIE+ +P E E+ + P + +N PDEDFFP QE N+ D K K +D + L KT + GF +ISI+D+I+ MLFKYT+TA EAAK+AA++ +V+GIDLL +HFKYWTDKF S NF +FS EA EWG L IF + IK+ WEAGDW GL VAIVKG+ + NL E++ LG++K+SASIL A+GF + A I G ALEGFQE TGN+L ++DQ+ +AKYQ KR + G + K + KT +WV G +NK + + + +R E+ LK + E+R+E IK NE RAA+ R E YI +D NP N +++EK+Y K I D ++ P KKELD RF+++ +K + K+ T KP + + S + ++VQ+I+K + +SK+ ++NT NNV T+ Q T VT+T APG+F ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>10</Hit_num> + <Hit_id>gi|228861505|ref|YP_002854526.1|</Hit_id> + <Hit_def>gp29 base plate hub [Enterobacteria phage RB14] >gi|227438521|gb|ACP30834.1| gp29 base plate hub [Enterobacteria phage RB14]</Hit_def> + <Hit_accession>YP_002854526</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>438.343</Hsp_bit-score> + <Hsp_score>1126</Hsp_score> + <Hsp_evalue>7.24825e-143</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>263</Hsp_identity> + <Hsp_positive>371</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMTAMILAVVVGIDLLMVHFKYWSDKFSKAWDLFNTDFTKFSSETGTWGPLLQSIFDSIDKIKQLWEAGDWGGLTAAIVEGLGSVLFNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNGDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFGATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + IK+ WEAGDW GL AIV+GL V++NL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVFGATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>11</Hit_num> + <Hit_id>gi|414086558|ref|YP_006986747.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Enterobacteria phage vB_EcoM_ACG-C40] >gi|383396339|gb|AFH20155.1| baseplate hub subunit tail length determinator [Enterobacteria phage vB_EcoM_ACG-C40]</Hit_def> + <Hit_accession>YP_006986747</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>437.958</Hsp_bit-score> + <Hsp_score>1125</Hsp_score> + <Hsp_evalue>8.89384e-143</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>263</Hsp_identity> + <Hsp_positive>372</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPVQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLAVVESAIPVKVVEDDTAEFVG---PLLPAPEAVNNDPDADFFPAPQPVEPKRESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMVALIMAVVIGIDLLMVHFKYWSDKFSKAWDLFSTDFKTFSSETGTWGPLLQSIFESIDEIKKFWEAGDWGGLTVAIVEGLGKVLYNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNGDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSIEAAHEDLKKRMNDPDLNNSPAVKKELASRFAKIDATYQELKK-NQPEAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFGATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G S + S I K+ + D E G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM A++ A+V+GIDLL +HFKYW+DKF ++F FS+E G WG LLQSIF + +IKKFWEAGDW GL VAIV+GL V+YNL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E A+ KK ++D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVFGATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>12</Hit_num> + <Hit_id>gi|9632606|ref|NP_049805.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit, tail length determinator [Enterobacteria phage T4] >gi|137988|sp|P13337.1|VG29_BPT4 RecName: Full=Tail-tube assembly protein Gp29; AltName: Full=Folylpolyglutamate synthase; AltName: Full=Tail length regulator; AltName: Full=Tetrahydrofolylpolyglutamate synthase [Enterobacteria phage T4] >gi|5354230|gb|AAD42437.1|AF158101_24 gp29 baseplate hub subunit, tail length determinator [Enterobacteria phage T4] >gi|215946|gb|AAA32538.1| tail-tube assembly protein [Enterobacteria phage T4]</Hit_def> + <Hit_accession>NP_049805</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>437.573</Hsp_bit-score> + <Hsp_score>1124</Hsp_score> + <Hsp_evalue>1.07961e-142</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>264</Hsp_identity> + <Hsp_positive>372</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVESAVSDTSAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMTAMILAVVVGIDLLMIHFKYWSDKFSKAWDLFSTDFTKFSSETGTWGPLLQSIFDSIDKIKQLWEAGDWGGLTVAIVEGLGKVLFNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNGDLGPIAEGLDKISNWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV + SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM AM+ A+V+GIDLL IHFKYW+DKF ++F +FS+E G WG LLQSIF + IK+ WEAGDW GL VAIV+GL V++NL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>13</Hit_num> + <Hit_id>gi|525334458|gb|AGR46140.1|</Hit_id> + <Hit_def>baseplate hub subunit [Yersinia phage PST]</Hit_def> + <Hit_accession>AGR46140</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>437.187</Hsp_bit-score> + <Hsp_score>1123</Hsp_score> + <Hsp_evalue>1.95194e-142</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>267</Hsp_identity> + <Hsp_positive>373</Hsp_positive> + <Hsp_gaps>47</Hsp_gaps> + <Hsp_align-len>605</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNV-------AEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVEGAVSDTTAGSELIAETVEIGNNINKE---IGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKDAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMTAMILAVVVGIDLLMVHFKYWSDKFSKAWDLFNTDFTKFSSETGTWGPLLQSIFDSIDKIKQLWEAGDWGGLTVAIIEGLGKVLFNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNGDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV G+EL AE E K + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKKD + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + IK+ WEAGDW GL VAI++GL V++NL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>14</Hit_num> + <Hit_id>gi|299780553|gb|ADJ39915.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Enterobacteria phage T4T]</Hit_def> + <Hit_accession>ADJ39915</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>437.187</Hsp_bit-score> + <Hsp_score>1123</Hsp_score> + <Hsp_evalue>2.03785e-142</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>264</Hsp_identity> + <Hsp_positive>371</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMTAMILAVVVGIDLLMIHFKYWSDKFSKAWDLFSTDFTKFSSETGTWGPLLQSIFDSIDKIKQLWEAGDWGGLTVAIVEGLGKVLFNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNGDLGPIAEGLDKISNWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM AM+ A+V+GIDLL IHFKYW+DKF ++F +FS+E G WG LLQSIF + IK+ WEAGDW GL VAIV+GL V++NL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>15</Hit_num> + <Hit_id>gi|330858710|ref|YP_004415085.1|</Hit_id> + <Hit_def>putative baseplate hub subunit and tail length determinator [Shigella phage Shfl2] >gi|327397644|gb|AEA73146.1| putative baseplate hub subunit and tail length determinator [Shigella phage Shfl2]</Hit_def> + <Hit_accession>YP_004415085</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>424.091</Hsp_bit-score> + <Hsp_score>1089</Hsp_score> + <Hsp_evalue>1.93327e-137</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>261</Hsp_identity> + <Hsp_positive>368</Hsp_positive> + <Hsp_gaps>33</Hsp_gaps> + <Hsp_align-len>598</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISITDKISSMLFKYTVSAAIEAAKMTAMILAVVVGIDLLMVHFKYWSDKFSKAWDLFNTDFTKFSSETGTWGPLLQSIFDSIDKIKQLWEAGDWGGLTAAIVEGLGSVLFNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNTTGASLNKEDQEKVANYQDKRMNGDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK--NKAQQAPVQQASPSINNTNNVVKKNTVV-HNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISITDKISSMLFKYTV+A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + IK+ WEAGDW GL AIV+GL V++NL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K N +Q+ ++ NT N+ H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>16</Hit_num> + <Hit_id>gi|397134209|gb|AFO10716.1|</Hit_id> + <Hit_def>baseplate hub protein [Escherichia phage ECML-134]</Hit_def> + <Hit_accession>AFO10716</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>421.009</Hsp_bit-score> + <Hsp_score>1081</Hsp_score> + <Hsp_evalue>3.75934e-136</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>263</Hsp_identity> + <Hsp_positive>373</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIVGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISISDKISSMLFKYTISAAIEAAKMTAMILAVVVGIDLLMVHFKYWSDKFSKAWDLFNTDFTKFSSETGTWGPLLQSIFSSIDEIKKFWEAGDWGGLTVAIVEGLGKVLYNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLSKEDQEKVANYQDKRMNGDLGPIAEGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEQYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N ++ ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISI+DKISSMLFKYT++A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + +IKKFWEAGDW GL VAIV+GL V+YNL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SLS++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R E+Y D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>17</Hit_num> + <Hit_id>gi|116326412|ref|YP_803132.1|</Hit_id> + <Hit_def>base plate hub [Enterobacteria phage RB32] >gi|115344005|gb|ABI95014.1| base plate hub [Enterobacteria phage RB32]</Hit_def> + <Hit_accession>YP_803132</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>407.527</Hsp_bit-score> + <Hsp_score>1046</Hsp_score> + <Hsp_evalue>5.49342e-131</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>261</Hsp_identity> + <Hsp_positive>372</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIIGAIDNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPAPQPVEPKQESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISISDKISSMLFKYTISAAIEAAKMTAMILAVVVGIDLLMVHFKYWSDKFSKAWDLFNTDFTKFSSETGTWGPLLQSIFDSIDEIKKFWEAGDWGGLTVAIVEGLGKVLYNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNTTNASLSKEDQEKVANYQYKRMNGDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAEEEEKLKQLSPEEAKIALMKANEARAAMNRFDQYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N +I ++DNV SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISI+DKISSMLFKYT++A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + +IKKFWEAGDW GL VAIV+GL V+YNL E++ LG++K+SA+IL + G ++ A + G ALE FQ T SLS++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R +E + LK ++PE+ + L+K NEARAA+ R ++Y D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>18</Hit_num> + <Hit_id>gi|639438842|ref|YP_009030799.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Escherichia phage e11/2] >gi|628971670|gb|AHY83392.1| baseplate hub subunit tail length determinator [Escherichia phage e11/2]</Hit_def> + <Hit_accession>YP_009030799</Hit_accession> + <Hit_len>590</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>399.823</Hsp_bit-score> + <Hsp_score>1026</Hsp_score> + <Hsp_evalue>4.84152e-128</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>590</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>255</Hsp_identity> + <Hsp_positive>369</Hsp_positive> + <Hsp_gaps>41</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGV----ASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFP-PVPQEP--ENNKKDQKKD--DKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDAQAASELIAQTVEEKSNEIVGAIGNVESAVSDTTAGSELIAETVEIGNNINKEIGESLGSKLDKLTSLLEQKIQTA--GIQQTGTSLATVESAIPVKVVEDDTAESVG---PLLPAPEAVNNDPDADFFPTPQPVEPKQESPEEKQKKEAFNLKLSQALDKLTKTVDFGFKKSISISDKISSMLFKYTISAAIEAAKMTAMILAVVVGIDLLMVHFKYWSDKFSKAWDLFNTDFTKFSSETGTWGPLLQSIFSSIDKIQQFWEKGDWGGLTAAIIEGLGSVLFNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNTTGASLNKEDQEKVANYQYKRMNGDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTSDEERAEEEEKLKQLSPEEAKIALMKANEARAAMNRFEKYADSADMSKDSTVKSVESAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N ++ ++ NV SE E+++ + ++ KL KL S+LE K+Q +Q++G S +T S I K+ + D ES G +LP + NN PD DFFP P P EP E+ ++ QKK+ + K + L L KT GFK +ISI+DKISSMLFKYT++A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + I++FWE GDW GL AI++GL V++NL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R +E + LK ++PE+ + L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>19</Hit_num> + <Hit_id>gi|398313740|emb|CCI89087.1|</Hit_id> + <Hit_def>phage baseplate hub [Yersinia phage phiD1]</Hit_def> + <Hit_accession>CCI89087</Hit_accession> + <Hit_len>369</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>308.531</Hsp_bit-score> + <Hsp_score>789</Hsp_score> + <Hsp_evalue>1.22596e-95</Hsp_evalue> + <Hsp_query-from>218</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>369</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>169</Hsp_identity> + <Hsp_positive>239</Hsp_positive> + <Hsp_gaps>26</Hsp_gaps> + <Hsp_align-len>377</Hsp_align-len> + <Hsp_qseq>MLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFM-------SNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGII----DKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTP--KPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MLFKYTISAAIEAAKMTAMILAVVIGIDLLMVHFKYWSDKFSKAWDLFNTDFTKFSSETGTWGPLLQSIFDSIDKIKQLWEAGDWGGLTAAIVEGLGSVLFNLGELIQLGMAKLSAAILRVIPGMKDTADEVEGRALENFQNSTGASLNKEDQEKVANYQDKRMNGDLGPIAKGLDKIANWKTRASNWIRGVDNKEALTTDEERAAEEEKLKQLSPEERKNALMKANEARAAMIRFEKYADSADMSKDSTVKSVEAAYEDLKKRMDDPDLNNSPAVKKELAARFSKIDATYQELKK-NQPNAKPETSAKSPEAKQVQVIEK-------NKAQQAPVQQASPSINNTNNVIKKNTVVHNMTPVTSTTAPGVFDATGVN</Hsp_hseq> + <Hsp_midline>MLFKYT++A EAAKM AM+ A+V+GIDLL +HFKYW+DKF ++F +FS+E G WG LLQSIF + IK+ WEAGDW GL AIV+GL V++NL E++ LG++K+SA+IL + G ++ A + G ALE FQ TG SL+++DQ+ +A YQ KR+ G I DK +KTRA +W+ G +NK T +R E + LK ++PE+R+ L+K NEARAA+ R EKY D + ++S+E AY KK + D +++ PA KKEL RF ++++ YQ+LK+ N P KP A S + ++VQ I+K +K + A+ +NN NN + +H + VT+T APGVF ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>20</Hit_num> + <Hit_id>gi|431809132|ref|YP_007236029.1|</Hit_id> + <Hit_def>phage baseplate hub [Yersinia phage phiR1-RT] >gi|398313421|emb|CCI88770.1| phage baseplate hub [Yersinia phage phiR1-RT]</Hit_def> + <Hit_accession>YP_007236029</Hit_accession> + <Hit_len>582</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>298.516</Hsp_bit-score> + <Hsp_score>763</Hsp_score> + <Hsp_evalue>2.81533e-89</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>582</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>217</Hsp_identity> + <Hsp_positive>334</Hsp_positive> + <Hsp_gaps>46</Hsp_gaps> + <Hsp_align-len>602</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLID-------SVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDE---PE---SPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPT--DMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRI--EEGPGIIDKAGEFKTRAFDWVL--GRENKIDSTQASDRDQ--ETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKY--QKLKEDNTPKPAAPATSEDNQRVQNIQK-AENAKEQSKKSTGDMNVANT--QVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKQPSQQNSFRRKVIEDSKPERDAASAANSQSTSLDSIDSKLSDVQAASELTSEVVEAKTDQLIDTIGQLKGSVQDVQAASELAVDAIGDSNSYLKSIDTVSQAINAKLAQLTSMLEAKFG--DQLAPLNAPNPVSG------ALPEPVPVVLPEDFIGPMLP--TVPDTDPNEEVLPEPPRREPEPKSEEDKKSSSEGDEKNTISEKLDLLIRTTQSGFKTAVGYSDKISNMLFKFTLTAIAQAAKTAAMILGIILAIDVIKANFTFWAEKFSTNFTEFAERAKEWGPLIESVVGMVRNISDAWNSDDPLGIIKAIAFGLSDITKQLADLLGLAVAKLTAGILRALGFNDKADALEGSYLKGYQDRTGSVMSEGHQKLIAKADNQKIKDEHDTTAYDQFKGMDQRGYDQAYKNGSMSK-DTYEALSKGEAKASDPLQGLSEEERLNVIIKRNEAQAAINRTKDYSTKIDPNNEREVNSLNKALADIKSRLDDPEISKIPESKSDLTRQFNELNNKTSANKLK---------PAPIAENQEVQTTKRVAELQKQNDTQSVNKGPTQNTVVQANTTNTSRTMYNMPPTTNIPAPGMRAALGTN</Hsp_hseq> + <Hsp_midline>MK + RRKVI DSK ERDAAS A+ Q SL+ I KL DVQ+A+EL +EV+E K + LID SV +V +ELA +A + +K++ V+ I+ KL++L SMLE+K +Q + + +G LP+P PE P LP +P D N + E + E +KK + D+K T + L L++TT+ GFK + +DKIS+MLFK+T+TA+A+AAK AAM+ ++L ID+++ +F +W +KF +NF EF+ A EWG L++S+ GM+ +I W + D G+ AI GL+D+ L++++ L ++K++A IL ALGF + A + GS L+G+Q+RTG+ +SE QK +AK +++I E D+ R +D G +K D+ +A + + + L+ ++ E+R +IK+NEA+AA+ R + Y +DP N + SL KA K + D IS P +K +L ++F + +K KLK PA +NQ VQ ++ AE K+ +S NT Q N N S+T++ + T PAPG+ A G N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>21</Hit_num> + <Hit_id>gi|422934216|ref|YP_007004252.1|</Hit_id> + <Hit_def>baseplate hub subunit [Enterobacteria phage Bp7] >gi|345450725|gb|AEN93928.1| baseplate hub subunit [Enterobacteria phage Bp7]</Hit_def> + <Hit_accession>YP_007004252</Hit_accession> + <Hit_len>578</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>269.24</Hsp_bit-score> + <Hsp_score>687</Hsp_score> + <Hsp_evalue>3.573e-78</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>578</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>204</Hsp_identity> + <Hsp_positive>331</Hsp_positive> + <Hsp_gaps>54</Hsp_gaps> + <Hsp_align-len>604</Hsp_align-len> + <Hsp_qseq>MKSE-NMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVD-------NVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLP---ERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKP-TDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEG--------------PGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKK-ELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKNESNQNSFRRNKLIEEMAPQRRAEALAQTQNDELGNISDVLSDSQAASELLSEVVETKSNQIISSVDRVDKSVQDVVAGTELTAEAISEQTQQSKALS---DALNEKINKLSNMLEAKFSGI--SIPPEGSS----LKVIEDSIPEEPKAETPKVPAVVEDILPPED---NKPDAEFMP----EPPKNSDEGKEGDKTSLSDKIEALTKITEKGFKASIGVADRISGMLFKYTITAAAEAAKLAAGLVLLIFGIDAIRVYFQYFMDQFESGWKEFNDKFKEWGPLLEGLMTWAKNAEAMFSEGNWLGLAEAIIRGMVNLTKNMAQLLMLGISKLISAILSKIPGMGELAENVEASALMSYQQNTGATLDVEDQTKVAKYHDRRSAEALETAEKMNKKYKDKPELINQAEKYGN------LTKE-QADQLRAGGIDTSFRDLPE---EERLEYFKKRDKAQADIIRLTQTADNIMKPDSKDIENAKAFKADIEKQLADPIMAKGGAPKDLNIQQLLDKMNKSLEKFNEAEKPKPASVAESPENTQVKKVDEQMRAKENAKYSQQAPTQINQQTNIKKTSKTSYNLPPQSSTPAPGMRQATKVN</Hsp_hseq> + <Hsp_midline>MK+E N ++ RR K+I + +R A + A Q D L I L D Q+A+EL++EV+E K N +I SVD +V GTEL AEA T+ K L+ +++K++KL++MLE+K + + G+S L VIED +P+ + E+P +P E ILPP D N PD +F P EP N + K+ DK +D + L K T+ GFKA+I + D+IS MLFKYT+TA AEAAK+AA L L+ GID +R++F+Y+ D+F S + EF+ + EWG LL+ + + + + G+W GLA AI++G+ ++ N+++++ LGISK+ ++IL + G A + SAL +Q+ TG +L +DQ +AKY +R E P +I++A ++ L +E + D +A D ++L E+R E K+++A+A + RL + ++ + ++++ + +K ++D ++ A K + + ++ +K E PKPA+ A S +N +V+ + + AKE +K S N Q N SKT + + ++TPAPG+ AT VN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>22</Hit_num> + <Hit_id>gi|314121771|ref|YP_004063890.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit tail length determinator [Enterobacteria phage vB_EcoM-VR7] >gi|313151528|gb|ADR32584.1| gp29 baseplate hub subunit tail length determinator [Enterobacteria phage vB_EcoM-VR7]</Hit_def> + <Hit_accession>YP_004063890</Hit_accession> + <Hit_len>581</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>269.24</Hsp_bit-score> + <Hsp_score>687</Hsp_score> + <Hsp_evalue>3.63307e-78</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>581</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>186</Hsp_identity> + <Hsp_positive>328</Hsp_positive> + <Hsp_gaps>58</Hsp_gaps> + <Hsp_align-len>606</Hsp_align-len> + <Hsp_qseq>KSENMSTMRR----RKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVD-------NVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEG--------------PGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKK-ELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KNSEQTSFRRGGPNKKLIEELAPQRRAEALSAEQNDELSNLNTTLTNTQAATELVSEAIEDKGNQIIENIQTNNGVLQDISAGVELTAEATEKTQQGIKNLTDI---LSDKLDKLSAMISGKIGVT------SPVAGSESLKPVEDALPEPEENKPTASVPALIPPEEQK---PDADFIPE-PEQPKTDAEGKETNTWSLGDKLDTLSKITEKGFKASISVADRISGMLFKYTITAAAEAAKLIGGLLLLVFGIDAIRVYFQYFMKQFEKGWAEFNDKFKEWGPLLEGLMTWAKNAEAMFSERNWLGLAEAIIRGMVNLTKNMAQLLMLGISKLISAILSKIPGMGDLADNVEASALMSYQQNTGATLDDEDQTKIAKYHDKRSAEAMKTAEKMNKKYKDKPELINQAEKYGN------LTKE-QADQLRAGGIDTSFRDLPE---EERLDYFKKRDKTQADIIRLTQTADNLMKPDATDKKNAEASYKAIQEQLADPVMAKGGAPKDLNMHALLEKLDKSLEKFKDEPKVKPPDVKASPDAQQAAKVDEGMKAKENKYKDAP----ANAQINTVNNIQKTSRTQYNMPPQSSTPAPGMRQATRIN</Hsp_hseq> + <Hsp_midline>K+ ++ RR +K+I + +R A + +++Q D L + L + Q+A ELV+E IE+KGN +I+++ +++ G EL AEA+E+T + IK LT + +SDKL KL++M+ K+ S + S L +ED LP+P+E + ++PP + PD DF P P++P+ + + ++ + D L L K T+ GFKA+IS+ D+IS MLFKYT+TA AEAAK+ L LV GID +R++F+Y+ +F + EF+ + EWG LL+ + + + + +W GLA AI++G+ ++ N+++++ LGISK+ ++IL + G + A + SAL +Q+ TG +L ++DQ +AKY KR E P +I++A ++ L +E + D +A D ++L E+R + K+++ +A + RL + ++ + T+ ++ E +Y + ++ ++D ++ A K + ++++ +K K++ KP S D Q+ + + AKE K AN Q+N VNN S+T + + ++TPAPG+ AT +N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>23</Hit_num> + <Hit_id>gi|299779140|ref|YP_003734334.1|</Hit_id> + <Hit_def>29 gene product [Enterobacteria phage IME08] >gi|298105869|gb|ADI55513.1| gp29 baseplate hub subunit [Enterobacteria phage IME08]</Hit_def> + <Hit_accession>YP_003734334</Hit_accession> + <Hit_len>578</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>266.929</Hsp_bit-score> + <Hsp_score>681</Hsp_score> + <Hsp_evalue>2.99001e-77</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>578</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>203</Hsp_identity> + <Hsp_positive>335</Hsp_positive> + <Hsp_gaps>56</Hsp_gaps> + <Hsp_align-len>605</Hsp_align-len> + <Hsp_qseq>MKSE-NMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVD-------NVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLP---ERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKP-TDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEG--------------PGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNS-AKKSISDSAISDQPATKK-ELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKNESNQNSFRRNKLIEEMAPQRRAEALAQTQNDELGNISDVLSDSQAASELLSEVVETKSNQIISSVDRVDKSVQDVVAGTELTAEAISEQTQQSKALS---DALNEKINKLSNMLEAKFSGI--SIPPEGSS----LKVIEDSIPEEPKAETPKVPAVVEDILPPED---NKPDAEFVP----EPPKNSDEGKEGAKSPLSEKIEALTKITEKGFKASVGVADRISGMLFKYTITAAAEAAKLAAGLVLLIFGIDAIRVYFQYFMDQFEAGWKEFNDKFKEWGPLLEGLMTWAKNAEAMFSEGNWLGLAEAIIRGMVNLTKNMAQLLMVGISKLISAILSKIPGMGELAENVEASALMSYQQNTGATLDDEDQTKVAKYHDRRSAEALETAEKMNKKYKNKPELINQAEKYGN------LTKE-QADQLRAGGIDTSFRDLPE---EERLEYFKKRDKAQADIIRLTQTADNIMKPDSKDIENA-KAYKADIEKQLADPIMAKGGAPKDLNIQQLLDKMNKSLEKFNEAEKPKPASVAESPENTQVKKVDEQMRAKENAKYSQQAPTQINQQTNIKKTSKTSYNLPPQSSTPAPGMRQATKVN</Hsp_hseq> + <Hsp_midline>MK+E N ++ RR K+I + +R A + A Q D L I L D Q+A+EL++EV+E K N +I SVD +V GTEL AEA T+ K L+ +++K++KL++MLE+K + + G+S L VIED +P+ + E+P +P E ILPP D N PD +F P EP N + K+ K P ++ + L K T+ GFKA++ + D+IS MLFKYT+TA AEAAK+AA L L+ GID +R++F+Y+ D+F + + EF+ + EWG LL+ + + + + G+W GLA AI++G+ ++ N+++++ +GISK+ ++IL + G A + SAL +Q+ TG +L ++DQ +AKY +R E P +I++A ++ L +E + D +A D ++L E+R E K+++A+A + RL + ++ + ++++ KAY + +K ++D ++ A K + + ++ +K E PKPA+ A S +N +V+ + + AKE +K S N Q N SKT + + ++TPAPG+ AT VN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>24</Hit_num> + <Hit_id>gi|308814556|ref|YP_003934830.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Shigella phage SP18] >gi|308206148|gb|ADO19547.1| baseplate hub subunit tail length determinator [Shigella phage SP18]</Hit_def> + <Hit_accession>YP_003934830</Hit_accession> + <Hit_len>581</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>265.388</Hsp_bit-score> + <Hsp_score>677</Hsp_score> + <Hsp_evalue>1.10381e-76</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>581</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>188</Hsp_identity> + <Hsp_positive>331</Hsp_positive> + <Hsp_gaps>60</Hsp_gaps> + <Hsp_align-len>607</Hsp_align-len> + <Hsp_qseq>KSENMSTMRR----RKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVD-------NVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEG--------------PGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKR--FQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNN----SKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KNSEQTSFRRGGPNKKLIEELAPQRRAEALSAEQNDELSNLNTTLTNTQAATELVSEAIEDKGNQIIENIQTNNGVLQDISAGVELTAEATEKTQQGIKNLTDI---LSDKLDKLSAMISGKLGVT------SPVAGSESLKPVEDALPEPEENKPTASVPTLIPPEEQK---PDADFIPE-PEQPKTDAEGKETNTWSLGDKLDTLSKITEKGFKASISVADRISGMLFKYTITAAAEAAKLIGGLLLLVFGIDAIRVYFQYFMKQFEKGWAEFNDKFKEWGPLLEGLMTWAKNAQAMFSEKNWLGLAEAIIRGMVNLTKNMAQLLMLGISKLISAILSKIPGMGDLADNVEASALMSYQQNTGATLDDEDQTKIAKYHDKRSAEAMEATEKMNKKYKDKPELINQAEKYGN------LTKE-QADQLRAGGIDTSFRDLPE---EERLDYFKKRDKAQADIIRLTQTADNLMKPDATDKKNAMEMRANIEKQLADPSMAKGGAP-KDLNMRALLEKLDKSLEKFKDEPKVKPPDVKTSPDAQQAAKVDEGMKAKENKYKDAP----AQAQINTVNNIQKTSRTQYNMPPQSSTPAPGMRQATRIN</Hsp_hseq> + <Hsp_midline>K+ ++ RR +K+I + +R A + +++Q D L + L + Q+A ELV+E IE+KGN +I+++ +++ G EL AEA+E+T + IK LT + +SDKL KL++M+ K+ S + S L +ED LP+P+E + ++PP + PD DF P P++P+ + + ++ + D L L K T+ GFKA+IS+ D+IS MLFKYT+TA AEAAK+ L LV GID +R++F+Y+ +F + EF+ + EWG LL+ + + + + +W GLA AI++G+ ++ N+++++ LGISK+ ++IL + G + A + SAL +Q+ TG +L ++DQ +AKY KR E P +I++A ++ L +E + D +A D ++L E+R + K+++A+A + RL + ++ + T+ ++ + + +K ++D +++ A K+L+ R ++++ +K K++ KP TS D Q+ + + AKE K A Q+N VNN S+T + + ++TPAPG+ AT +N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>25</Hit_num> + <Hit_id>gi|238695345|ref|YP_002922538.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit, tail length determinator [Enterobacteria phage JS10] >gi|220029481|gb|ACL78415.1| gp29 baseplate hub subunit, tail length determinator [Enterobacteria phage JS10]</Hit_def> + <Hit_accession>YP_002922538</Hit_accession> + <Hit_len>578</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>262.692</Hsp_bit-score> + <Hsp_score>670</Hsp_score> + <Hsp_evalue>1.03696e-75</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>578</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>198</Hsp_identity> + <Hsp_positive>334</Hsp_positive> + <Hsp_gaps>52</Hsp_gaps> + <Hsp_align-len>603</Hsp_align-len> + <Hsp_qseq>MKSE-NMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVD-------NVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLP---ERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEG--------------PGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKK-ELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKNESNQNSFRRNKLIEEMAPQRRAEALAQTQNDELGNITEALSETQAASELLSEVVETKSNQIINSIDRVDKSVQDVVAGTELTAEAISEQTQQSKALS---DALNEKINKLSNMLEAKFSGI--SIPPEGSS----LKVIEDSIPEEPKAETPKVPAVIEDILPPED---NKPDAEF---VPEPPKNSDEGKEGDKSSLSDKIEALTKITEKGFKASIGVADRISGMLFKYTITAAAEAAKLAAGLALLIFGIDAIRVYFQYFMDQFNEGWKKFNDKFKEWGPLLEGLMTWAKNAEAMFSERNWLGLAEAIIRGMVNLTKNMAQLLMLGISKLISAILSKIPGMGDLAENVEASALMSYQQNTGATLDDEDQTKVAKYHDRRSAEALETAEKMNKKYKGKPELINQAEKYGN------LTKE-QADQLRAGGIDTSFRNLPE---EERLEYFKKRDKAQADIIRLTQTADNIMKPDSKDIENAKAFKADIEKQLADPIMAKGGAPKDLNIQQLLDKMNKSLEKFNEAEKPKPASVAESPENTQVKKVDEQMRAKENAKYSQQAPTQINQQTNIKKTSKTSYNLPPQSSTPAPGMRQATKVN</Hsp_hseq> + <Hsp_midline>MK+E N ++ RR K+I + +R A + A Q D L I L + Q+A+EL++EV+E K N +I+S+D +V GTEL AEA T+ K L+ +++K++KL++MLE+K + + G+S L VIED +P+ + E+P +P E ILPP D N PD +F VP+ P+N+ + ++ D +D + L K T+ GFKA+I + D+IS MLFKYT+TA AEAAK+AA L L+ GID +R++F+Y+ D+F + +F+ + EWG LL+ + + + + +W GLA AI++G+ ++ N+++++ LGISK+ ++IL + G + A + SAL +Q+ TG +L ++DQ +AKY +R E P +I++A ++ L +E + D +A D +NL E+R E K+++A+A + RL + ++ + ++++ + +K ++D ++ A K + + ++ +K E PKPA+ A S +N +V+ + + AKE +K S N Q N SKT + + ++TPAPG+ AT VN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>26</Hit_num> + <Hit_id>gi|161622623|ref|YP_001595318.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit tail length determinator [Enterobacteria phage JS98] >gi|52139948|gb|AAU29318.1| gp29 baseplate hub subunit tail length determinator [Enterobacteria phage JS98]</Hit_def> + <Hit_accession>YP_001595318</Hit_accession> + <Hit_len>578</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>259.225</Hsp_bit-score> + <Hsp_score>661</Hsp_score> + <Hsp_evalue>1.72858e-74</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>578</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>196</Hsp_identity> + <Hsp_positive>334</Hsp_positive> + <Hsp_gaps>52</Hsp_gaps> + <Hsp_align-len>603</Hsp_align-len> + <Hsp_qseq>MKSE-NMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVD-------NVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLP---ERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEG--------------PGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKK-ELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MKNESNQNSFRRNKLIEEMAPQRRAEALAQTQNDELGNITEALSETQAASELLSEVVETKSNQIINSIDRVDKSVQDVVAGTELTAEAISEQTQQSKALS---DALNEKINKLSNMLEAKFSGI--SIPPEGSS----LKVIEDSIPEEPKAETPKVPAVIEDILPPED---NKPDAEF---VPEPPKNSDEGKEGDKSSLSDKIEALTKITEKGFKASIGVADRISGMLFKYTITAAAEAAKLAAGLALLIFGIDAIRVYFQYFMDQFNEGWKKFNDKFKEWGPVLEGLMTWAKNAEAMFSERNWLGLAEAIIRGMVNLTKNMAQLLMLGISKLISAILSKIPGMGDLAENVEASALMSYQQNTGATLDDEDQTKVAKYHDRRSAEALETAEKMNKKYKGKPELINQAEKYGN------LTKE-QADQLRAGGIDTSFRDLPE---EERLEYFKKRDKAQADIIRLTQTADNIMKPDSKDIENAKAFKADIEKQLADPIMAKGGAPKDLNIQQLLDKMNKSLEKFNEAEKPKPASVAESPENTQVKKVDEQMRAKENAKYSQQAPTQINQQTNIKKTSKTSYNLPPQSSTPAPGMRQATKVN</Hsp_hseq> + <Hsp_midline>MK+E N ++ RR K+I + +R A + A Q D L I L + Q+A+EL++EV+E K N +I+S+D +V GTEL AEA T+ K L+ +++K++KL++MLE+K + + G+S L VIED +P+ + E+P +P E ILPP D N PD +F VP+ P+N+ + ++ D +D + L K T+ GFKA+I + D+IS MLFKYT+TA AEAAK+AA L L+ GID +R++F+Y+ D+F + +F+ + EWG +L+ + + + + +W GLA AI++G+ ++ N+++++ LGISK+ ++IL + G + A + SAL +Q+ TG +L ++DQ +AKY +R E P +I++A ++ L +E + D +A D ++L E+R E K+++A+A + RL + ++ + ++++ + +K ++D ++ A K + + ++ +K E PKPA+ A S +N +V+ + + AKE +K S N Q N SKT + + ++TPAPG+ AT VN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>27</Hit_num> + <Hit_id>gi|311992691|ref|YP_004009559.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit [Acinetobacter phage Ac42] >gi|298684474|gb|ADI96435.1| gp29 baseplate hub subunit [Acinetobacter phage Ac42]</Hit_def> + <Hit_accession>YP_004009559</Hit_accession> + <Hit_len>569</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>227.639</Hsp_bit-score> + <Hsp_score>579</Hsp_score> + <Hsp_evalue>7.65187e-63</Hsp_evalue> + <Hsp_query-from>1</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>1</Hsp_hit-from> + <Hsp_hit-to>569</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>183</Hsp_identity> + <Hsp_positive>306</Hsp_positive> + <Hsp_gaps>91</Hsp_gaps> + <Hsp_align-len>618</Hsp_align-len> + <Hsp_qseq>MKSENMSTMRRRKVIADSKGERDAASTASDQVDSLEL---------IGLKLDDVQSANELVAEVIE------EKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDE--PESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGDLLKTT-KGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGE------------WGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGI----SKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGP-----GIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPAT-SEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNN--VNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>MAQQSLKSEVRDRVLAKSASLRDARKQIIDKANSQTLKPQESPQEAVQTPIDDLSPVSSTMSQALQQSSTSNEIGRASLDELHNISESSKL---------------------INQRLQKLSTLLESKFVNAETKPVELNERA---VDVIKDYVEKPEQKVPEPNPIP-KLLPGIEYTSSLGD-------TKDDQSKTVDQKE---KREDANGTGVKSILKTGFGKTVSVIDRISGFLFKYTLSAAIASAKIVGGLFALILGFDLLRIHFKYWGEKLMEKFDQISDWFGENISAPFNALLERWTPVFESIMDSVGFVKRAWENGDWG----ALISGIGSAIDTATTSLLVGIQSALAKLGAAILDKLGFKDAADNLEGAAIQNKQNHTDAVLSDKEKIALAEYQKKNIEKGEAPSRGGITSFLPDSWRKNLDLITEQ----DYNQIKAEEKDMGRLKSMSSDDQTKVLIKNNEAKDALDRYAEAGRKLDVNNEQDKARLNKLYNEASTRVKDKDLSNTPEVQKHLEGRLERIKNSINAKKVKVEPAPSNESKDATTASRIQAIDSKKNS------SAGNGNASNTNVQNNIVKSNRQINIQAPVTSSNAPGIFKATSAN</Hsp_hseq> + <Hsp_midline>M +++ + R +V+A S RDA D+ +S L + +DD+ + +++ ++ E G +D + N++E ++L I+ +L KL+++LESK E K E A + VI+D + P++ PE +P ++LP ++ ++L D ++ ++ DQK+ K D G +K+ K GF T+S+ D+IS LFKYT++A +AK+ LFAL+LG DLLRIHFKYW +K M FD+ S GE W + +SI +G +K+ WE GDW A++ G+ I + + +GI +K+ A+ILD LGF++AA + G+A++ Q T LS+ ++ ALA+YQ K IE+G GI + + D + + D Q +++ LK+M+ + + + LIK NEA+ A+ R + +D N + L K YN A + D +S+ P +K L+ R +R+++ K P P+ + + R+Q I +N+ S G+ N +NT V N V +++ I+ VT++ APG+F AT N</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>28</Hit_num> + <Hit_id>gi|639438514|ref|YP_009030254.1|</Hit_id> + <Hit_def>baseplate hub subunit, tail length determinator [Serratia phage PS2] >gi|625370587|gb|AHY25447.1| baseplate hub subunit, tail length determinator [Serratia phage PS2]</Hit_def> + <Hit_accession>YP_009030254</Hit_accession> + <Hit_len>572</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>211.46</Hsp_bit-score> + <Hsp_score>537</Hsp_score> + <Hsp_evalue>6.69261e-57</Hsp_evalue> + <Hsp_query-from>42</Hsp_query-from> + <Hsp_query-to>570</Hsp_query-to> + <Hsp_hit-from>35</Hsp_hit-from> + <Hsp_hit-to>566</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>158</Hsp_identity> + <Hsp_positive>276</Hsp_positive> + <Hsp_gaps>33</Hsp_gaps> + <Hsp_align-len>547</Hsp_align-len> + <Hsp_qseq>LDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDP-DEPESPGLPERILP-PL-DDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDAL-GFENAATTIRGSALEGFQERTGNSLSEDD-QKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGREN------KIDSTQAS--DRDQETQNLKAMAPEK----REETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKY-QKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVF</Hsp_qseq> + <Hsp_hseq>LDDIVEANELIADRVEDNTNRSVAAQEDSTAATELVAENTEHGNKHLSNIADTARQISSKLSEFADRLNSKIEASVQSGLPAIGNQATAIQAIEEQINTPLNEEVLADAIEKLLPMPVKSETDVFPEPEKPKEPEQNPQEDKREEERKDKEKSQASEKILSAVKGGFKSTYGLLNNIAGSLFKYTITAAANMLKWAGIMFAIVFAIDLIRVHFKYWQKVFEKSLDELNEQVGAWGPILTDIFNTAQEMRDYWAKGQYGDLVTSLVQGIGRTLLDLGHMIMFGIGKAIASMLDAIPGMSETAKKVEGRAIRTYSEQTGYVPDEEERQKVIAVEKYDQGQQYKDLKDEANKYTEDQFVKKTGNRGFLNDGISLNETQARQIHKDIRSGKLKDSDIEKEIGIQADLAMRMNTIENRVQRTSG--------SPSTNAELMDNLSKLAKDIGNADI--QSYMKEPLQERVQKMESALAERTKPKVTPKPAAE--SAEATQVKEVEATIKPKETASTNAG---TTLNNINNVRNSRTVVQVQPRSSIPSGGIM</Hsp_hseq> + <Hsp_midline>LDD+ ANEL+A+ +E+ N + + ++ TEL AE +E + + + A IS KLS+ A L SK++A Q + + +T + IE+++ P +E E++LP P+ + + P+ + Q P+ +K+++++ DK+ + +L KGGFK+T + + I+ LFKYT+TA A K A ++FA+V IDL+R+HFKYW F + DE + + G WG +L IF +++ +W G + L ++V+G+ + +L ++ GI K AS+LDA+ G A + G A+ + E+TG E++ QK +A + + ++ + D+A ++ F G ++ TQA +D + LK EK + + ++ N VQR +P+ L + K I ++ I Q K+ L +R Q++ES ++ K TPKPAA S + +V+ ++ KE + + G +NNV NS+T+ QVQ ++ P+ G+ </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>29</Hit_num> + <Hit_id>gi|238695064|ref|YP_002922258.1|</Hit_id> + <Hit_def>tail length regulator [Enterobacteria phage JSE] >gi|220029200|gb|ACL78135.1| tail length regulator [Enterobacteria phage JSE]</Hit_def> + <Hit_accession>YP_002922258</Hit_accession> + <Hit_len>577</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>204.527</Hsp_bit-score> + <Hsp_score>519</Hsp_score> + <Hsp_evalue>2.33408e-54</Hsp_evalue> + <Hsp_query-from>22</Hsp_query-from> + <Hsp_query-to>570</Hsp_query-to> + <Hsp_hit-from>13</Hsp_hit-from> + <Hsp_hit-to>572</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>167</Hsp_identity> + <Hsp_positive>299</Hsp_positive> + <Hsp_gaps>83</Hsp_gaps> + <Hsp_align-len>596</Hsp_align-len> + <Hsp_qseq>RDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDN-------VAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQE-PE-NNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIY----NLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEF-----KTRAFDWVLGR--ENKIDSTQASD--RDQETQNLKAMAPEKREETLIK------QNEARAAVQRL---------------EKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDN----QRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVF</Hsp_qseq> + <Hsp_hseq>KEAEENPIDKLNKLDKLN-SIDNLQAATELVAETVEQKSNEVVGAVEDNTAANELTAENTQSTAGNTQKTYEELQKLNNFSSQMNEKLRGFGVMMERRFGVV--------SKMASGIGAIEEALKKPEQPQTMPSPQPVLPTVPEQ---PNNDNYQGLPKKKPDADDRKKKNATDKRNADSMENLLKVVRGGFKETIGISNKVLGMLFKITLTAMAEAAKWGAILMGIVFVIDTLMVHFRYWSDLFETKFNEFMDKAGGWAGPISDILTTVRQVRDYWSKGEYGELIKSLVMGIGDAFYKTFIQLDRIITTGIAKILRMI---PGMGDYADKLEYGALKSAVAQ-GYTPNERELELMDKVESEHEE------DKYGERTGWTGKARDIGEAIGESIKDKVNEGLVSLGWRDQ-----KDVDAEKRQEELKRGEYKSVSAEQRSASRKLRIKSEGAINNINEVMENLSGDYDKE---RMGELKKDIDVYREQVQDPTLVE--SDRSQLERLIEKFDEMYADKTKGVVPTKSVPATETETAKQAERTEQMQKQAAIQQQTTNQTS--NVNNTQI--VTNNRTIKQGAPTTRIDAPGTI</Hsp_hseq> + <Hsp_midline>++A D+++ L+ + +D++Q+A ELVAE +E+K N ++ +V++ AE T+ A +++T E ++ L +S +++KL M+E + V + ++G+ IE+ L P++P++ P+ +LP + + P+ D + +P++ P+ +++K + DK+ D + +LLK +GGFK TI I++K+ MLFK T+TA+AEAAK A+L +V ID L +HF+YW+D F + F+EF +AG W G + I + ++ +W G++ L ++V G+ D Y L I++ GI+KI I G + A + AL+ + G + +E + + + K +S+ E DK GE K R +G ++K++ S RDQ K + EKR+E L + E R+A ++L E GD D E M L+K + ++ + D + + + + +L++ ++ + Y + P + PAT + +R + +QK ++Q+ T NV NTQ+ V N++TI Q T APG </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>30</Hit_num> + <Hit_id>gi|157311483|ref|YP_001469526.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit tail length determinator [Enterobacteria phage Phi1] >gi|149380687|gb|ABR24692.1| gp29 baseplate hub subunit tail length determinator [Enterobacteria phage Phi1]</Hit_def> + <Hit_accession>YP_001469526</Hit_accession> + <Hit_len>577</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>200.675</Hsp_bit-score> + <Hsp_score>509</Hsp_score> + <Hsp_evalue>5.33273e-53</Hsp_evalue> + <Hsp_query-from>42</Hsp_query-from> + <Hsp_query-to>570</Hsp_query-to> + <Hsp_hit-from>32</Hsp_hit-from> + <Hsp_hit-to>572</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>163</Hsp_identity> + <Hsp_positive>286</Hsp_positive> + <Hsp_gaps>82</Hsp_gaps> + <Hsp_align-len>576</Hsp_align-len> + <Hsp_qseq>LDDVQSANELVAEVIEEKGNNLIDSVDNVAEGTELAAEASE-------RTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQE-PE-NNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIY----NLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEF-----KTRAFDWVLGR--ENKIDSTQASD--RDQETQNLKAMAPEKREETLIK------QNEARAAVQRL---------------EKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDN----QRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVF</Hsp_qseq> + <Hsp_hseq>IDNLQAATELVAETVEQKSNEVVGAVEDNTAANELTAENTQSTAGNTKKTYEELQKLNNFSSQMNEKLRGFGVMMERRFGVV--------SKMASGIGAIEEALKKPEQPQTMPSPQPVLPTVPEQ---PNNDNYQGLPKKKPDVDDRKKKNAADKRNADSMENLLKVVRGGFKETIGISNKVLGMLFKITLTAMAEAAKWGAILMGIVFVIDTLMVHFRYWSDLFETKFNEFMDKAGGWAGPISDILTTVRQVRDYWSKGEYKELIKSLVMGIGDAFYKTFIQLDRIITTGIAKILRMI---PGMGDYADKLEYGALKSAVAQ-GYTPNERELELMDKVESEHEE------DKYGERTGWTGKARDIGEAIGDSIKDKVNEGLVSLGWRDQ-----KDVDAEKRQEELKRGEYKSVSAEQRSASRKLRIKSEGAINNINEVMENLSGDYDKE---RMGELKKDIDVYREQVQDPTLVE--SDRSQLERLIEKFDEMYADKTNGVVPTNPVPATETETAKQAERTEQMQKQAAIQQQTTNQTS--NVNNTQI--VTNNRTVKQGAPTTRIDAPGTI</Hsp_hseq> + <Hsp_midline>+D++Q+A ELVAE +E+K N ++ +V++ EL AE ++ +T E ++ L +S +++KL M+E + V + ++G+ IE+ L P++P++ P+ +LP + + P+ D + +P++ P+ +++K + DK+ D + +LLK +GGFK TI I++K+ MLFK T+TA+AEAAK A+L +V ID L +HF+YW+D F + F+EF +AG W G + I + ++ +W G++ L ++V G+ D Y L I++ GI+KI I G + A + AL+ + G + +E + + + K +S+ E DK GE K R +G ++K++ S RDQ K + EKR+E L + E R+A ++L E GD D E M L+K + ++ + D + + + + +L++ ++ + Y P PAT + +R + +QK ++Q+ T NV NTQ+ V N++T+ Q T APG </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>31</Hit_num> + <Hit_id>gi|33620639|ref|NP_891750.1|</Hit_id> + <Hit_def>tail length regulator [Enterobacteria phage RB49] >gi|33438535|gb|AAL15120.2| tail length regulator [Enterobacteria phage RB49]</Hit_def> + <Hit_accession>NP_891750</Hit_accession> + <Hit_len>577</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>200.675</Hsp_bit-score> + <Hsp_score>509</Hsp_score> + <Hsp_evalue>5.38583e-53</Hsp_evalue> + <Hsp_query-from>42</Hsp_query-from> + <Hsp_query-to>570</Hsp_query-to> + <Hsp_hit-from>32</Hsp_hit-from> + <Hsp_hit-to>572</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>164</Hsp_identity> + <Hsp_positive>284</Hsp_positive> + <Hsp_gaps>82</Hsp_gaps> + <Hsp_align-len>576</Hsp_align-len> + <Hsp_qseq>LDDVQSANELVAEVIEEKGNNLIDSVDN-------VAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQE-PE-NNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIY----NLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEF-----KTRAFDWVLGR--ENKIDSTQASD--RDQETQNLKAMAPEKREETLIK------QNEARAAVQRL---------------EKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDN----QRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVF</Hsp_qseq> + <Hsp_hseq>IDNLQAATELVAETVEQKSNEVVGAVEDNTAANELTAENTQSTAGNTQKTYEELQKLNNFSSQMNEKLRGFGVMMERRFGVV--------SKMASGIGAIEEALKKPEQPQTMPSPQPFLPTVPEQ---PNNDNYQGLPKKKPDVDDRKKKNATDKRNADSMENLLKVVRGGFKETIGISNKVLGMLFKITLTAMAEAAKWGAILMGIVFVIDTLMVHFRYWSDLFETKFKEFMDKAGGWAGPISDILTTVRQVRDYWSKGEYKELIKSLVMGIGDAFYKTFIQLDRIITTGIAKILRMI---PGMGDYADNLEYGALKSAVAK-GYKPNERELELMDKVESEHEE------DKYGERTGWTGKARDIGEAIGESIKDKFNEGLVSLGWRDQ-----KDVDAEKRQEELKRGEYKSVSAEQRSASRKLKIKSEGAINNINEVMENLSGDYDKE---RMEELKKDIDVYREQVQDPTLVE--SDRSQLERLIEKFDEMYADKTNGVVPTNPVPATETETAKQAERTEQMQKQAAIQQQTTNQTS--NVNNTQI--VTNNRTIKQGAPTTRIDAPGTI</Hsp_hseq> + <Hsp_midline>+D++Q+A ELVAE +E+K N ++ +V++ AE T+ A +++T E ++ L +S +++KL M+E + V + ++G+ IE+ L P++P++ P+ LP + + P+ D + +P++ P+ +++K + DK+ D + +LLK +GGFK TI I++K+ MLFK T+TA+AEAAK A+L +V ID L +HF+YW+D F + F EF +AG W G + I + ++ +W G++ L ++V G+ D Y L I++ GI+KI I G + A + AL+ + G +E + + + K +S+ E DK GE K R +G ++K + S RDQ K + EKR+E L + E R+A ++L E GD D E M+ L+K + ++ + D + + + + +L++ ++ + Y P PAT + +R + +QK ++Q+ T NV NTQ+ V N++TI Q T APG </Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>32</Hit_num> + <Hit_id>gi|392973136|ref|YP_006489094.1|</Hit_id> + <Hit_def>baseplate hub subunit [Acinetobacter phage ZZ1] >gi|390058277|gb|AFL47731.1| baseplate hub subunit, tail length determinator [Acinetobacter phage ZZ1]</Hit_def> + <Hit_accession>YP_006489094</Hit_accession> + <Hit_len>585</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>195.667</Hsp_bit-score> + <Hsp_score>496</Hsp_score> + <Hsp_evalue>4.41683e-51</Hsp_evalue> + <Hsp_query-from>112</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>105</Hsp_hit-from> + <Hsp_hit-to>585</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>156</Hsp_identity> + <Hsp_positive>246</Hsp_positive> + <Hsp_gaps>32</Hsp_gaps> + <Hsp_align-len>489</Hsp_align-len> + <Hsp_qseq>KVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEP--ENNKKDQKKDDKKPTDMLGDLLKTTKG----GFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEW-----------GGLLQSIFGMLGD---IKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDK---AGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQT-VTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>KLAALSERLKEKYEAANDATVDLPVKAEEPTTSES--LSSRISPEDTNNNVIPSVVADDPKPSKDLLESTNEVKGAPSLGPAAMIVSGLQTLTGAVKTGFAKSKSVSDKIAGMLFKYTVTQAVNAAKIALAVFGIILALDLLKMAWNAWGEKIMAKFEEWTQTFSKWWDNFKEWSTYFSDMKYAFEGMQGDLMGIRNAWESGDWPALASAIGTAFVDGIKTLSGIMDRVITKLIATILNKLGFKDTAKSIEAEGLQRYQNMTNNKLDPENQQKLAEEQLKR-EKKDGLTSTQRGVTSFLPDSWREKLGFITKNEHSQIEAEKKDQKARQSLSKDDQVKVVAASNEAREAVARLENIAVNADPNNKGQMATLDKYRKEAQNYINNPALSKSPNVKAELQNQLDRLTPK-QSVK--NTVTPETSTASKDVQTAKNIQIAE--AQKAKTNAVQNNNTANVQNNIVKSSRQYNVQAPITGTAAPGIFKATGVN</Hsp_hseq> + <Hsp_midline>K+ A+ ++++E +A+ + K +P ES L RI P +NN +P P P + E+ + + P M+ L+T G GF + S++DKI+ MLFKYTVT AAK+A +F ++L +DLL++ + W +K M+ F+E++ +W + + GM GD I+ WE+GDW LA AI D I LS IM I+K+ A+IL+ LGF++ A +I L+ +Q T N L ++Q+ LA+ Q KR E+ G+ F ++ LG K + +Q ++ + ++++ + + + + NEAR AV RLE + DP N M +L+K A+ I++ A+S P K EL + R+ K Q +K NT P S+D Q +NIQ AE +++K + N NN+ S + VQ +T T APG+F ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>33</Hit_num> + <Hit_id>gi|326536335|ref|YP_004300776.1|</Hit_id> + <Hit_def>gp29 baseplate hub [Acinetobacter phage 133] >gi|299483416|gb|ADJ19510.1| gp29 baseplate hub [Acinetobacter phage 133]</Hit_def> + <Hit_accession>YP_004300776</Hit_accession> + <Hit_len>582</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>182.185</Hsp_bit-score> + <Hsp_score>461</Hsp_score> + <Hsp_evalue>1.85312e-46</Hsp_evalue> + <Hsp_query-from>75</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>84</Hsp_hit-from> + <Hsp_hit-to>582</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>164</Hsp_identity> + <Hsp_positive>246</Hsp_positive> + <Hsp_gaps>65</Hsp_gaps> + <Hsp_align-len>533</Hsp_align-len> + <Hsp_qseq>ELAAEASERTTESIKTLTGVASTISDK---LSKLASMLESKV-------QAVEQKVQESGASASTGLSVIED---KLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDE-------FSAEAGEWGGLLQSIFGMLGD----IKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEG-----PGIIDKAGEFKTRAFDWVLG--RENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>ELQQEAVEANTH----LEQIEKSTTDSNATLSKLSSQLESKFSGQVQSPQVVEHKTTEE---------IIKDFAEKSKSKTESTEPAILPAVLPEATKKPNLGGAT----TPKE-----QKAKSDSTKASHPAMKVFNVVKSGFKSVKSVGDKIAGFLFKGALTAAIEAAKMAGIIFLIIAAIDLVRIHFKYWTEKFSAKFDAVKEIIMGYFDRFGNWMESIMPMFSGLFDAIDYIRNVFAKGDWSALAGAIGNVMKEAFNSLGAMIQNGIAKLASILLRKFGFNDTADSIEAIGLENKQNMTNTPLTPEEQKKVAKQQQKMLDKDYTPTQTGIT----AFLPDKFRKAIGALSDGEYDQIQAEKKNM--SQLKGLNKEDQTNTIGAMNEARAALNRYENKVERLDPNDPNQAAKIDNAYKEAKTAISDPDLKNVPDVKIELENQLGKLQAKTGRAAPKPAPAANSPEAAQANSIA---RKTNEVKAPVAQAANNTNVNTTM---VKNNKSVHVQAPVTSTNAPGVFHGTGVN</Hsp_hseq> + <Hsp_midline>EL EA E T L + + +D LSKL+S LESK Q VE K E +I+D K E P + +LP NL P+E + K D K + + K GFK+ S+ DKI+ LFK +TA EAAKMA ++F ++ IDL+RIHFKYWT+KF + FD + G W + +F L D I+ + GDWS LA AI + + +L ++ GI+K+++ +L GF + A +I LE Q T L+ ++QK +AK Q K +++ GI F F +G + + D QA ++ LK + E + T+ NEARAA+ R E + +DP +P ++ AY AK +ISD + + P K EL+ + ++++K + P +P ++ N +K K ++ + NV T V N+K++H VT+T APGVF TGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>34</Hit_num> + <Hit_id>gi|311993473|ref|YP_004010338.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit [Acinetobacter phage Acj9] >gi|295917430|gb|ADG60101.1| gp29 baseplate hub subunit [Acinetobacter phage Acj9]</Hit_def> + <Hit_accession>YP_004010338</Hit_accession> + <Hit_len>572</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>172.17</Hsp_bit-score> + <Hsp_score>435</Hsp_score> + <Hsp_evalue>5.19477e-43</Hsp_evalue> + <Hsp_query-from>86</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>72</Hsp_hit-from> + <Hsp_hit-to>572</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>159</Hsp_identity> + <Hsp_positive>249</Hsp_positive> + <Hsp_gaps>58</Hsp_gaps> + <Hsp_align-len>525</Hsp_align-len> + <Hsp_qseq>ESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENN--KKDQKKDDKK-----PTDMLGDLLKTTKG-------GFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSA-EAGEWGGL---------LQSIF-GMLGD---IKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFD-----WVLGRENKIDSTQASDRDQ-ETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>EETKYLSNTADEISAKLSVLSERLKVKYDAASPDAPPVVRDNSTA-EVLADRL-DAQSEEQPKKQAWMPQPM-------------PVEKKPSDDLLSKSEDKGSKEGVKGAPNESTIPMIAAVKGVGSVVKAGFNKSIGIVDKISNLLFKMSVKQIADAALMGAAIFGIILSIDLLKAAWAAWGEKIMAKVEEWTTIFKGWWEGFKGWASSFSDLTTAFEGMRGDFMGIRNAWESGDWPSLAKALGTTIKDGLMTLSGILDRLFTKVLSTILDKVGLGKAAKAVEAEGLQRYQGKTNNKLSDENQKKLAEEQIRR-EKKDGLTPTQRGLTSFLPDKMRKGWAL-TDNEYNQIQAEKKDKAATKNL---SHDDQVKVTAATNEAREAVARFKNIADNYDPNKKDQAAQFDKYKKEAQAYISKPELAKSPAVKAELEAQVAAI-SKGKGGKASVAPEKS--ANSQDSGTVKNIKVAEAQRAANKNASPAGNTV-IQTNVAKTNKNVHVQAPVTSTTAPGVYGATKVN</Hsp_hseq> + <Hsp_midline>E K L+ A IS KLS L+ L+ K A ST V+ D+L D E P + P+ PV ++P ++ K + K K+ P + ++ KG GF +I I DKIS++LFK +V +A+AA M A +F ++L IDLL+ + W +K M+ +E++ G W G L + F GM GD I+ WE+GDW LA A+ + D + LS I+ +K+ ++ILD +G AA + L+ +Q +T N LS+++QK LA+ Q +R E+ G+ + D W L +N+ + QA +D+ T+NL + + + + NEAR AV R + + DP +K A+ IS ++ PA K EL+ + + SK + K P+ + A S+D+ V+NI+ AE + +K ++ N Q N +K +H VT+T APGV+GAT VN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>35</Hit_num> + <Hit_id>gi|310722277|ref|YP_003969101.1|</Hit_id> + <Hit_def>unnamed protein product [Aeromonas phage phiAS4] >gi|306021120|gb|ADM79655.1| baseplate hub [Aeromonas phage phiAS4]</Hit_def> + <Hit_accession>YP_003969101</Hit_accession> + <Hit_len>565</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>150.984</Hsp_bit-score> + <Hsp_score>380</Hsp_score> + <Hsp_evalue>5.93083e-36</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>569</Hsp_query-to> + <Hsp_hit-from>36</Hsp_hit-from> + <Hsp_hit-to>560</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>143</Hsp_identity> + <Hsp_positive>271</Hsp_positive> + <Hsp_gaps>69</Hsp_gaps> + <Hsp_align-len>560</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEVIEEKGN-------NLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQK--VQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKK----DQKKDDKKPTDMLGD-LLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETL-IKQNEARAAVQRLE------KYIGDVDPENPTNMQSLEKAY-------NSAKKSISDSAISDQPA--TKKELDKRFQRVESKYQKLKEDNTPKPAA---PATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNV-NNSKTIHQVQTVTATPAPGV</Hsp_qseq> + <Hsp_hseq>DLLASSELIAETVEQ-GNSELRKIVNNTSETENIAAATELSAEATEISNQHLKEISDTSKKTFSKLSEFAEKLKNNFLADVEKNPITATNTSDQTAKKIVEEEEQTPKNNPVLGYLKTISE---------DIKFLKNDKPKEEEKEDKVKPDKEENVERAIDRIGDRIVSSVDNGFKKTISVADSISSMLFKYTLTAVLNFAKMAALVLSLIMTFDVLSRHFTHWTKMFEENYAEFKNQLGSLATPFENVHGVITDLMNYFKSDEYTKMFVRLAEGAFDQMKYMVNMMMVGLAKLGATILRALGADEKADSLEASAISVAASEVGYTPSKEEEEVIGRVRKREAEDANN---------TEA-NWFEKQWRKVNG-----EDEETPDEK----EKREKRMEIAKNTTAEQFGRYDVLSGKINHVGVTAKKNETSPELLNKHRELLDDRSNEVEQSYQEGKLTKESYEQLRVEIDK-----QTKFLAEHEKTLVVPTAAIKPAPEPEVSTVKSIDKEEKRVESKKQEAASQNNYHTKANIVKNQNQTIVQAPR-TSSPGPGI</Hsp_hseq> + <Hsp_midline>D+ +++EL+AE +E+ GN N +N+A TEL+AEA+E + + +K ++ + KLS+ A L++ A +K + + S T ++E++ P G + I D F + E + D++++ ++ D +GD ++ + GFK TIS+ D ISSMLFKYT+TA+ AKMAA++ +L++ D+L HF +WT F N+ EF + G +++ G++ D+ ++++ +++ + V + +G D + + +M +G++K+ A+IL ALG + A ++ SA+ G + S+++++ + + + + E+ T A +W + K++ D+ET + K EKRE+ + I +N R + ++G +N T+ + L K N ++S + ++ + + E+DK ++K+ E P A PA + V++I K E E K+ N +T+ N V N ++TI Q T++P PG+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>36</Hit_num> + <Hit_id>gi|472438116|ref|YP_007677896.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Aeromonas phage Aes012] >gi|395653254|gb|AFN69809.1| baseplate hub subunit tail length determinator [Aeromonas phage Aes012]</Hit_def> + <Hit_accession>YP_007677896</Hit_accession> + <Hit_len>565</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>150.599</Hsp_bit-score> + <Hsp_score>379</Hsp_score> + <Hsp_evalue>8.25687e-36</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>569</Hsp_query-to> + <Hsp_hit-from>36</Hsp_hit-from> + <Hsp_hit-to>560</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>143</Hsp_identity> + <Hsp_positive>271</Hsp_positive> + <Hsp_gaps>69</Hsp_gaps> + <Hsp_align-len>560</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEVIEEKGN-------NLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQK--VQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKK----DQKKDDKKPTDMLGD-LLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETL-IKQNEARAAVQRLE------KYIGDVDPENPTNMQSLEKAY-------NSAKKSISDSAISDQPA--TKKELDKRFQRVESKYQKLKEDNTPKPAA---PATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNV-NNSKTIHQVQTVTATPAPGV</Hsp_qseq> + <Hsp_hseq>DLLASSELIAETVEQ-GNSELRKIVNNTSETENIAAATELSAEATEISNQHLKEISDTSKKTFSKLSEFAEKLKNNFLADVEKNPITATNTSDQTAKKIVEEEEQTPKDNPVLGYLKTISE---------DIKFLKNDKPKEEEKEDKVKPDEEENVERAIDRIGDRIVSSVDNGFKKTISVADSISSMLFKYTLTAVLNFAKMAALVLSLIMTFDVLSRHFTHWTKMFEENYAEFKNQLGSLATPFENVHGVITDLMNYFKSDEYTKMFVRLAKGAFDQMKYMVNMMMVGLAKLGATILRALGADEKADSLEASAISVAASEVGYTPSKEEEEVIGRVRKREAEDANN---------TEA-NWFEKQWRKVNG-----EDEETPDEK----EKREKRMEIAKNTTAEQFGRYDVLRGKINHVGVTAKKNETSPELLNKHRELLDDRSNEVEQSYQEGKLTKESYEQLRVEIDK-----QTKFLAEHEKTLVVPTAAIKPAPEPEVSTVKSIDKEEKRVESKKQEAASQTNYHTKANIVKNQNQTIVQAPR-TSSPGPGI</Hsp_hseq> + <Hsp_midline>D+ +++EL+AE +E+ GN N +N+A TEL+AEA+E + + +K ++ + KLS+ A L++ A +K + + S T ++E++ P + G + I D F + E + D++++ ++ D +GD ++ + GFK TIS+ D ISSMLFKYT+TA+ AKMAA++ +L++ D+L HF +WT F N+ EF + G +++ G++ D+ ++++ +++ + V + KG D + + +M +G++K+ A+IL ALG + A ++ SA+ G + S+++++ + + + + E+ T A +W + K++ D+ET + K EKRE+ + I +N R + ++G +N T+ + L K N ++S + ++ + + E+DK ++K+ E P A PA + V++I K E E K+ +T+ N V N ++TI Q T++P PG+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>37</Hit_num> + <Hit_id>gi|311992947|ref|YP_004009814.1|</Hit_id> + <Hit_def>gp29 baseplate hub subunit [Acinetobacter phage Acj61] >gi|295815236|gb|ADG36162.1| gp29 baseplate hub subunit [Acinetobacter phage Acj61]</Hit_def> + <Hit_accession>YP_004009814</Hit_accession> + <Hit_len>597</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>149.443</Hsp_bit-score> + <Hsp_score>376</Hsp_score> + <Hsp_evalue>2.04985e-35</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>576</Hsp_query-to> + <Hsp_hit-from>46</Hsp_hit-from> + <Hsp_hit-to>597</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>174</Hsp_identity> + <Hsp_positive>287</Hsp_positive> + <Hsp_gaps>61</Hsp_gaps> + <Hsp_align-len>573</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEV---IEEKGNNLIDSVDNVAEG-----TELAAEASERTTESI------KTLTGVASTISDKLSKLASML-ESKVQA-VEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPT------DMLGDLLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSA-------EAGEWGGL---LQSIF-GM---LGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKR-IEEGPGIIDKA-GEFKTRAFDWVLG--RENKIDSTQASDRDQETQNLKAMAPEKREETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPATKKELDKRFQRVESKYQKLKEDNTPKPAAPATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNVNNSKTIHQVQTVTATPAPGVFGATGVN</Hsp_qseq> + <Hsp_hseq>DMKAANDALDDIRDQVSDKADDPIDTLDASKQSLASIDNKMSQQISDNLASSIVQRRYEGTMIGETQNISAKLSLLLGKLTEMHVDAQVEAAQKDNIKSEPTTSEVIGDLIKKEQPEQKPEIAEKILPTEEK----------PSTKLLDENAGKSGKELVGKANPIVMGLDKVGGLLKT---GFKSSIGVMDKISGMLFKFTATQAINAAKVAAAIFAIILAIDLIKIYWSVWGEKIMAKLSEWAEIFKGWWDTFTDWGSQFSDFKTAFEGMGANLMEIKNAWVSGDFPALAKALGNAIIDMGKTISGIIGRTLASLFGPLLRKLGFGETADNLEAAGLRHYQNMTDNRLSPENQRKLAENQVKQEAKDGKTATERGMTDFLPNTWRNKLGFISDNELSQINAEKKDQSARS--NLSQEQKVDSVAATNEAREAIARYKKFADAANPDNAGDMAKVDKYKKEAAQYLSNKALDLTPSIKSELQTQYNAIKVKSKKDDV----KPETSAASKDTQTVNSIKTAEAAK--ANQQTQQTNVANVQNNVVKNSKTVHVQAPTTSTRAPGVHKATGVN</Hsp_hseq> + <Hsp_midline>D+++AN+ + ++ + +K ++ ID++D + +++ + S+ SI T+ G IS KLS L L E V A VE +++ S T VI D + + P + E+ILP + P EN K K+ K D +G LLKT GFK++I + DKIS MLFK+T T AAK+AA +FA++L IDL++I++ W +K M+ E++ +WG ++ F GM L +IK W +GD+ LA A+ + D+ +S I+ ++ + +L LGF A + + L +Q T N LS ++Q+ LA+ Q K+ ++G ++ +F + LG +N++ A +DQ ++ ++ E++ +++ NEAR A+ R +K+ +P+N +M ++K A + +S+ A+ P+ K EL ++ ++ K +K KP A S+D Q V +I+ AE AK + + T NVAN Q N V NSKT+H T+T APGV ATGVN</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>38</Hit_num> + <Hit_id>gi|401824980|gb|AFQ22670.1|</Hit_id> + <Hit_def>baseplate hub [Stenotrophomonas phage IME13]</Hit_def> + <Hit_accession>AFQ22670</Hit_accession> + <Hit_len>565</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>147.902</Hsp_bit-score> + <Hsp_score>372</Hsp_score> + <Hsp_evalue>5.89358e-35</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>569</Hsp_query-to> + <Hsp_hit-from>36</Hsp_hit-from> + <Hsp_hit-to>560</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>142</Hsp_identity> + <Hsp_positive>270</Hsp_positive> + <Hsp_gaps>69</Hsp_gaps> + <Hsp_align-len>560</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEVIEEKGN-------NLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQK--VQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKK----DQKKDDKKPTDMLGD-LLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETL-IKQNEARAAVQRLE------KYIGDVDPENPTNMQSLEKAY-------NSAKKSISDSAISDQPA--TKKELDKRFQRVESKYQKLKEDNTPKPAA---PATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNV-NNSKTIHQVQTVTATPAPGV</Hsp_qseq> + <Hsp_hseq>DLLAASELISETVEQ-GNSELRKIVNNTSETENIAAATEISAEATEISNQHLKEISDTSKKTFSKLSEFAEKLKNNFLADVEKNPITTTNTSDQTAKKIVEEEEQTPKNNPVLGYLKTISE---------DIKFLKNDKPKEEEKEDKVKPDEEENVERAIDRIGDRIVSSVDNGFKKTISIADSISSMLFKYTLTAVLNFAKMAALVLSLIMTFDVLSRHFTHWTKMFEENYAEFKNQLGSLATPFENVHGVITDLMNYFKSDEYTKMFVRLAEGAFDQMKYMVNMMMVGLAKLGATILRALGADEKADSLEASAISVAASEVGYTPSKEEEEVIGRVRKREAEDANN---------TEA-NWFEKQWRKVNG-----EDEETPDEK----EKREKRMEIAKNTTAEQFGRYDVLSGKINHVGVTAKKNETSPELLNKHRELLDDRSNEVEQSYQEGKLTKESYEQLRVEIDK-----QTKFLAEHEKTLVVPTAAIKPAPEPEVSTVKSIDKEEKRVESKKQEAASQTNYHTKANIVKNQNQTIVQAPR-TSSPGPGI</Hsp_hseq> + <Hsp_midline>D+ +A+EL++E +E+ GN N +N+A TE++AEA+E + + +K ++ + KLS+ A L++ A +K + + S T ++E++ P G + I D F + E + D++++ ++ D +GD ++ + GFK TISI D ISSMLFKYT+TA+ AKMAA++ +L++ D+L HF +WT F N+ EF + G +++ G++ D+ ++++ +++ + V + +G D + + +M +G++K+ A+IL ALG + A ++ SA+ G + S+++++ + + + + E+ T A +W + K++ D+ET + K EKRE+ + I +N R + ++G +N T+ + L K N ++S + ++ + + E+DK ++K+ E P A PA + V++I K E E K+ +T+ N V N ++TI Q T++P PG+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>39</Hit_num> + <Hit_id>gi|109290160|ref|YP_656409.1|</Hit_id> + <Hit_def>gp29 base plate hub [Aeromonas phage 25] >gi|104345833|gb|ABF72733.1| gp29 base plate hub [Aeromonas phage 25]</Hit_def> + <Hit_accession>YP_656409</Hit_accession> + <Hit_len>565</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>145.976</Hsp_bit-score> + <Hsp_score>367</Hsp_score> + <Hsp_evalue>2.35249e-34</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>569</Hsp_query-to> + <Hsp_hit-from>36</Hsp_hit-from> + <Hsp_hit-to>560</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>142</Hsp_identity> + <Hsp_positive>269</Hsp_positive> + <Hsp_gaps>69</Hsp_gaps> + <Hsp_align-len>560</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEVIEEKGN-------NLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQK--VQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKK----DQKKDDKKPTDMLGD-LLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETL-IKQNEARAAVQRLE------KYIGDVDPENPTNMQSLEKAY-------NSAKKSISDSAISDQPA--TKKELDKRFQRVESKYQKLKEDNTPKPAA---PATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNV-NNSKTIHQVQTVTATPAPGV</Hsp_qseq> + <Hsp_hseq>DLLAASELISETVEQ-GNSELRKIVNNTSETENIAAATELSAEATEISNQHLKEISDTSKKTFSKLSEFAEKLKNNFLADVEKNPITATNTSDQTAKKIVEEEEQTPKNNPVLGYLKTISE---------DIKFLKNDKPKEEEKEDKVKPDKEENVESAIDRIGDRIVSSVDNGFKKTINIADSISSMLFKYTLTAVLNFAKMAALVLSLIMTFDVLSRHFTHWTKMFEENYAEFKNQLGSLATPFENVHGVITDLMNYFKSDEYTKMFVRLAEGAFDQMKYMVNMMMVGLAKLGATILRALGADEKADSLEASAISVAASEVGYTPSKEEEEVIGRVRKREAEDANN---------TEA-NWFEKQWRKVNG-----EDEETPDEK----EKREKRMEIAKNTTAEQFGRYDVLSGKINHVGVTAKKNETSPELLNKHRELLDDRSNEVEQSYQEGKLTKESYEQLRVEIDK-----QTKFLAEHEKTLVVPTAAIKPAPEPEVSTVKSIDKEEKRVESKKQEAASQTNYHTKANIVKNQNQTIVQAPR-TSSPGPGI</Hsp_hseq> + <Hsp_midline>D+ +A+EL++E +E+ GN N +N+A TEL+AEA+E + + +K ++ + KLS+ A L++ A +K + + S T ++E++ P G + I D F + E + D++++ + D +GD ++ + GFK TI+I D ISSMLFKYT+TA+ AKMAA++ +L++ D+L HF +WT F N+ EF + G +++ G++ D+ ++++ +++ + V + +G D + + +M +G++K+ A+IL ALG + A ++ SA+ G + S+++++ + + + + E+ T A +W + K++ D+ET + K EKRE+ + I +N R + ++G +N T+ + L K N ++S + ++ + + E+DK ++K+ E P A PA + V++I K E E K+ +T+ N V N ++TI Q T++P PG+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>40</Hit_num> + <Hit_id>gi|423262258|ref|YP_007010857.1|</Hit_id> + <Hit_def>baseplate hub subunit tail length determinator [Aeromonas phage Aes508] >gi|402762136|gb|AFQ97250.1| baseplate hub subunit tail length determinator [Aeromonas phage Aes508]</Hit_def> + <Hit_accession>YP_007010857</Hit_accession> + <Hit_len>565</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>145.591</Hsp_bit-score> + <Hsp_score>366</Hsp_score> + <Hsp_evalue>3.57946e-34</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>569</Hsp_query-to> + <Hsp_hit-from>36</Hsp_hit-from> + <Hsp_hit-to>560</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>142</Hsp_identity> + <Hsp_positive>269</Hsp_positive> + <Hsp_gaps>69</Hsp_gaps> + <Hsp_align-len>560</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEVIEEKGN-------NLIDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQK--VQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKK----DQKKDDKKPTDMLGD-LLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKREETL-IKQNEARAAVQRLE------KYIGDVDPENPTNMQSLEKAY-------NSAKKSISDSAISDQPA--TKKELDKRFQRVESKYQKLKEDNTPKPAA---PATSEDNQRVQNIQKAENAKEQSKKSTGDMNVANTQVNNV-NNSKTIHQVQTVTATPAPGV</Hsp_qseq> + <Hsp_hseq>DLLASSELIAETVEQ-GNSELRKIVNNTSETENIAAATELSAEATEISNQHLKEISDTSKKTFSKLSEFAEKLKNNFLADVEKNPITTTNTSDQTAKKISEEEEQTPKNNPVLGYLKTISE---------DIKFLKNDKPKEEEKEDKVKPDKEENVERAIDRIGDRIVSSVDNGFKKTISVADSISSMLFKYTLTAVLNFAKMAALVLSLIMTFDVLSRHFTHWTKMFEENYAEFKNQLGSLATPFENVHGVITDLMNYFKSDEYTKMFVRLAEGAFDQMKYMVNMMMVGLAKLGATILRALGADEKADSLEASAISVAASEVGYTPSKEEEEVIGRVRKREAEDANN---------TEA-NWFEKQWRKVNG-----EDEETPDEK----EKREKRMEIAKNTTAEQFGRYDVLSGKINHVGVTAKKNETSPELLNKHRELLDDRSNEVEQSYQEGKLTKESYEQLRVEIDK-----QTKFLAEHEKTLVVPTAAIKPAPEPEVSTVKSIDKEEKRVESKKQEAASQTNYHTKANIVKNQNQTIVQAPR-TSSPGPGI</Hsp_hseq> + <Hsp_midline>D+ +++EL+AE +E+ GN N +N+A TEL+AEA+E + + +K ++ + KLS+ A L++ A +K + + S T + E++ P G + I D F + E + D++++ ++ D +GD ++ + GFK TIS+ D ISSMLFKYT+TA+ AKMAA++ +L++ D+L HF +WT F N+ EF + G +++ G++ D+ ++++ +++ + V + +G D + + +M +G++K+ A+IL ALG + A ++ SA+ G + S+++++ + + + + E+ T A +W + K++ D+ET + K EKRE+ + I +N R + ++G +N T+ + L K N ++S + ++ + + E+DK ++K+ E P A PA + V++I K E E K+ +T+ N V N ++TI Q T++P PG+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>41</Hit_num> + <Hit_id>gi|66391985|ref|YP_238910.1|</Hit_id> + <Hit_def>baseplate hub subunit [Aeromonas phage 31] >gi|62114822|gb|AAX63670.1| gp29 [Aeromonas phage 31]</Hit_def> + <Hit_accession>YP_238910</Hit_accession> + <Hit_len>566</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>144.05</Hsp_bit-score> + <Hsp_score>362</Hsp_score> + <Hsp_evalue>1.01075e-33</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>569</Hsp_query-to> + <Hsp_hit-from>36</Hsp_hit-from> + <Hsp_hit-to>562</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>150</Hsp_identity> + <Hsp_positive>269</Hsp_positive> + <Hsp_gaps>53</Hsp_gaps> + <Hsp_align-len>553</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEVIEEKGNNL------IDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQA--VEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGD-LLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKR---EETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPA---------TKKELDKRFQRVESKYQKLKEDNTPKPAA---PATSEDNQRVQNIQKAENAKE--QSKKSTGDMNVANTQVNNV-NNSKTIHQVQTVTATPAPGV</Hsp_qseq> + <Hsp_hseq>DSLAAQELIAETVEQGNNELRQIKANTASLHDTAAATELSAESTEMSNTILREISETGKQTFSKLSEFAERLKGSFSADDVEQAPIRTASSSDQAIQIINEENPEPENPLVG-----YLRTISEDIKFLRENKNEPSDPKDPDVVPDDKDDLKTMIDRIGDQIVKSVDSGFKRTVNIADSISSTLFKYTITAALNFAKMAALVLSLIIAFDVLSRHFSHWTQMFQEQYAEFKETLGSFGTPFENLTGIVTDLVNYFKSDEYLKMFVRLAEGAADQMIYIVNMMMVGLAKLGAAILRALGADDKADTLEASAISVATKTVGYTPSEEEEATIGRVRKRQAQE---------EAEQSEASWWEKKKREWDG-----KPIETDEEKAVRERKKSIAENTTAEQFGKHDALSQKIQHVGVTAEKNETSNELLGKHRELLEKRASDVEQAKQSGEITTESYKQLKVEIEKQREFLDAHEQKL-----LKPKASIKPAPEPEIGVVGSIAKEEKRVEASQTAKQEAASNY-NTNANIVKNNNQTLVQAPR-TSSPGPGI</Hsp_hseq> + <Hsp_midline>D +A EL+AE +E+ N L S+ + A TEL+AE++E + ++ ++ KLS+ A L+ A VEQ + +S+ + +I ++ P+P+ P L + ++ E+ P + + D K D K D +GD ++K+ GFK T++I D ISS LFKYT+TA AKMAA++ +L++ D+L HF +WT F + EF G +G +++ G++ D+ ++++ ++ + V + +G AD + + +M +G++K+ A+IL ALG ++ A T+ SA+ + G + SE+++ + + + ++ +E E + W ++ + D + ET KA+ K+ E T +Q A+ + +++G +N T+ + L K +K SD + Q K E++K+ + +++ QKL KP A PA + V +I K E E Q+ K N NT N V NN++T+ Q T++P PG+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>42</Hit_num> + <Hit_id>gi|37651664|ref|NP_932538.1|</Hit_id> + <Hit_def>baseplate hub subunit [Aeromonas phage 44RR2.8t] >gi|34732964|gb|AAQ81501.1| baseplate hub subunit [Aeromonas phage 44RR2.8t]</Hit_def> + <Hit_accession>NP_932538</Hit_accession> + <Hit_len>566</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>144.05</Hsp_bit-score> + <Hsp_score>362</Hsp_score> + <Hsp_evalue>1.1527e-33</Hsp_evalue> + <Hsp_query-from>44</Hsp_query-from> + <Hsp_query-to>569</Hsp_query-to> + <Hsp_hit-from>36</Hsp_hit-from> + <Hsp_hit-to>562</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>150</Hsp_identity> + <Hsp_positive>268</Hsp_positive> + <Hsp_gaps>53</Hsp_gaps> + <Hsp_align-len>553</Hsp_align-len> + <Hsp_qseq>DVQSANELVAEVIEEKGNNL------IDSVDNVAEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQA--VEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKKPTDMLGD-LLKTTKGGFKATISITDKISSMLFKYTVTALAEAAKMAAMLFALVLGIDLLRIHFKYWTDKFMSNFDEFSAEAGEWGGLLQSIFGMLGDIKKFWEAGDWSGLAVAIVKGLADVIYNLSEIMSLGISKISASILDALGFENAATTIRGSALEGFQERTGNSLSEDDQKALAKYQSKRIEEGPGIIDKAGEFKTRAFDWVLGRENKIDSTQASDRDQETQNLKAMAPEKR---EETLIKQNEARAAVQRLEKYIGDVDPENPTNMQSLEKAYNSAKKSISDSAISDQPA---------TKKELDKRFQRVESKYQKLKEDNTPKPAA---PATSEDNQRVQNIQKAENAKE--QSKKSTGDMNVANTQVNNV-NNSKTIHQVQTVTATPAPGV</Hsp_qseq> + <Hsp_hseq>DSLAAQELIAETVEQGNNELRQIKANTASLHDTAAATELGAESTEMSNTILREISETGKQTFSKLSEFAERLKGSFSADDVEQTPIRAASSSDQAIQIINEENPEPENPLVG-----YLRTISEDIKFLRENKNEPSDPKDPDVVPDDKDDLKTMIDRIGDQIVKSVDSGFKRTVNIADSISSTLFKYTITAALNFAKMAALVLSLIIAFDVLSRHFSHWTQMFQEQYAEFKETLGSFGTPFENLTGIVTDLVNYFKSDEYLKMFVRLAEGAADQMIYIVNMMMVGLAKLGAAILRALGADDKADTLEASAISVATKTVGYTPSEEEEATIGRVRKRQAQE---------EAEQSEASWWEKKKREWDG-----KPIETDEEKAVRERKKSIAENTTAEQFGKHDALSQKIQHVGVTAEKNETSNELLGKHRELLEKRASDVEQAKQSGEITTESYKQLKVEIEKQREFLDAHEQKL-----LKPKASIKPAPEPEIGVVGSIAKEEKRVEASQTAKQEAASNY-NTNANIVKNNNQTLVQAPR-TSSPGPGI</Hsp_hseq> + <Hsp_midline>D +A EL+AE +E+ N L S+ + A TEL AE++E + ++ ++ KLS+ A L+ A VEQ + +S+ + +I ++ P+P+ P L + ++ E+ P + + D K D K D +GD ++K+ GFK T++I D ISS LFKYT+TA AKMAA++ +L++ D+L HF +WT F + EF G +G +++ G++ D+ ++++ ++ + V + +G AD + + +M +G++K+ A+IL ALG ++ A T+ SA+ + G + SE+++ + + + ++ +E E + W ++ + D + ET KA+ K+ E T +Q A+ + +++G +N T+ + L K +K SD + Q K E++K+ + +++ QKL KP A PA + V +I K E E Q+ K N NT N V NN++T+ Q T++P PG+</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +<Hit> + <Hit_num>43</Hit_num> + <Hit_id>gi|398313739|emb|CCI89086.1|</Hit_id> + <Hit_def>phage baseplate hub [Yersinia phage phiD1]</Hit_def> + <Hit_accession>CCI89086</Hit_accession> + <Hit_len>191</Hit_len> + <Hit_hsps> + <Hsp> + <Hsp_num>1</Hsp_num> + <Hsp_bit-score>79.7221</Hsp_bit-score> + <Hsp_score>195</Hsp_score> + <Hsp_evalue>1.49556e-13</Hsp_evalue> + <Hsp_query-from>2</Hsp_query-from> + <Hsp_query-to>189</Hsp_query-to> + <Hsp_hit-from>3</Hsp_hit-from> + <Hsp_hit-to>187</Hsp_hit-to> + <Hsp_query-frame>0</Hsp_query-frame> + <Hsp_hit-frame>0</Hsp_hit-frame> + <Hsp_identity>69</Hsp_identity> + <Hsp_positive>102</Hsp_positive> + <Hsp_gaps>17</Hsp_gaps> + <Hsp_align-len>195</Hsp_align-len> + <Hsp_qseq>KSENMSTMRRRKVIADSKGERDAASTASDQVDSLELIGLKLDDVQSANELVAEVIEEKGNNLIDSVDNV-------AEGTELAAEASERTTESIKTLTGVASTISDKLSKLASMLESKVQAVEQKVQESGASASTGLSVIEDKLPDPDEPESPGLPERILPPLDDNNNLPDEDFFPPVPQEPENNKKDQKKDDKK</Hsp_qseq> + <Hsp_hseq>KPQEMQTMRR-KVISDNKPTQEAAKSASNTLSGLNDISTKLDDTQAASELIAQTVEEKSNEIVGAIGNVESAVSDTTAGSELIAETVEIGNNINKE---IGESLGSKLDKLTSLLEQKIQTA--GIQQTGTXLATVESAIPVKVVEDDTDRXXVLXYRXLKQLIMILTLI---FSLPLSQLSQ-SKNHQKKNRKK</Hsp_hseq> + <Hsp_midline>K + M TMRR KVI+D+K ++AA +AS+ + L I KLDD Q+A+EL+A+ +EEK N ++ ++ NV G+EL AE E K + ++ KL KL S+LE K+Q +Q++G +T S I K+ + D L R L L L F P+ Q + +K QKK+ KK</Hsp_midline> + </Hsp> + </Hit_hsps> +</Hit> +</Iteration_hits> + <Iteration_stat> + <Statistics> + <Statistics_db-num>48094830</Statistics_db-num> + <Statistics_db-len>17186091396</Statistics_db-len> + <Statistics_hsp-len>153</Statistics_hsp-len> + <Statistics_eff-space>4157067357738</Statistics_eff-space> + <Statistics_kappa>0.041</Statistics_kappa> + <Statistics_lambda>0.267</Statistics_lambda> + <Statistics_entropy>0.14</Statistics_entropy> + </Statistics> + </Iteration_stat> +</Iteration> +</BlastOutput_iterations> +</BlastOutput> +
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/test.vcf Thu Jun 18 12:10:51 2015 -0400 @@ -0,0 +1,23 @@ +##fileformat=VCFv4.0 +##fileDate=20090805 +##source=myImputationProgramV3.1 +##reference=1000GenomesPilot-NCBI36 +##phasing=partial +##INFO=<ID=NS,Number=1,Type=Integer,Description="Number of Samples With Data"> +##INFO=<ID=DP,Number=1,Type=Integer,Description="Total Depth"> +##INFO=<ID=AF,Number=.,Type=Float,Description="Allele Frequency"> +##INFO=<ID=AA,Number=1,Type=String,Description="Ancestral Allele"> +##INFO=<ID=DB,Number=0,Type=Flag,Description="dbSNP membership, build 129"> +##INFO=<ID=H2,Number=0,Type=Flag,Description="HapMap2 membership"> +##FILTER=<ID=q10,Description="Quality below 10"> +##FILTER=<ID=s50,Description="Less than 50% of samples have data"> +##FORMAT=<ID=GT,Number=1,Type=String,Description="Genotype"> +##FORMAT=<ID=GQ,Number=1,Type=Integer,Description="Genotype Quality"> +##FORMAT=<ID=DP,Number=1,Type=Integer,Description="Read Depth"> +##FORMAT=<ID=HQ,Number=2,Type=Integer,Description="Haplotype Quality"> +#CHROM POS ID REF ALT QUAL FILTER INFO FORMAT NA00001 NA00002 NA00003 +Merlin 14370 rs6054257 G A 29 PASS NS=3;DP=14;AF=0.5;DB;H2 GT:GQ:DP:HQ 0|0:48:1:51,51 1|0:48:8:51,51 1/1:43:5:.,. +Merlin 17330 . T A 3 q10 NS=3;DP=11;AF=0.017 GT:GQ:DP:HQ 0|0:49:3:58,50 0|1:3:5:65,3 0/0:41:3 +Merlin 1110696 rs6040355 A G,T 67 PASS NS=2;DP=10;AF=0.333,0.667;AA=T;DB GT:GQ:DP:HQ 1|2:21:6:23,27 2|1:2:0:18,2 2/2:35:4 +Merlin 1230237 . T . 47 PASS NS=3;DP=13;AA=T GT:GQ:DP:HQ 0|0:54:7:56,60 0|0:48:4:51,51 0/0:61:2 +Merlin 1234567 microsat1 GTCT G,GTACT 50 PASS NS=3;DP=9;AA=G GT:GQ:DP 0/1:35:4 0/2:17:2 1/1:40:3
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/xmfa.gff Thu Jun 18 12:10:51 2015 -0400 @@ -0,0 +1,5918 @@ +##gff-version 3 +##sequence-region Merlin 1 172788 +Merlin progressiveMauve match 123963 171642 . - . ID=HM137666;Target=HM137666 +Merlin progressiveMauve match_part 123963 123982 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 123983 124032 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 124033 124082 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 124083 124132 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 124133 124182 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 124183 124232 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 124233 124282 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 124283 124329 42.5531914894 + . Parent=HM137666 +Merlin progressiveMauve match_part 124469 124494 73.0769230769 + . Parent=HM137666 +Merlin progressiveMauve match_part 124495 124544 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 124601 124650 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 124651 124700 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 124701 124750 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 124751 124796 56.5217391304 + . Parent=HM137666 +Merlin progressiveMauve match_part 124797 124846 14 + . Parent=HM137666 +Merlin progressiveMauve match_part 124847 124868 27.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 124869 124918 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 124919 124964 45.652173913 + . Parent=HM137666 +Merlin progressiveMauve match_part 124965 125009 55.5555555556 + . Parent=HM137666 +Merlin progressiveMauve match_part 125010 125059 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 125060 125077 33.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 125078 125127 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 125128 125177 26 + . Parent=HM137666 +Merlin progressiveMauve match_part 125744 125793 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 125794 125843 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 125844 125893 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 125894 125943 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 125944 125993 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 125994 126043 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 126044 126093 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 126094 126143 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 126144 126193 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 126194 126240 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 126241 126290 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 126291 126333 58.1395348837 + . Parent=HM137666 +Merlin progressiveMauve match_part 126334 126378 71.1111111111 + . Parent=HM137666 +Merlin progressiveMauve match_part 126379 126425 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 126426 126468 67.4418604651 + . Parent=HM137666 +Merlin progressiveMauve match_part 126469 126515 74.4680851064 + . Parent=HM137666 +Merlin progressiveMauve match_part 126516 126565 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 126566 126603 60.5263157895 + . Parent=HM137666 +Merlin progressiveMauve match_part 126604 126653 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 126654 126703 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 126704 126753 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 126754 126803 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 126804 126853 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 126854 126903 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 126904 126953 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 126954 127003 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 127004 127053 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127054 127103 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 127104 127153 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 127154 127203 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 127204 127253 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 127254 127296 74.4186046512 + . Parent=HM137666 +Merlin progressiveMauve match_part 127297 127346 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127347 127390 70.4545454545 + . Parent=HM137666 +Merlin progressiveMauve match_part 127391 127440 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 127441 127484 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 127485 127534 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 127535 127584 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127585 127634 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 127635 127684 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 127685 127734 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 127735 127784 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127785 127833 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 127834 127883 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 127884 127926 60.4651162791 + . Parent=HM137666 +Merlin progressiveMauve match_part 127927 127974 60.4166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 127975 128024 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 128025 128074 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 128075 128124 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 128125 128172 37.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 128740 128750 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 128751 128800 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 128801 128850 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 128851 128900 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 128901 128950 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 128951 129000 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 129001 129050 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 129051 129100 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 129101 129150 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 129151 129200 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 129201 129250 22 + . Parent=HM137666 +Merlin progressiveMauve match_part 130448 130493 52.1739130435 + . Parent=HM137666 +Merlin progressiveMauve match_part 130494 130540 76.5957446809 + . Parent=HM137666 +Merlin progressiveMauve match_part 130541 130590 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 130591 130640 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 130641 130690 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 130691 130740 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 130741 130790 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 130791 130840 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 130841 130878 78.9473684211 + . Parent=HM137666 +Merlin progressiveMauve match_part 130879 130927 40.8163265306 + . Parent=HM137666 +Merlin progressiveMauve match_part 131920 131966 82.9787234043 + . Parent=HM137666 +Merlin progressiveMauve match_part 131967 132013 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 132014 132063 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 132064 132113 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 132114 132163 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 132173 132190 94.4444444444 + . Parent=HM137666 +Merlin progressiveMauve match_part 132191 132239 67.3469387755 + . Parent=HM137666 +Merlin progressiveMauve match_part 132824 132839 100 + . Parent=HM137666 +Merlin progressiveMauve match_part 132840 132889 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 132890 132939 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 132940 132989 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 132990 133039 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 133040 133089 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 133090 133139 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 133140 133179 67.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 133180 133229 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 133230 133279 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 133280 133329 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 133330 133376 53.1914893617 + . Parent=HM137666 +Merlin progressiveMauve match_part 133377 133425 69.387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 133426 133475 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 133476 133525 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 133526 133575 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 133576 133625 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 133626 133669 70.4545454545 + . Parent=HM137666 +Merlin progressiveMauve match_part 133670 133719 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 133720 133769 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 134020 134068 2.04081632653 + . Parent=HM137666 +Merlin progressiveMauve match_part 134069 134118 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 134119 134168 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 134169 134218 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 134219 134268 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 134269 134318 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 134319 134359 87.8048780488 + . Parent=HM137666 +Merlin progressiveMauve match_part 134360 134391 62.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 134392 134441 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 134442 134491 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 134492 134541 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 134542 134591 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 134592 134641 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 134642 134689 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 134690 134739 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 134740 134785 52.1739130435 + . Parent=HM137666 +Merlin progressiveMauve match_part 134786 134835 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 134927 134937 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 134938 134986 59.1836734694 + . Parent=HM137666 +Merlin progressiveMauve match_part 134987 135036 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 135037 135085 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 135534 135558 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 135559 135605 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 135606 135655 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 135656 135705 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 135706 135743 39.4736842105 + . Parent=HM137666 +Merlin progressiveMauve match_part 135744 135793 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 135794 135843 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 135844 135893 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 135894 135943 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 135944 135993 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 135994 136043 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 136044 136087 61.3636363636 + . Parent=HM137666 +Merlin progressiveMauve match_part 136088 136137 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 136138 136187 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 136188 136237 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 136238 136287 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 136288 136325 68.4210526316 + . Parent=HM137666 +Merlin progressiveMauve match_part 136326 136375 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 136376 136425 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 136426 136469 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 136470 136517 64.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 136518 136564 59.5744680851 + . Parent=HM137666 +Merlin progressiveMauve match_part 136565 136614 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 136615 136664 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 136665 136714 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 136715 136764 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 136765 136814 12 + . Parent=HM137666 +Merlin progressiveMauve match_part 137888 137937 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 137938 137987 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 137988 138037 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 138038 138078 73.1707317073 + . Parent=HM137666 +Merlin progressiveMauve match_part 138079 138127 59.1836734694 + . Parent=HM137666 +Merlin progressiveMauve match_part 138128 138177 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 138178 138227 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 138228 138277 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 138278 138318 65.8536585366 + . Parent=HM137666 +Merlin progressiveMauve match_part 138319 138368 34 + . Parent=HM137666 +Merlin progressiveMauve match_part 138525 138544 55 + . Parent=HM137666 +Merlin progressiveMauve match_part 138545 138594 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 138595 138644 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 138645 138694 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 138695 138744 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 138745 138790 69.5652173913 + . Parent=HM137666 +Merlin progressiveMauve match_part 138791 138840 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 138841 138884 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 138885 138934 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 138935 138983 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 138984 139027 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 139028 139077 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 139078 139127 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 139128 139176 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 139177 139226 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 139227 139276 32 + . Parent=HM137666 +Merlin progressiveMauve match_part 139393 139442 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 139443 139488 65.2173913043 + . Parent=HM137666 +Merlin progressiveMauve match_part 139489 139538 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 139539 139585 38.2978723404 + . Parent=HM137666 +Merlin progressiveMauve match_part 139586 139631 71.7391304348 + . Parent=HM137666 +Merlin progressiveMauve match_part 139632 139681 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 139682 139731 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 139732 139773 73.8095238095 + . Parent=HM137666 +Merlin progressiveMauve match_part 139774 139823 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 139824 139873 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 139874 139923 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 139924 139973 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 139974 140023 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 140024 140073 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 140074 140123 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 140124 140173 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 140174 140220 72.3404255319 + . Parent=HM137666 +Merlin progressiveMauve match_part 140221 140270 4 + . Parent=HM137666 +Merlin progressiveMauve match_part 140452 140472 76.1904761905 + . Parent=HM137666 +Merlin progressiveMauve match_part 140473 140522 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 140523 140572 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 140573 140622 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 140623 140672 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 140673 140722 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 140723 140770 68.75 + . Parent=HM137666 +Merlin progressiveMauve match_part 140771 140811 46.3414634146 + . Parent=HM137666 +Merlin progressiveMauve match_part 140812 140861 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 140862 140910 67.3469387755 + . Parent=HM137666 +Merlin progressiveMauve match_part 140911 140960 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 140961 141010 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 141011 141060 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141061 141110 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141111 141160 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 141161 141210 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 141211 141260 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 141261 141310 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 141311 141360 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 141361 141385 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 141386 141411 84.6153846154 + . Parent=HM137666 +Merlin progressiveMauve match_part 141412 141461 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 141462 141504 62.7906976744 + . Parent=HM137666 +Merlin progressiveMauve match_part 141505 141534 93.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 141535 141584 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 141585 141634 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 141635 141684 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141685 141734 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 141735 141784 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 141785 141834 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 141835 141884 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 141885 141934 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141935 141984 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 141985 142034 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 142035 142084 2 + . Parent=HM137666 +Merlin progressiveMauve match_part 142143 142192 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 142193 142242 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 142243 142292 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 142293 142342 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 142343 142392 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 142393 142442 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 142443 142492 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 142493 142542 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 142543 142592 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 142593 142642 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 142643 142692 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 142693 142742 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 142743 142792 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 142793 142842 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 142843 142892 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 142893 142942 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 142943 142992 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 142993 143042 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143043 143089 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 143090 143139 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 143140 143189 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 143190 143239 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 143240 143289 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 143290 143339 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 143340 143389 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143390 143439 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 143440 143489 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143490 143539 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 143540 143589 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 143590 143639 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 143640 143689 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 143690 143739 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143740 143789 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 143790 143839 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 143840 143889 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 143890 143939 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 143940 143989 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 143990 144039 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 144040 144089 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 144090 144139 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 144140 144188 77.5510204082 + . Parent=HM137666 +Merlin progressiveMauve match_part 144189 144238 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 144239 144288 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 144289 144338 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 144339 144379 63.4146341463 + . Parent=HM137666 +Merlin progressiveMauve match_part 144380 144429 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 144430 144479 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 144480 144529 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 144530 144579 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 144580 144629 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 144630 144679 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 144957 144974 88.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 144975 145024 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 145025 145074 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145075 145124 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 145125 145173 73.4693877551 + . Parent=HM137666 +Merlin progressiveMauve match_part 145180 145202 82.6086956522 + . Parent=HM137666 +Merlin progressiveMauve match_part 145203 145252 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 145253 145302 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145303 145352 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 145353 145402 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 145403 145452 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 145453 145502 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145503 145552 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 145553 145602 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145603 145652 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 146375 146424 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 146425 146474 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 146475 146519 77.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 146520 146569 14 + . Parent=HM137666 +Merlin progressiveMauve match_part 146757 146791 48.5714285714 + . Parent=HM137666 +Merlin progressiveMauve match_part 146792 146841 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 146842 146891 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 146892 146941 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 146942 146991 6 + . Parent=HM137666 +Merlin progressiveMauve match_part 149433 149454 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 149455 149504 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 149505 149538 58.8235294118 + . Parent=HM137666 +Merlin progressiveMauve match_part 149539 149580 61.9047619048 + . Parent=HM137666 +Merlin progressiveMauve match_part 149581 149629 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 149630 149674 57.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 149675 149715 56.0975609756 + . Parent=HM137666 +Merlin progressiveMauve match_part 149716 149747 59.375 + . Parent=HM137666 +Merlin progressiveMauve match_part 149748 149794 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 149795 149832 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 149833 149882 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 149883 149932 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 149933 149980 75 + . Parent=HM137666 +Merlin progressiveMauve match_part 149981 150030 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 150031 150080 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 150081 150130 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 150131 150180 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 150181 150230 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 150231 150280 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 150281 150330 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 150331 150380 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 150381 150430 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 150431 150480 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 150481 150530 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 150531 150580 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 150640 150672 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 150673 150722 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 150723 150772 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 150773 150822 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 150823 150872 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 150873 150922 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 150923 150972 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 150973 151022 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 151023 151072 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 151073 151122 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 151123 151172 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151173 151222 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 151223 151272 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 151273 151322 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 151323 151372 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 151373 151422 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 151423 151472 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151473 151522 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 151523 151572 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 151573 151620 77.0833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 151621 151670 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151671 151720 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151721 151770 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151771 151820 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 151821 151863 69.7674418605 + . Parent=HM137666 +Merlin progressiveMauve match_part 151864 151913 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151914 151963 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 151964 152013 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 152014 152063 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 152064 152112 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 152113 152162 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 152163 152212 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 152213 152262 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 152263 152312 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 152313 152362 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 152363 152412 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 152413 152462 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 152463 152512 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 152513 152562 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 152563 152610 62.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 152611 152654 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 152655 152704 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 152705 152754 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 152755 152804 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 152805 152818 85.7142857143 + . Parent=HM137666 +Merlin progressiveMauve match_part 152819 152862 70.4545454545 + . Parent=HM137666 +Merlin progressiveMauve match_part 152863 152912 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 152913 152962 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 152963 153012 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 153013 153062 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 153063 153109 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 153110 153159 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 153160 153208 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 153209 153256 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 153257 153306 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 153307 153353 53.1914893617 + . Parent=HM137666 +Merlin progressiveMauve match_part 153354 153403 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 153404 153453 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 153454 153503 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 153504 153553 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153554 153603 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153604 153653 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 153654 153703 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 153704 153753 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 153754 153803 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153804 153852 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 153853 153897 77.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 153898 153947 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153948 153997 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 153998 154047 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 154048 154097 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 154098 154147 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 154148 154197 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 154198 154247 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 154248 154297 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 154298 154344 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 154345 154394 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 154395 154444 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 154445 154494 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 154495 154544 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 154605 154639 51.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 154640 154675 69.4444444444 + . Parent=HM137666 +Merlin progressiveMauve match_part 154676 154725 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 154726 154769 77.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 154770 154819 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 154820 154869 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 154870 154919 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 154920 154966 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 154967 155016 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 155017 155066 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 155067 155116 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 155117 155166 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 155167 155216 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 155217 155266 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 155267 155316 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 155317 155363 55.3191489362 + . Parent=HM137666 +Merlin progressiveMauve match_part 155364 155413 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 155464 155507 65.9090909091 + . Parent=HM137666 +Merlin progressiveMauve match_part 155508 155557 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 155558 155607 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 155608 155657 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 155658 155707 20 + . Parent=HM137666 +Merlin progressiveMauve match_part 156017 156040 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 156041 156087 53.1914893617 + . Parent=HM137666 +Merlin progressiveMauve match_part 156088 156137 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 156138 156187 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 156188 156218 6.45161290323 + . Parent=HM137666 +Merlin progressiveMauve match_part 156219 156268 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 156269 156312 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 156313 156359 68.085106383 + . Parent=HM137666 +Merlin progressiveMauve match_part 156360 156409 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 156410 156459 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 156460 156499 45 + . Parent=HM137666 +Merlin progressiveMauve match_part 156500 156549 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 156550 156599 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 156600 156641 54.7619047619 + . Parent=HM137666 +Merlin progressiveMauve match_part 156642 156690 71.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 156691 156740 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 157836 157872 62.1621621622 + . Parent=HM137666 +Merlin progressiveMauve match_part 157873 157922 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 157923 157972 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 157973 158022 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158023 158072 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158073 158117 48.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 158118 158155 55.2631578947 + . Parent=HM137666 +Merlin progressiveMauve match_part 158156 158204 46.9387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 158205 158254 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 158255 158304 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 158305 158348 56.8181818182 + . Parent=HM137666 +Merlin progressiveMauve match_part 158349 158393 57.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 158394 158441 64.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 158442 158491 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158492 158541 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 158542 158591 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158592 158641 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 158642 158691 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158692 158741 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 159334 159379 58.6956521739 + . Parent=HM137666 +Merlin progressiveMauve match_part 159380 159429 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 159430 159479 38 + . Parent=HM137666 +Merlin progressiveMauve match_part 161952 161995 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 161996 162045 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 162046 162095 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 162096 162145 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 162146 162195 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 162196 162245 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 162246 162292 68.085106383 + . Parent=HM137666 +Merlin progressiveMauve match_part 162293 162342 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 162343 162392 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 162393 162438 73.9130434783 + . Parent=HM137666 +Merlin progressiveMauve match_part 162439 162488 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 162489 162538 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 162539 162588 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 162589 162638 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 162639 162686 83.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 162687 162734 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 162735 162783 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 163000 163031 90.625 + . Parent=HM137666 +Merlin progressiveMauve match_part 163032 163081 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 163735 163782 72.9166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 163783 163832 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 163833 163874 69.0476190476 + . Parent=HM137666 +Merlin progressiveMauve match_part 163875 163911 59.4594594595 + . Parent=HM137666 +Merlin progressiveMauve match_part 163912 163961 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 163962 164011 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 164012 164061 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 164062 164111 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 164112 164161 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 164162 164211 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 164212 164261 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 164262 164311 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 164312 164361 30 + . Parent=HM137666 +Merlin progressiveMauve match_part 164648 164676 72.4137931034 + . Parent=HM137666 +Merlin progressiveMauve match_part 164677 164726 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 164727 164776 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 164777 164826 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 164827 164876 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 164877 164926 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 164927 164972 54.347826087 + . Parent=HM137666 +Merlin progressiveMauve match_part 164973 165021 30.612244898 + . Parent=HM137666 +Merlin progressiveMauve match_part 165280 165325 67.3913043478 + . Parent=HM137666 +Merlin progressiveMauve match_part 165399 165444 60.8695652174 + . Parent=HM137666 +Merlin progressiveMauve match_part 165445 165494 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 165495 165544 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 165545 165594 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 165595 165644 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 165645 165694 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 165695 165744 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 165745 165794 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 165795 165844 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 165845 165894 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 165895 165944 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 165945 165994 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 165995 166042 89.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 166043 166091 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 166092 166141 6 + . Parent=HM137666 +Merlin progressiveMauve match_part 167295 167333 64.1025641026 + . Parent=HM137666 +Merlin progressiveMauve match_part 167334 167383 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 167384 167433 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 167434 167483 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 167484 167533 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 167534 167580 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 167581 167630 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 167631 167678 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 167679 167728 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 167729 167776 56.25 + . Parent=HM137666 +Merlin progressiveMauve match_part 167777 167826 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 167827 167876 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 167877 167926 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 167927 167976 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 167977 168026 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 168027 168074 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 168075 168124 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168125 168174 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168175 168224 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 168225 168274 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168275 168324 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 168325 168374 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 168375 168424 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 168425 168474 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168475 168524 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 168525 168574 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 168575 168624 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 168625 168674 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 168675 168724 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 169065 169092 60.7142857143 + . Parent=HM137666 +Merlin progressiveMauve match_part 169093 169142 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 169143 169192 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 169193 169242 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 169243 169292 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 169293 169342 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 169343 169374 59.375 + . Parent=HM137666 +Merlin progressiveMauve match_part 169375 169423 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 169424 169473 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 169474 169523 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 169524 169573 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 169574 169623 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 169624 169673 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 170000 170040 68.2926829268 + . Parent=HM137666 +Merlin progressiveMauve match_part 170041 170082 76.1904761905 + . Parent=HM137666 +Merlin progressiveMauve match_part 170083 170132 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 170133 170182 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 170183 170232 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 170233 170282 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 170283 170332 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 170333 170382 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 170383 170431 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 170432 170473 52.380952381 + . Parent=HM137666 +Merlin progressiveMauve match_part 170474 170523 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 170524 170573 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 170574 170623 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 170824 170849 38.4615384615 + . Parent=HM137666 +Merlin progressiveMauve match_part 170850 170898 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 170899 170948 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 170949 170991 67.4418604651 + . Parent=HM137666 +Merlin progressiveMauve match_part 170992 171040 46.9387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 171041 171090 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 171091 171123 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 171124 171167 79.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 171168 171217 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 171218 171264 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 171265 171314 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 171315 171364 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 171365 171414 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 171415 171464 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 171465 171514 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 171515 171564 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 171565 171614 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 171615 171642 53.5714285714 + . Parent=HM137666 +Merlin progressiveMauve match 123963 171642 . - . Target=NC_000866;ID=NC_000866 +Merlin progressiveMauve match_part 123963 123982 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 123983 124032 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124033 124082 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124083 124132 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124133 124182 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124183 124232 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124233 124282 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124283 124329 42.5531914894 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124469 124494 73.0769230769 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124495 124544 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124601 124650 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124651 124700 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124701 124750 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124751 124796 56.5217391304 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124797 124846 14 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124847 124868 27.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124869 124918 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124919 124964 45.652173913 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124965 125009 55.5555555556 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125010 125059 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125060 125077 33.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125078 125127 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125128 125177 26 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125744 125793 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125794 125843 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125844 125893 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125894 125943 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125944 125993 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125994 126043 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126044 126093 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126094 126143 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126144 126193 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126194 126240 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126241 126290 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126291 126333 58.1395348837 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126334 126378 71.1111111111 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126379 126425 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126426 126468 67.4418604651 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126469 126515 74.4680851064 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126516 126565 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126566 126603 60.5263157895 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126604 126653 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126654 126703 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126704 126753 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126754 126803 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126804 126853 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126854 126903 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126904 126953 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126954 127003 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127004 127053 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127054 127103 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127104 127153 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127154 127203 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127204 127253 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127254 127296 74.4186046512 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127297 127346 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127347 127390 70.4545454545 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127391 127440 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127441 127484 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127485 127534 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127535 127584 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127585 127634 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127635 127684 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127685 127734 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127735 127784 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127785 127833 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127834 127883 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127884 127926 60.4651162791 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127927 127974 60.4166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127975 128024 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128025 128074 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128075 128124 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128125 128172 37.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128740 128750 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128751 128800 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128801 128850 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128851 128900 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128901 128950 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128951 129000 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129001 129050 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129051 129100 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129101 129150 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129151 129200 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129201 129250 22 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130448 130493 52.1739130435 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130494 130540 76.5957446809 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130541 130590 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130591 130640 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130641 130690 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130691 130740 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130741 130790 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130791 130840 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130841 130878 78.9473684211 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130879 130927 40.8163265306 + . Parent=NC_000866 +Merlin progressiveMauve match_part 131920 131966 82.9787234043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 131967 132013 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132014 132063 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132064 132113 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132114 132163 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132173 132190 94.4444444444 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132191 132239 67.3469387755 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132824 132839 100 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132840 132889 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132890 132939 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132940 132989 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132990 133039 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133040 133089 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133090 133139 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133140 133179 67.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133180 133229 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133230 133279 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133280 133329 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133330 133376 53.1914893617 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133377 133425 69.387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133426 133475 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133476 133525 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133526 133575 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133576 133625 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133626 133669 70.4545454545 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133670 133719 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133720 133769 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134020 134068 2.04081632653 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134069 134118 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134119 134168 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134169 134218 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134219 134268 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134269 134318 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134319 134359 87.8048780488 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134360 134391 62.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134392 134441 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134442 134491 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134492 134541 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134542 134591 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134592 134641 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134642 134689 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134690 134739 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134740 134785 52.1739130435 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134786 134835 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134927 134937 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134938 134986 59.1836734694 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134987 135036 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135037 135085 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135534 135558 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135559 135605 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135606 135655 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135656 135705 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135706 135743 39.4736842105 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135744 135793 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135794 135843 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135844 135893 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135894 135943 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135944 135993 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135994 136043 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136044 136087 61.3636363636 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136088 136137 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136138 136187 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136188 136237 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136238 136287 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136288 136325 68.4210526316 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136326 136375 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136376 136425 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136426 136469 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136470 136517 64.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136518 136564 59.5744680851 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136565 136614 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136615 136664 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136665 136714 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136715 136764 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136765 136814 12 + . Parent=NC_000866 +Merlin progressiveMauve match_part 137888 137937 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 137938 137987 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 137988 138037 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138038 138078 73.1707317073 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138079 138127 59.1836734694 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138128 138177 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138178 138227 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138228 138277 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138278 138318 65.8536585366 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138319 138368 34 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138525 138544 55 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138545 138594 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138595 138644 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138645 138694 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138695 138744 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138745 138790 69.5652173913 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138791 138840 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138841 138884 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138885 138934 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138935 138983 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138984 139027 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139028 139077 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139078 139127 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139128 139176 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139177 139226 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139227 139276 32 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139393 139442 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139443 139488 65.2173913043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139489 139538 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139539 139585 38.2978723404 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139586 139631 71.7391304348 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139632 139681 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139682 139731 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139732 139773 73.8095238095 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139774 139823 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139824 139873 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139874 139923 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139924 139973 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139974 140023 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140024 140073 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140074 140123 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140124 140173 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140174 140220 72.3404255319 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140221 140270 4 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140452 140472 76.1904761905 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140473 140522 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140523 140572 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140573 140622 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140623 140672 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140673 140722 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140723 140770 68.75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140771 140811 46.3414634146 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140812 140861 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140862 140910 67.3469387755 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140911 140960 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140961 141010 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141011 141060 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141061 141110 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141111 141160 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141161 141210 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141211 141260 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141261 141310 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141311 141360 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141361 141385 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141386 141411 84.6153846154 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141412 141461 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141462 141504 62.7906976744 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141505 141534 93.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141535 141584 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141585 141634 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141635 141684 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141685 141734 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141735 141784 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141785 141834 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141835 141884 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141885 141934 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141935 141984 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141985 142034 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142035 142084 2 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142143 142192 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142193 142242 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142243 142292 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142293 142342 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142343 142392 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142393 142442 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142443 142492 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142493 142542 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142543 142592 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142593 142642 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142643 142692 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142693 142742 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142743 142792 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142793 142842 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142843 142892 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142893 142942 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142943 142992 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142993 143042 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143043 143089 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143090 143139 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143140 143189 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143190 143239 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143240 143289 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143290 143339 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143340 143389 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143390 143439 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143440 143489 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143490 143539 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143540 143589 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143590 143639 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143640 143689 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143690 143739 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143740 143789 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143790 143839 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143840 143889 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143890 143939 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143940 143989 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143990 144039 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144040 144089 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144090 144139 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144140 144188 77.5510204082 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144189 144238 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144239 144288 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144289 144338 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144339 144379 63.4146341463 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144380 144429 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144430 144479 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144480 144529 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144530 144579 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144580 144629 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144630 144679 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144957 144974 88.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144975 145024 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145025 145074 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145075 145124 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145125 145173 73.4693877551 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145180 145202 82.6086956522 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145203 145252 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145253 145302 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145303 145352 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145353 145402 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145403 145452 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145453 145502 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145503 145552 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145553 145602 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145603 145652 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146375 146424 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146425 146474 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146475 146519 77.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146520 146569 14 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146757 146791 48.5714285714 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146792 146841 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146842 146891 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146892 146941 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146942 146991 6 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149433 149454 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149455 149504 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149505 149538 58.8235294118 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149539 149580 61.9047619048 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149581 149629 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149630 149674 57.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149675 149715 56.0975609756 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149716 149747 59.375 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149748 149794 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149795 149832 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149833 149882 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149883 149932 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149933 149980 75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149981 150030 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150031 150080 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150081 150130 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150131 150180 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150181 150230 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150231 150280 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150281 150330 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150331 150380 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150381 150430 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150431 150480 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150481 150530 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150531 150580 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150640 150672 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150673 150722 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150723 150772 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150773 150822 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150823 150872 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150873 150922 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150923 150972 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150973 151022 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151023 151072 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151073 151122 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151123 151172 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151173 151222 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151223 151272 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151273 151322 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151323 151372 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151373 151422 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151423 151472 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151473 151522 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151523 151572 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151573 151620 77.0833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151621 151670 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151671 151720 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151721 151770 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151771 151820 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151821 151863 69.7674418605 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151864 151913 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151914 151963 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151964 152013 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152014 152063 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152064 152112 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152113 152162 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152163 152212 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152213 152262 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152263 152312 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152313 152362 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152363 152412 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152413 152462 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152463 152512 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152513 152562 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152563 152610 62.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152611 152654 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152655 152704 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152705 152754 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152755 152804 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152805 152818 85.7142857143 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152819 152862 70.4545454545 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152863 152912 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152913 152962 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152963 153012 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153013 153062 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153063 153109 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153110 153159 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153160 153208 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153209 153256 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153257 153306 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153307 153353 53.1914893617 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153354 153403 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153404 153453 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153454 153503 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153504 153553 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153554 153603 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153604 153653 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153654 153703 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153704 153753 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153754 153803 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153804 153852 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153853 153897 77.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153898 153947 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153948 153997 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153998 154047 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154048 154097 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154098 154147 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154148 154197 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154198 154247 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154248 154297 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154298 154344 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154345 154394 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154395 154444 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154445 154494 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154495 154544 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154605 154639 51.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154640 154675 69.4444444444 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154676 154725 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154726 154769 77.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154770 154819 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154820 154869 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154870 154919 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154920 154966 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154967 155016 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155017 155066 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155067 155116 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155117 155166 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155167 155216 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155217 155266 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155267 155316 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155317 155363 55.3191489362 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155364 155413 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155464 155507 65.9090909091 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155508 155557 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155558 155607 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155608 155657 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155658 155707 20 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156017 156040 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156041 156087 53.1914893617 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156088 156137 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156138 156187 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156188 156218 6.45161290323 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156219 156268 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156269 156312 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156313 156359 68.085106383 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156360 156409 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156410 156459 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156460 156499 45 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156500 156549 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156550 156599 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156600 156641 54.7619047619 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156642 156690 71.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156691 156740 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157836 157872 59.4594594595 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157873 157922 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157923 157972 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157973 158022 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158023 158072 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158073 158117 48.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158118 158155 55.2631578947 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158156 158204 46.9387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158205 158254 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158255 158304 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158305 158348 56.8181818182 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158349 158393 57.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158394 158441 64.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158442 158491 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158492 158541 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158542 158591 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158592 158641 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158642 158691 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158692 158741 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 159334 159379 58.6956521739 + . Parent=NC_000866 +Merlin progressiveMauve match_part 159380 159429 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 159430 159479 38 + . Parent=NC_000866 +Merlin progressiveMauve match_part 161952 161995 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 161996 162045 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162046 162095 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162096 162145 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162146 162195 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162196 162245 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162246 162292 68.085106383 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162293 162342 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162343 162392 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162393 162438 73.9130434783 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162439 162488 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162489 162538 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162539 162588 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162589 162638 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162639 162686 83.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162687 162734 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162735 162783 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163000 163031 90.625 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163032 163081 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163735 163782 72.9166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163783 163832 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163833 163874 69.0476190476 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163875 163911 59.4594594595 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163912 163961 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163962 164011 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164012 164061 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164062 164111 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164112 164161 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164162 164211 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164212 164261 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164262 164311 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164312 164361 30 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164648 164676 72.4137931034 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164677 164726 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164727 164776 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164777 164826 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164827 164876 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164877 164926 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164927 164972 54.347826087 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164973 165021 30.612244898 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165280 165325 65.2173913043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165399 165444 60.8695652174 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165445 165494 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165495 165544 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165545 165594 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165595 165644 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165645 165694 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165695 165744 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165745 165794 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165795 165844 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165845 165894 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165895 165944 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165945 165994 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165995 166042 89.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 166043 166091 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 166092 166141 6 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167295 167333 64.1025641026 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167334 167383 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167384 167433 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167434 167483 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167484 167533 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167534 167580 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167581 167630 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167631 167678 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167679 167728 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167729 167776 56.25 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167777 167826 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167827 167876 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167877 167926 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167927 167976 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167977 168026 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168027 168074 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168075 168124 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168125 168174 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168175 168224 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168225 168274 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168275 168324 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168325 168374 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168375 168424 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168425 168474 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168475 168524 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168525 168574 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168575 168624 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168625 168674 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168675 168724 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169065 169092 60.7142857143 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169093 169142 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169143 169192 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169193 169242 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169243 169292 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169293 169342 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169343 169374 59.375 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169375 169423 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169424 169473 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169474 169523 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169524 169573 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169574 169623 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169624 169673 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170000 170040 68.2926829268 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170041 170082 76.1904761905 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170083 170132 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170133 170182 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170183 170232 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170233 170282 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170283 170332 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170333 170382 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170383 170431 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170432 170473 52.380952381 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170474 170523 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170524 170573 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170574 170623 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170824 170849 38.4615384615 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170850 170898 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170899 170948 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170949 170991 67.4418604651 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170992 171040 46.9387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171041 171090 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171091 171123 69.696969697 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171124 171167 79.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171168 171217 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171218 171264 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171265 171314 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171315 171364 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171365 171414 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171415 171464 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171465 171514 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171515 171564 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171565 171614 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171615 171642 53.5714285714 + . Parent=NC_000866 +### +Merlin progressiveMauve match 735 122810 . - . ID=HM137666;Target=HM137666 +Merlin progressiveMauve match_part 744 793 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 794 843 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 844 855 41.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 856 903 60.4166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 904 952 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 953 1000 52.0833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 1001 1044 52.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 1045 1094 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 1095 1136 52.380952381 + . Parent=HM137666 +Merlin progressiveMauve match_part 1137 1186 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 1187 1236 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 1237 1286 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 1287 1336 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 1337 1383 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 1384 1433 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 1482 1531 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 1532 1578 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 1579 1622 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 1623 1672 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 1673 1719 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 1720 1769 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 1770 1819 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 1820 1869 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 1870 1919 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 1920 1969 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 1970 2019 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 2020 2069 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 2070 2115 54.347826087 + . Parent=HM137666 +Merlin progressiveMauve match_part 2116 2162 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 2163 2212 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 2213 2262 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 2263 2312 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 2313 2362 4 + . Parent=HM137666 +Merlin progressiveMauve match_part 2855 2877 78.2608695652 + . Parent=HM137666 +Merlin progressiveMauve match_part 2878 2927 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 2928 2977 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 2978 3027 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 3028 3077 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 3078 3127 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 3128 3177 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 3178 3199 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 3200 3221 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 3222 3258 54.0540540541 + . Parent=HM137666 +Merlin progressiveMauve match_part 3259 3305 78.7234042553 + . Parent=HM137666 +Merlin progressiveMauve match_part 3306 3355 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 3356 3405 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 3406 3455 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 3456 3505 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 3506 3555 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 3556 3605 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 3606 3655 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 3656 3705 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 3706 3755 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 3756 3805 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 3806 3855 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 3856 3905 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 3906 3955 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 3956 4005 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 4006 4055 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 4056 4105 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 4106 4154 40.8163265306 + . Parent=HM137666 +Merlin progressiveMauve match_part 4155 4201 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 4202 4251 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 4252 4301 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 4302 4351 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 4352 4401 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 4402 4451 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 4452 4501 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 4502 4551 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 4552 4601 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 4602 4651 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 4652 4701 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 4702 4751 18 + . Parent=HM137666 +Merlin progressiveMauve match_part 5359 5395 70.2702702703 + . Parent=HM137666 +Merlin progressiveMauve match_part 5396 5445 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 5446 5495 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 5496 5545 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 6288 6302 73.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 6303 6346 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 6347 6396 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 6561 6596 63.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 6597 6633 64.8648648649 + . Parent=HM137666 +Merlin progressiveMauve match_part 6634 6677 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 6678 6727 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 6728 6777 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 6778 6827 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 6828 6877 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 6878 6918 58.5365853659 + . Parent=HM137666 +Merlin progressiveMauve match_part 6919 6968 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 6969 7018 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 7587 7630 86.3636363636 + . Parent=HM137666 +Merlin progressiveMauve match_part 7631 7680 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 7681 7730 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 7731 7780 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 7781 7830 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 7831 7880 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 7881 7930 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 7931 7980 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 7981 8030 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 8031 8080 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 8081 8130 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 8131 8180 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 8181 8230 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 8231 8280 10 + . Parent=HM137666 +Merlin progressiveMauve match_part 8426 8472 80.8510638298 + . Parent=HM137666 +Merlin progressiveMauve match_part 8473 8522 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 8523 8572 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 8573 8622 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 8623 8672 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 8673 8722 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 8723 8772 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 8773 8822 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 8823 8872 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 8873 8922 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 8923 8972 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 8973 9022 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 9023 9072 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 9073 9122 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 9123 9172 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 9173 9222 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 9223 9272 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 9273 9322 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 9323 9372 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 9373 9422 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 9423 9472 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 9473 9522 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 9523 9572 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 9573 9622 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 9623 9672 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 9673 9722 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 9723 9772 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 9937 9985 59.1836734694 + . Parent=HM137666 +Merlin progressiveMauve match_part 9986 10024 58.9743589744 + . Parent=HM137666 +Merlin progressiveMauve match_part 10025 10068 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 10069 10110 64.2857142857 + . Parent=HM137666 +Merlin progressiveMauve match_part 10111 10160 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 10161 10210 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 10211 10260 38 + . Parent=HM137666 +Merlin progressiveMauve match_part 10503 10537 51.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 10538 10587 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 10588 10637 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 10638 10687 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 10688 10737 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 10738 10787 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 10788 10837 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 10838 10887 2 + . Parent=HM137666 +Merlin progressiveMauve match_part 10996 11013 55.5555555556 + . Parent=HM137666 +Merlin progressiveMauve match_part 11014 11061 52.0833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 11062 11102 60.9756097561 + . Parent=HM137666 +Merlin progressiveMauve match_part 11103 11145 48.8372093023 + . Parent=HM137666 +Merlin progressiveMauve match_part 11146 11190 62.2222222222 + . Parent=HM137666 +Merlin progressiveMauve match_part 11191 11240 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 11241 11290 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 11291 11340 22 + . Parent=HM137666 +Merlin progressiveMauve match_part 11569 11613 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 11614 11651 71.0526315789 + . Parent=HM137666 +Merlin progressiveMauve match_part 11652 11698 36.170212766 + . Parent=HM137666 +Merlin progressiveMauve match_part 12474 12486 53.8461538462 + . Parent=HM137666 +Merlin progressiveMauve match_part 12487 12536 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 12537 12583 53.1914893617 + . Parent=HM137666 +Merlin progressiveMauve match_part 12584 12632 34.693877551 + . Parent=HM137666 +Merlin progressiveMauve match_part 12764 12777 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 12778 12823 76.0869565217 + . Parent=HM137666 +Merlin progressiveMauve match_part 12824 12873 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 12874 12914 65.8536585366 + . Parent=HM137666 +Merlin progressiveMauve match_part 12915 12957 65.1162790698 + . Parent=HM137666 +Merlin progressiveMauve match_part 12958 13007 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 13307 13327 80.9523809524 + . Parent=HM137666 +Merlin progressiveMauve match_part 13328 13377 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 13378 13427 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 13428 13477 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 13478 13527 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 13528 13577 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 13578 13627 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 13628 13672 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 13673 13709 81.0810810811 + . Parent=HM137666 +Merlin progressiveMauve match_part 13710 13759 2 + . Parent=HM137666 +Merlin progressiveMauve match_part 14253 14274 81.8181818182 + . Parent=HM137666 +Merlin progressiveMauve match_part 14275 14324 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 14325 14374 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 14375 14424 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 14425 14474 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 14475 14524 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 14525 14574 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 14575 14624 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 14625 14674 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 14675 14724 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 14725 14774 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 14775 14823 87.7551020408 + . Parent=HM137666 +Merlin progressiveMauve match_part 14824 14873 8 + . Parent=HM137666 +Merlin progressiveMauve match_part 15115 15164 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 15165 15211 59.5744680851 + . Parent=HM137666 +Merlin progressiveMauve match_part 15212 15255 65.9090909091 + . Parent=HM137666 +Merlin progressiveMauve match_part 15256 15301 54.347826087 + . Parent=HM137666 +Merlin progressiveMauve match_part 15302 15346 62.2222222222 + . Parent=HM137666 +Merlin progressiveMauve match_part 15347 15396 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 15397 15446 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 15447 15496 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 15497 15546 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 15547 15596 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 15597 15646 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 15647 15696 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 15697 15746 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 15747 15796 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 15797 15846 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 15847 15884 44.7368421053 + . Parent=HM137666 +Merlin progressiveMauve match_part 15885 15934 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 15935 15984 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 15985 16032 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 16033 16075 67.4418604651 + . Parent=HM137666 +Merlin progressiveMauve match_part 16076 16125 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 16126 16175 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 16176 16225 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 16226 16275 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 16276 16325 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 16326 16375 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 16418 16429 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 16430 16479 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 16480 16529 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 17150 17199 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 17200 17249 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 17250 17299 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 17607 17629 56.5217391304 + . Parent=HM137666 +Merlin progressiveMauve match_part 17630 17679 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 17680 17728 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 17729 17778 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 17779 17828 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 17829 17878 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 17879 17928 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 17929 17978 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 17979 18028 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 18029 18078 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 18079 18128 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 18129 18178 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 18179 18228 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 18229 18278 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 18279 18328 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 18329 18378 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 18379 18428 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 18429 18478 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 18479 18528 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 18529 18578 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 18579 18628 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 18629 18678 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 18679 18728 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 18729 18778 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 18779 18828 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 18829 18878 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 18879 18928 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 18929 18978 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 18979 19028 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 19029 19078 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 19079 19128 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 19129 19178 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 19179 19228 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 19229 19275 44.6808510638 + . Parent=HM137666 +Merlin progressiveMauve match_part 19276 19325 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 19326 19375 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 19376 19425 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 19426 19475 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 19476 19525 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 19526 19575 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 19576 19625 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 19626 19675 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 19676 19725 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 19726 19775 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 19776 19825 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 19826 19875 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 19876 19925 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 19926 19975 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 19976 20025 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 20026 20075 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 20076 20125 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 20126 20175 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 20176 20225 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 20226 20275 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 20276 20325 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 20326 20375 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 20376 20425 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 20426 20475 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 20476 20525 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 20526 20575 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 20576 20625 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 20626 20675 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 20767 20793 74.0740740741 + . Parent=HM137666 +Merlin progressiveMauve match_part 20794 20842 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 20843 20892 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 20893 20942 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 20943 20991 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 20992 21041 36 + . Parent=HM137666 +Merlin progressiveMauve match_part 21103 21152 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 21153 21202 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 21203 21252 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 21253 21301 55.1020408163 + . Parent=HM137666 +Merlin progressiveMauve match_part 21302 21345 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 21346 21395 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 21396 21445 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 21446 21492 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 21493 21540 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 21541 21590 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 21591 21640 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 21641 21690 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 21691 21740 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 21741 21790 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 21791 21840 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 21841 21890 8 + . Parent=HM137666 +Merlin progressiveMauve match_part 22676 22709 64.7058823529 + . Parent=HM137666 +Merlin progressiveMauve match_part 22710 22759 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 22760 22809 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 22810 22859 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 22860 22909 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 22910 22959 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 22960 23009 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 23010 23059 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 23060 23109 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 23110 23159 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 23160 23209 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 23210 23259 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 23260 23309 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 23310 23359 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 23360 23409 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 23413 23433 76.1904761905 + . Parent=HM137666 +Merlin progressiveMauve match_part 23434 23474 73.1707317073 + . Parent=HM137666 +Merlin progressiveMauve match_part 23475 23524 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 24430 24464 68.5714285714 + . Parent=HM137666 +Merlin progressiveMauve match_part 24465 24514 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 24515 24564 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 24565 24614 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 24615 24664 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 24665 24714 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 24715 24764 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 24765 24814 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 24815 24864 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 24865 24914 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 24915 24961 80.8510638298 + . Parent=HM137666 +Merlin progressiveMauve match_part 24962 25011 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 25012 25061 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 25062 25111 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 25112 25161 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 25162 25211 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 25212 25261 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 25262 25311 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 25312 25361 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 25362 25411 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 25412 25461 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 25462 25511 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 25512 25561 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 25562 25611 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 25612 25658 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 25659 25708 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 25709 25758 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 25759 25808 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 25809 25858 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 25859 25908 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 25909 25958 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 25959 26008 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 26009 26058 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 26059 26108 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 26109 26158 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 26159 26208 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 26209 26258 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 26259 26308 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 26309 26358 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 26359 26408 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 26409 26458 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 26459 26508 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 26509 26558 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 26559 26608 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 26609 26658 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 26659 26708 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 26709 26758 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 26759 26808 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 26809 26858 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 26859 26908 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 26909 26958 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 26959 27008 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 27009 27058 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 27059 27105 87.2340425532 + . Parent=HM137666 +Merlin progressiveMauve match_part 27106 27151 82.6086956522 + . Parent=HM137666 +Merlin progressiveMauve match_part 27152 27201 10 + . Parent=HM137666 +Merlin progressiveMauve match_part 27436 27462 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 27463 27512 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 27513 27562 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 27563 27612 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 27613 27662 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 27663 27712 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 27713 27762 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 27763 27812 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 27813 27862 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 27863 27912 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 27913 27962 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 27963 28012 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 28013 28062 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 28063 28112 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 28113 28162 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 28163 28212 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 28213 28262 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 28263 28312 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 28313 28362 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 28363 28409 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 28410 28459 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 28460 28508 67.3469387755 + . Parent=HM137666 +Merlin progressiveMauve match_part 28509 28558 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 28559 28608 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 28609 28658 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 28659 28708 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 28709 28758 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 28759 28808 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 28809 28858 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 28859 28908 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 28909 28958 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 28959 29008 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 29009 29058 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 29059 29108 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 29109 29158 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 29159 29208 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 29209 29258 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 29259 29308 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 29309 29357 79.5918367347 + . Parent=HM137666 +Merlin progressiveMauve match_part 29358 29406 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 29407 29456 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 29457 29506 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 29507 29556 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 29557 29606 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 29607 29656 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 29657 29706 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 29707 29756 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 29757 29806 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 29807 29856 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 29857 29906 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 29907 29956 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 29957 30006 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 30007 30056 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 30057 30106 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 30107 30148 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 30149 30198 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 30199 30244 63.0434782609 + . Parent=HM137666 +Merlin progressiveMauve match_part 30245 30292 60.4166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 30293 30340 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 30341 30383 55.8139534884 + . Parent=HM137666 +Merlin progressiveMauve match_part 30384 30433 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 30434 30474 73.1707317073 + . Parent=HM137666 +Merlin progressiveMauve match_part 30475 30523 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 30524 30573 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 30574 30623 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 30624 30673 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 30679 30701 86.9565217391 + . Parent=HM137666 +Merlin progressiveMauve match_part 30702 30751 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 30752 30801 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 30802 30851 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 30852 30901 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 30902 30951 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 30952 31001 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 31002 31051 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 31052 31101 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 31102 31151 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 31152 31201 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 31202 31251 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 31252 31301 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 31302 31351 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 31352 31401 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 31402 31449 64.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 31450 31499 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 31500 31549 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 31550 31599 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 31600 31649 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 31650 31699 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 31700 31749 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 31750 31799 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 31800 31849 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 31850 31899 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 31900 31949 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 31950 31999 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 32000 32049 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 32050 32099 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 32100 32149 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 32150 32199 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 32200 32249 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 32250 32299 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 32300 32349 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 32350 32399 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 32400 32449 4 + . Parent=HM137666 +Merlin progressiveMauve match_part 32540 32568 58.6206896552 + . Parent=HM137666 +Merlin progressiveMauve match_part 32569 32618 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 32619 32667 73.4693877551 + . Parent=HM137666 +Merlin progressiveMauve match_part 32668 32717 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 32718 32767 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 32768 32817 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 32818 32867 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 32868 32914 59.5744680851 + . Parent=HM137666 +Merlin progressiveMauve match_part 32915 32964 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 32965 33014 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 33015 33064 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 33065 33114 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 33115 33164 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 33165 33214 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 33215 33264 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 33265 33314 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 33315 33363 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 33364 33413 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 33414 33463 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 33464 33513 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 33514 33563 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 33564 33610 78.7234042553 + . Parent=HM137666 +Merlin progressiveMauve match_part 33611 33660 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 33661 33710 6 + . Parent=HM137666 +Merlin progressiveMauve match_part 34432 34477 54.347826087 + . Parent=HM137666 +Merlin progressiveMauve match_part 34478 34527 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 34528 34577 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 34578 34627 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 34628 34677 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 34678 34725 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 34726 34773 47.9166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 34774 34818 57.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 34903 34949 70.2127659574 + . Parent=HM137666 +Merlin progressiveMauve match_part 34950 34999 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 35000 35049 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 35050 35099 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 35100 35149 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 35150 35199 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 35200 35249 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 35250 35299 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 35300 35349 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 35350 35399 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 35400 35449 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 35450 35499 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 35500 35549 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 35550 35593 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 35594 35643 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 38668 38701 73.5294117647 + . Parent=HM137666 +Merlin progressiveMauve match_part 38702 38751 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 38752 38801 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 38802 38851 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 38852 38901 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 38902 38949 64.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 38950 38999 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 39000 39049 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 39050 39099 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 39100 39110 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 39111 39125 73.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 39126 39175 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 39176 39225 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 39226 39275 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 39276 39325 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 39326 39375 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 39376 39425 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 39426 39475 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 39476 39525 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 39526 39575 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 39576 39625 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 39626 39672 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 39673 39722 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 39723 39772 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 39773 39822 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 39823 39867 64.4444444444 + . Parent=HM137666 +Merlin progressiveMauve match_part 39868 39917 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 39918 39966 55.1020408163 + . Parent=HM137666 +Merlin progressiveMauve match_part 39967 40016 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 40017 40066 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 40067 40116 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 40117 40166 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 40167 40216 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 40217 40266 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 40267 40316 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 40317 40366 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 40367 40385 78.9473684211 + . Parent=HM137666 +Merlin progressiveMauve match_part 40386 40433 89.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 40434 40483 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 40484 40533 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 40534 40583 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 40584 40633 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 40634 40683 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 40684 40733 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 40734 40783 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 40784 40833 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 40834 40883 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 40884 40933 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 40934 40983 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 40984 41033 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 41034 41083 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 41084 41133 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 41134 41183 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 41184 41233 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 41234 41283 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 41284 41333 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 41334 41383 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 41384 41430 70.2127659574 + . Parent=HM137666 +Merlin progressiveMauve match_part 41431 41480 10 + . Parent=HM137666 +Merlin progressiveMauve match_part 41612 41627 62.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 41628 41677 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 41678 41727 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 41728 41773 52.1739130435 + . Parent=HM137666 +Merlin progressiveMauve match_part 41774 41823 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 41824 41867 38.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 41900 41942 62.7906976744 + . Parent=HM137666 +Merlin progressiveMauve match_part 41943 41992 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 41993 42042 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 42043 42086 81.8181818182 + . Parent=HM137666 +Merlin progressiveMauve match_part 42087 42133 80.8510638298 + . Parent=HM137666 +Merlin progressiveMauve match_part 42134 42183 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 42184 42233 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 42234 42283 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 42284 42331 70.8333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 42332 42381 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 42382 42431 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 42432 42481 10 + . Parent=HM137666 +Merlin progressiveMauve match_part 42611 42651 68.2926829268 + . Parent=HM137666 +Merlin progressiveMauve match_part 42652 42701 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 42702 42751 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 42752 42801 2 + . Parent=HM137666 +Merlin progressiveMauve match_part 43122 43135 85.7142857143 + . Parent=HM137666 +Merlin progressiveMauve match_part 43136 43185 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 43186 43235 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 43236 43285 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 43286 43335 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 48867 48914 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 48915 48964 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 48965 49014 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 49015 49064 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 49065 49114 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 49115 49164 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 49165 49214 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 49215 49264 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 49265 49314 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 49315 49364 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 49365 49414 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 49415 49464 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 49465 49514 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 49515 49564 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 49565 49614 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 49615 49661 80.8510638298 + . Parent=HM137666 +Merlin progressiveMauve match_part 49662 49711 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 49712 49760 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 49761 49810 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 49811 49860 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 50413 50425 84.6153846154 + . Parent=HM137666 +Merlin progressiveMauve match_part 50426 50475 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 50476 50525 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 50526 50575 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 50576 50625 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 50626 50675 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 50676 50725 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 50726 50775 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 50776 50825 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 50826 50875 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 50876 50925 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 50926 50972 51.0638297872 + . Parent=HM137666 +Merlin progressiveMauve match_part 50973 51022 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 51023 51072 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 51073 51122 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 51123 51172 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 51173 51222 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 51223 51272 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 51273 51322 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 51323 51372 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 51373 51422 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 51423 51472 8 + . Parent=HM137666 +Merlin progressiveMauve match_part 53804 53816 84.6153846154 + . Parent=HM137666 +Merlin progressiveMauve match_part 53817 53862 52.1739130435 + . Parent=HM137666 +Merlin progressiveMauve match_part 53863 53912 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 53913 53962 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 53963 54012 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 54013 54057 68.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 54058 54107 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 54108 54157 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 54158 54207 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 54208 54254 61.7021276596 + . Parent=HM137666 +Merlin progressiveMauve match_part 54255 54289 51.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 54290 54339 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 54340 54389 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 54390 54431 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 54432 54478 59.5744680851 + . Parent=HM137666 +Merlin progressiveMauve match_part 54479 54528 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 54529 54574 82.6086956522 + . Parent=HM137666 +Merlin progressiveMauve match_part 54575 54624 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 54625 54674 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 54675 54724 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 54725 54774 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 54775 54823 32.6530612245 + . Parent=HM137666 +Merlin progressiveMauve match_part 55720 55739 85 + . Parent=HM137666 +Merlin progressiveMauve match_part 55740 55789 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 55790 55838 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 55839 55888 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 55889 55938 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 55939 55988 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 55989 56038 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 56039 56088 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 56089 56138 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 56139 56188 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 56189 56238 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 56239 56288 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 57247 57258 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 57259 57308 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 57309 57358 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 57359 57408 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 57409 57451 67.4418604651 + . Parent=HM137666 +Merlin progressiveMauve match_part 57452 57501 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 57502 57544 67.4418604651 + . Parent=HM137666 +Merlin progressiveMauve match_part 57545 57594 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 57595 57644 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 57645 57685 53.6585365854 + . Parent=HM137666 +Merlin progressiveMauve match_part 57686 57735 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 57736 57782 70.2127659574 + . Parent=HM137666 +Merlin progressiveMauve match_part 57783 57832 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 57833 57882 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 58525 58548 79.1666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 58549 58595 42.5531914894 + . Parent=HM137666 +Merlin progressiveMauve match_part 58596 58645 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 58646 58695 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 58696 58745 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 58746 58795 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 58796 58845 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 58846 58895 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 58896 58939 65.9090909091 + . Parent=HM137666 +Merlin progressiveMauve match_part 58940 58989 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 58990 59039 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 59040 59089 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 59090 59139 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 59140 59186 61.7021276596 + . Parent=HM137666 +Merlin progressiveMauve match_part 59187 59236 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 59237 59263 51.8518518519 + . Parent=HM137666 +Merlin progressiveMauve match_part 59264 59313 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 59314 59363 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 59364 59413 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 59414 59463 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 59464 59513 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 59514 59563 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 59564 59610 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 59611 59659 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 59660 59706 8.51063829787 + . Parent=HM137666 +Merlin progressiveMauve match_part 59707 59749 65.1162790698 + . Parent=HM137666 +Merlin progressiveMauve match_part 59750 59797 39.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 59798 59846 53.0612244898 + . Parent=HM137666 +Merlin progressiveMauve match_part 59847 59896 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 59897 59943 42.5531914894 + . Parent=HM137666 +Merlin progressiveMauve match_part 59944 59988 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 59989 60038 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 60039 60088 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 60089 60138 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 60189 60234 58.6956521739 + . Parent=HM137666 +Merlin progressiveMauve match_part 60235 60284 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 60329 60350 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 60351 60400 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 60401 60450 34 + . Parent=HM137666 +Merlin progressiveMauve match_part 60503 60529 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 60530 60579 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 60651 60688 71.0526315789 + . Parent=HM137666 +Merlin progressiveMauve match_part 60689 60733 48.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 60734 60773 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 60774 60823 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 60824 60873 28 + . Parent=HM137666 +Merlin progressiveMauve match_part 60929 60953 36 + . Parent=HM137666 +Merlin progressiveMauve match_part 60954 61003 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 61004 61053 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 61054 61097 52.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 61098 61147 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 61148 61195 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 61196 61234 76.9230769231 + . Parent=HM137666 +Merlin progressiveMauve match_part 61235 61280 4.34782608696 + . Parent=HM137666 +Merlin progressiveMauve match_part 61281 61328 77.0833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 61329 61378 38 + . Parent=HM137666 +Merlin progressiveMauve match_part 61379 61428 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 61429 61478 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 61479 61525 55.3191489362 + . Parent=HM137666 +Merlin progressiveMauve match_part 61526 61575 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 61576 61625 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 61626 61667 54.7619047619 + . Parent=HM137666 +Merlin progressiveMauve match_part 61668 61716 73.4693877551 + . Parent=HM137666 +Merlin progressiveMauve match_part 61717 61766 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 61767 61812 76.0869565217 + . Parent=HM137666 +Merlin progressiveMauve match_part 61813 61862 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 61863 61912 18 + . Parent=HM137666 +Merlin progressiveMauve match_part 62173 62207 77.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 62208 62257 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 62258 62307 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 62308 62357 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 62358 62407 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 62408 62457 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 62458 62507 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 62508 62557 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 62558 62607 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 62608 62657 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 62658 62706 73.4693877551 + . Parent=HM137666 +Merlin progressiveMauve match_part 62707 62756 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 62757 62806 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 62807 62856 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 62857 62906 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 62907 62956 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 62957 63006 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 63007 63049 69.7674418605 + . Parent=HM137666 +Merlin progressiveMauve match_part 63050 63094 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 63095 63144 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 63145 63194 2 + . Parent=HM137666 +Merlin progressiveMauve match_part 68346 68375 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 68376 68425 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 68426 68475 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 68476 68525 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 68526 68575 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 68576 68625 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 68626 68675 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 68676 68725 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 68726 68775 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 68776 68825 2 + . Parent=HM137666 +Merlin progressiveMauve match_part 73949 73965 76.4705882353 + . Parent=HM137666 +Merlin progressiveMauve match_part 73966 74009 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 74010 74058 46.9387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 74953 74993 65.8536585366 + . Parent=HM137666 +Merlin progressiveMauve match_part 74994 75033 55 + . Parent=HM137666 +Merlin progressiveMauve match_part 75034 75082 40.8163265306 + . Parent=HM137666 +Merlin progressiveMauve match_part 75083 75132 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 75133 75176 79.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 75177 75218 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 75219 75265 21.2765957447 + . Parent=HM137666 +Merlin progressiveMauve match_part 75371 75409 71.7948717949 + . Parent=HM137666 +Merlin progressiveMauve match_part 75410 75459 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 75604 75627 75 + . Parent=HM137666 +Merlin progressiveMauve match_part 75628 75677 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 75678 75727 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 75728 75777 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 75778 75827 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 75828 75877 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 75878 75927 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 75928 75977 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 75978 76027 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 76028 76071 68.1818181818 + . Parent=HM137666 +Merlin progressiveMauve match_part 76072 76117 56.5217391304 + . Parent=HM137666 +Merlin progressiveMauve match_part 76118 76167 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 76168 76206 58.9743589744 + . Parent=HM137666 +Merlin progressiveMauve match_part 76207 76256 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 76257 76292 72.2222222222 + . Parent=HM137666 +Merlin progressiveMauve match_part 76293 76337 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 76338 76387 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 76388 76437 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 76438 76487 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 76488 76537 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 76538 76587 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 76588 76637 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 76638 76686 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 76687 76728 61.9047619048 + . Parent=HM137666 +Merlin progressiveMauve match_part 76729 76778 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 76779 76828 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 76829 76874 58.6956521739 + . Parent=HM137666 +Merlin progressiveMauve match_part 76875 76924 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 76925 76974 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 76975 77024 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 77025 77074 36 + . Parent=HM137666 +Merlin progressiveMauve match_part 77075 77124 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 77125 77174 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 77175 77224 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 77225 77274 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 77275 77324 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 77325 77374 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 77375 77424 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 77425 77473 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 77474 77523 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 77524 77573 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 77574 77605 81.25 + . Parent=HM137666 +Merlin progressiveMauve match_part 77606 77650 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 77651 77689 79.4871794872 + . Parent=HM137666 +Merlin progressiveMauve match_part 77690 77736 80.8510638298 + . Parent=HM137666 +Merlin progressiveMauve match_part 77737 77786 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 77787 77836 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 77837 77886 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 77887 77936 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 77937 77986 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 77987 78036 14 + . Parent=HM137666 +Merlin progressiveMauve match_part 78451 78494 70.4545454545 + . Parent=HM137666 +Merlin progressiveMauve match_part 78495 78542 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 78543 78591 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 78592 78641 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 78642 78691 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 78692 78741 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 78742 78791 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 78792 78841 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 78842 78891 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 78892 78941 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 78942 78989 68.75 + . Parent=HM137666 +Merlin progressiveMauve match_part 78990 79039 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 79040 79089 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 79090 79139 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 79140 79189 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 79190 79239 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 79240 79289 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 79290 79339 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 79340 79389 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 79390 79439 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 79440 79489 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 79490 79539 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 79540 79589 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 79590 79639 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 79640 79689 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 79690 79739 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 79740 79789 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 79790 79839 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 79840 79889 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 79890 79933 65.9090909091 + . Parent=HM137666 +Merlin progressiveMauve match_part 79934 79983 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 79984 80033 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 80034 80083 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 80084 80130 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 80131 80180 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 80181 80230 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 80231 80280 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 80281 80330 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 80331 80380 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 80381 80420 15 + . Parent=HM137666 +Merlin progressiveMauve match_part 80421 80448 78.5714285714 + . Parent=HM137666 +Merlin progressiveMauve match_part 80449 80498 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 80499 80548 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 80549 80598 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 80599 80648 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 80649 80695 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 80696 80745 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 80746 80795 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 80796 80845 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 80846 80895 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 80896 80945 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 80946 80995 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 80996 81045 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 81046 81095 34 + . Parent=HM137666 +Merlin progressiveMauve match_part 81227 81237 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 81238 81287 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 81288 81337 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 81338 81386 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 81387 81436 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 81437 81486 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 81487 81530 65.9090909091 + . Parent=HM137666 +Merlin progressiveMauve match_part 81531 81580 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 81581 81630 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 81631 81680 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 81681 81730 36 + . Parent=HM137666 +Merlin progressiveMauve match_part 81835 81862 67.8571428571 + . Parent=HM137666 +Merlin progressiveMauve match_part 81863 81912 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 81913 81962 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 81963 82012 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 82013 82062 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 82063 82112 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 82113 82150 78.9473684211 + . Parent=HM137666 +Merlin progressiveMauve match_part 82151 82200 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 82201 82250 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 82251 82300 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 82301 82350 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 82351 82400 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 82401 82450 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 82451 82500 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 82501 82550 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 82551 82600 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 82601 82650 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 82651 82700 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 82701 82750 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 82751 82800 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 82801 82850 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 82851 82900 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 82901 82950 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 82951 83000 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 83001 83050 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 83051 83100 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 83101 83150 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 83151 83200 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 83201 83250 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 83251 83300 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 83301 83350 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 83351 83400 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 83401 83450 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 83451 83500 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 83501 83550 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 83551 83600 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 83601 83650 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 83651 83678 60.7142857143 + . Parent=HM137666 +Merlin progressiveMauve match_part 83679 83713 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 83714 83763 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 83764 83813 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 83814 83855 54.7619047619 + . Parent=HM137666 +Merlin progressiveMauve match_part 83856 83905 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 83906 83955 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 83956 84005 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 84006 84055 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 84056 84105 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 84106 84155 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 84156 84205 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 84206 84253 60.4166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 84254 84300 51.0638297872 + . Parent=HM137666 +Merlin progressiveMauve match_part 84301 84350 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 84351 84400 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 84401 84450 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 84451 84500 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 84501 84550 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 84551 84600 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 84601 84649 71.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 84650 84699 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 84700 84749 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 84750 84799 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 84800 84849 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 84850 84899 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 84900 84949 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 84950 84999 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 85000 85049 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 85050 85099 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 85100 85149 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 85150 85199 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 85200 85248 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 85249 85290 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 85291 85340 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 85341 85390 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 85391 85440 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 85441 85490 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 85491 85540 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 85541 85590 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 85591 85640 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 85641 85690 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 85691 85736 63.0434782609 + . Parent=HM137666 +Merlin progressiveMauve match_part 85737 85786 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 85787 85836 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 85837 85886 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 85887 85936 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 85937 85965 20.6896551724 + . Parent=HM137666 +Merlin progressiveMauve match_part 85966 86015 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 86016 86065 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 86066 86115 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 86116 86165 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 86166 86215 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 86216 86265 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 86266 86315 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 86316 86365 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 86366 86415 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 86416 86465 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 86466 86515 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 86516 86565 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 86566 86615 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 86616 86665 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 86666 86715 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 86716 86765 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 86766 86815 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 86816 86865 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 86866 86915 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 86916 86965 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 86966 87015 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 87016 87065 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 87066 87115 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 87116 87165 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 87166 87215 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 87216 87265 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 87266 87315 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 87316 87365 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 87366 87415 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 87416 87465 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 87466 87515 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 87516 87565 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 87566 87615 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 87616 87662 68.085106383 + . Parent=HM137666 +Merlin progressiveMauve match_part 87663 87710 64.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 87711 87760 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 87761 87810 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 87811 87860 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 87861 87910 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 87911 87960 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 87961 88010 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 88011 88060 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 88061 88110 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 88111 88160 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 88161 88205 73.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 88206 88255 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 88256 88305 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 88306 88355 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 88356 88405 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 88406 88455 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 88456 88505 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 88506 88555 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 88556 88605 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 88606 88645 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 88646 88695 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 88696 88745 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 88746 88795 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 88796 88845 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 88846 88895 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 88896 88945 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 88946 88995 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 88996 89044 46.9387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 89045 89086 61.9047619048 + . Parent=HM137666 +Merlin progressiveMauve match_part 89087 89133 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 89134 89183 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 89184 89233 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 89234 89281 75 + . Parent=HM137666 +Merlin progressiveMauve match_part 89282 89331 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 89332 89381 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 89382 89431 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 89432 89476 64.4444444444 + . Parent=HM137666 +Merlin progressiveMauve match_part 89477 89526 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 89527 89576 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 89577 89621 68.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 89622 89671 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 89672 89721 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 89722 89768 72.3404255319 + . Parent=HM137666 +Merlin progressiveMauve match_part 89769 89818 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 89819 89868 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 89869 89918 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 89919 89964 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 89965 90011 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 90012 90061 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 90062 90111 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 90112 90152 70.7317073171 + . Parent=HM137666 +Merlin progressiveMauve match_part 90153 90201 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 90202 90247 76.0869565217 + . Parent=HM137666 +Merlin progressiveMauve match_part 90248 90296 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 90297 90346 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 90347 90396 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 90397 90440 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 90441 90488 83.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 90489 90538 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 90539 90588 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 90589 90638 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 90639 90688 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 90689 90738 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 90739 90788 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 90789 90838 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 90839 90888 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 90889 90938 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 90939 90984 67.3913043478 + . Parent=HM137666 +Merlin progressiveMauve match_part 90985 91029 62.2222222222 + . Parent=HM137666 +Merlin progressiveMauve match_part 91030 91079 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 91080 91120 53.6585365854 + . Parent=HM137666 +Merlin progressiveMauve match_part 91121 91170 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 91171 91209 43.5897435897 + . Parent=HM137666 +Merlin progressiveMauve match_part 91210 91255 65.2173913043 + . Parent=HM137666 +Merlin progressiveMauve match_part 91256 91299 52.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 91300 91347 56.25 + . Parent=HM137666 +Merlin progressiveMauve match_part 91348 91394 78.7234042553 + . Parent=HM137666 +Merlin progressiveMauve match_part 91395 91435 60.9756097561 + . Parent=HM137666 +Merlin progressiveMauve match_part 91436 91484 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 91485 91533 59.1836734694 + . Parent=HM137666 +Merlin progressiveMauve match_part 91534 91583 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 91584 91633 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 91634 91683 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 91843 91855 76.9230769231 + . Parent=HM137666 +Merlin progressiveMauve match_part 91856 91905 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 91906 91952 44.6808510638 + . Parent=HM137666 +Merlin progressiveMauve match_part 91953 92002 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 92003 92052 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 92053 92099 34.0425531915 + . Parent=HM137666 +Merlin progressiveMauve match_part 92100 92149 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 92150 92199 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 92200 92249 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 92250 92299 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 92300 92334 65.7142857143 + . Parent=HM137666 +Merlin progressiveMauve match_part 92335 92378 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 92379 92428 26 + . Parent=HM137666 +Merlin progressiveMauve match_part 92475 92496 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 92497 92546 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 92547 92593 46.8085106383 + . Parent=HM137666 +Merlin progressiveMauve match_part 92594 92643 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 92644 92693 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 92694 92743 6 + . Parent=HM137666 +Merlin progressiveMauve match_part 92859 92894 44.4444444444 + . Parent=HM137666 +Merlin progressiveMauve match_part 92895 92944 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 92945 92994 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 92995 93044 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 93045 93094 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 93095 93144 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 93145 93185 58.5365853659 + . Parent=HM137666 +Merlin progressiveMauve match_part 93186 93235 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 93236 93279 68.1818181818 + . Parent=HM137666 +Merlin progressiveMauve match_part 93280 93323 38.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 93324 93373 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 93374 93422 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 93423 93472 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 93473 93522 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 93523 93567 53.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 93568 93617 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 93618 93667 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 93905 93916 83.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 93917 93966 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 93967 94016 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 94017 94066 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 94067 94105 58.9743589744 + . Parent=HM137666 +Merlin progressiveMauve match_part 94106 94155 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 94156 94205 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 94206 94255 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 94302 94351 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 94352 94395 56.8181818182 + . Parent=HM137666 +Merlin progressiveMauve match_part 94396 94445 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 94446 94495 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 94496 94545 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 94546 94595 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 94596 94645 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 94646 94695 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 94696 94745 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 94746 94795 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 94796 94845 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 94846 94895 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 94896 94945 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 94946 94995 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 94996 95045 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 95046 95095 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 95096 95145 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 95146 95195 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 95196 95245 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 95246 95295 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 95296 95345 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 95346 95384 64.1025641026 + . Parent=HM137666 +Merlin progressiveMauve match_part 95385 95434 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 95435 95484 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 95485 95534 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 95535 95584 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 95585 95634 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 95635 95684 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 95685 95734 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 95735 95784 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 95785 95834 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 95835 95884 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 95885 95934 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 95935 95984 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 95985 96034 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 96035 96084 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 96085 96131 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 96132 96178 76.5957446809 + . Parent=HM137666 +Merlin progressiveMauve match_part 96179 96228 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 96229 96270 38.0952380952 + . Parent=HM137666 +Merlin progressiveMauve match_part 96271 96320 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 96321 96370 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 96371 96420 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 96421 96470 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 96471 96520 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 96521 96570 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 96571 96620 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 96621 96670 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 96671 96720 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 96721 96770 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 96771 96820 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 96821 96867 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 96868 96917 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 96918 96967 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 96968 97011 68.1818181818 + . Parent=HM137666 +Merlin progressiveMauve match_part 97012 97061 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 97062 97111 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 97112 97161 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 97162 97211 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 97212 97261 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 97262 97311 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 97312 97355 65.9090909091 + . Parent=HM137666 +Merlin progressiveMauve match_part 97356 97405 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 97406 97455 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 97456 97505 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 97506 97555 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 97556 97605 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 97606 97653 75 + . Parent=HM137666 +Merlin progressiveMauve match_part 97654 97703 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 97704 97753 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 97754 97803 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 97804 97853 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 97854 97903 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 97904 97953 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 97954 98003 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 98004 98053 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 98054 98103 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 98104 98153 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 98154 98203 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 98204 98253 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 98254 98303 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 98304 98353 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 98354 98403 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 98404 98453 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 98454 98503 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 98504 98553 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 98554 98603 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 98604 98653 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 98654 98703 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 98704 98753 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 98754 98803 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 98804 98853 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 98854 98903 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 98904 98953 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 98954 99003 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 99004 99053 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 99054 99103 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 99104 99153 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 99154 99203 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 99204 99253 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 99254 99303 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 99304 99353 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 99354 99403 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 99404 99453 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 99454 99503 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 99504 99553 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 99554 99603 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 99604 99653 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 99654 99703 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 99704 99753 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 99754 99802 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 99803 99852 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 99853 99902 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 99903 99952 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 99953 100002 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 100003 100052 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 100053 100102 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 100103 100152 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 100153 100202 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 100203 100252 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 100253 100299 74.4680851064 + . Parent=HM137666 +Merlin progressiveMauve match_part 100300 100349 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 100350 100399 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 100400 100449 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 100450 100499 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 100500 100549 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 100550 100599 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 100600 100649 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 100650 100699 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 100700 100749 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 100750 100799 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 100800 100849 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 100850 100899 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 100900 100949 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 100950 100999 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 101000 101049 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 101050 101099 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 101100 101149 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 101150 101199 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 101200 101249 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 101250 101299 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 101300 101349 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 101350 101399 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 101400 101449 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 101450 101499 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 101500 101549 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 101550 101599 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 101600 101649 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 101650 101699 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 101700 101749 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 101750 101799 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 101800 101849 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 101850 101899 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 101900 101945 65.2173913043 + . Parent=HM137666 +Merlin progressiveMauve match_part 101946 101981 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 101982 102031 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 102032 102081 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 102082 102131 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 102132 102172 68.2926829268 + . Parent=HM137666 +Merlin progressiveMauve match_part 102173 102222 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 102223 102272 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 102273 102322 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 102323 102372 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 102373 102422 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 102423 102472 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 102473 102522 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 102523 102572 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 102573 102622 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 102623 102672 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 102673 102722 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 102723 102772 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 102773 102822 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 102823 102872 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 102873 102922 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 102923 102972 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 102973 103022 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 103023 103072 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 103073 103122 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 103123 103172 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 103173 103222 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 103223 103272 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 103273 103322 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 103323 103372 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 103373 103422 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 103423 103472 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 103473 103522 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 103523 103569 78.7234042553 + . Parent=HM137666 +Merlin progressiveMauve match_part 103570 103619 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 103620 103669 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 103670 103717 68.75 + . Parent=HM137666 +Merlin progressiveMauve match_part 103718 103744 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 103745 103780 91.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 103781 103830 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 103831 103880 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 103881 103930 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 103931 103980 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 103981 104030 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 104031 104080 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 104081 104130 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 104131 104180 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 104181 104230 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 104231 104280 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 104281 104330 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 104331 104380 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 104381 104430 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 104431 104480 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 104481 104530 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 104531 104580 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 104581 104630 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 104631 104680 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 104681 104730 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 104731 104780 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 104781 104827 70.2127659574 + . Parent=HM137666 +Merlin progressiveMauve match_part 104828 104877 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 104878 104927 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 104928 104977 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 104978 105027 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 105028 105077 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 105078 105127 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 105128 105177 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 105178 105227 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 105228 105277 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 105278 105327 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 105328 105377 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 105378 105427 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 105428 105477 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 105478 105527 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 105528 105574 68.085106383 + . Parent=HM137666 +Merlin progressiveMauve match_part 105575 105618 77.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 105619 105668 32 + . Parent=HM137666 +Merlin progressiveMauve match_part 105669 105715 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 105716 105762 61.7021276596 + . Parent=HM137666 +Merlin progressiveMauve match_part 105763 105811 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 105812 105861 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 105862 105911 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 105912 105961 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 105962 106011 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 106012 106061 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 106062 106111 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 106112 106161 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 106162 106211 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 106212 106261 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 106262 106311 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 106312 106361 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 106362 106411 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 106412 106461 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 106462 106511 96 + . Parent=HM137666 +Merlin progressiveMauve match_part 106512 106561 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 106562 106611 94 + . Parent=HM137666 +Merlin progressiveMauve match_part 106612 106661 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 106662 106711 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 106712 106761 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 106762 106811 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 106812 106861 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 106862 106911 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 106912 106961 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 106962 107011 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 107012 107061 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 107062 107111 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 107112 107158 87.2340425532 + . Parent=HM137666 +Merlin progressiveMauve match_part 107159 107205 59.5744680851 + . Parent=HM137666 +Merlin progressiveMauve match_part 107206 107253 70.8333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 107254 107303 22 + . Parent=HM137666 +Merlin progressiveMauve match_part 107310 107326 82.3529411765 + . Parent=HM137666 +Merlin progressiveMauve match_part 107327 107376 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 107377 107426 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 107427 107476 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 107477 107526 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 107527 107576 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 107577 107626 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 107627 107676 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 107677 107726 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 107727 107776 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 107777 107826 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 107827 107876 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 107877 107926 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 107927 107976 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 107977 108026 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 108027 108076 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 108077 108126 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 108127 108176 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 108177 108226 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 108227 108276 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 108277 108326 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 108327 108376 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 108377 108426 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 108427 108476 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 108477 108526 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 108527 108576 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 108577 108626 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 108627 108676 32 + . Parent=HM137666 +Merlin progressiveMauve match_part 109177 109213 21.6216216216 + . Parent=HM137666 +Merlin progressiveMauve match_part 109214 109263 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 109264 109313 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 109314 109363 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 109364 109413 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 109414 109463 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 109464 109513 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 109514 109563 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 109564 109607 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 109608 109657 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 109658 109704 59.5744680851 + . Parent=HM137666 +Merlin progressiveMauve match_part 109705 109754 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 109755 109804 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 109805 109854 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 109855 109904 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 109905 109954 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 109955 110004 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 110005 110054 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 110055 110098 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 110099 110148 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 110149 110198 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 110199 110248 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 110249 110298 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 110299 110348 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 111266 111315 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 111316 111365 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 111366 111414 69.387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 111415 111464 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 111465 111514 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 111515 111558 61.3636363636 + . Parent=HM137666 +Merlin progressiveMauve match_part 111559 111606 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 111607 111656 20 + . Parent=HM137666 +Merlin progressiveMauve match_part 111914 111963 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 111964 112013 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 112014 112063 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 112064 112106 11.6279069767 + . Parent=HM137666 +Merlin progressiveMauve match_part 112107 112154 70.8333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 112155 112204 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 112205 112254 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 112255 112304 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 112305 112351 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 112352 112395 56.8181818182 + . Parent=HM137666 +Merlin progressiveMauve match_part 112396 112442 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 112443 112483 68.2926829268 + . Parent=HM137666 +Merlin progressiveMauve match_part 112484 112527 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 112528 112557 63.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 112558 112606 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 112607 112656 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 112657 112703 72.3404255319 + . Parent=HM137666 +Merlin progressiveMauve match_part 112704 112753 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 112754 112784 6.45161290323 + . Parent=HM137666 +Merlin progressiveMauve match_part 112785 112807 69.5652173913 + . Parent=HM137666 +Merlin progressiveMauve match_part 112808 112857 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 112858 112907 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 112908 112957 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 112958 113007 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 113008 113057 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 113058 113107 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 113108 113157 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 113158 113207 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 113208 113257 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 113258 113307 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 113308 113346 71.7948717949 + . Parent=HM137666 +Merlin progressiveMauve match_part 113347 113395 38.7755102041 + . Parent=HM137666 +Merlin progressiveMauve match_part 113396 113445 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 113446 113495 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 113496 113545 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 113546 113595 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 113596 113645 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 113646 113695 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 113696 113745 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 113746 113795 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 113796 113845 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 113846 113895 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 113896 113945 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 113946 113995 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 113996 114045 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 114046 114095 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 114096 114145 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 114146 114195 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 114196 114245 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 114246 114295 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 114296 114309 28.5714285714 + . Parent=HM137666 +Merlin progressiveMauve match_part 114310 114359 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 114360 114409 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 114410 114459 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 114460 114506 74.4680851064 + . Parent=HM137666 +Merlin progressiveMauve match_part 114507 114556 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 114557 114606 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 114607 114656 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 114657 114706 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 114707 114753 74.4680851064 + . Parent=HM137666 +Merlin progressiveMauve match_part 114754 114791 84.2105263158 + . Parent=HM137666 +Merlin progressiveMauve match_part 114792 114834 74.4186046512 + . Parent=HM137666 +Merlin progressiveMauve match_part 114835 114884 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 114885 114934 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 114935 114984 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 114985 115034 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 115035 115083 67.3469387755 + . Parent=HM137666 +Merlin progressiveMauve match_part 115084 115133 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 115134 115183 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 115184 115233 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 115234 115275 71.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 115276 115321 65.2173913043 + . Parent=HM137666 +Merlin progressiveMauve match_part 115322 115371 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 115372 115421 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 115422 115471 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 115472 115521 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 115522 115571 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 115572 115621 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 115622 115671 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 115672 115721 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 115722 115771 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 115772 115821 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 115822 115871 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 115872 115921 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 115922 115971 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 115972 116021 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 116022 116071 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 116072 116121 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 116122 116171 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 116172 116221 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 116222 116271 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 116272 116320 67.3469387755 + . Parent=HM137666 +Merlin progressiveMauve match_part 116321 116368 79.1666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 116369 116418 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 116419 116468 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 116469 116518 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 116519 116568 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 116569 116618 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 116619 116668 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 116669 116718 36 + . Parent=HM137666 +Merlin progressiveMauve match_part 116862 116909 54.1666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 116910 116956 61.7021276596 + . Parent=HM137666 +Merlin progressiveMauve match_part 116957 117006 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 117007 117056 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 117057 117105 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 117106 117153 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 117154 117203 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 117204 117253 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 117254 117303 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 117304 117352 75.5102040816 + . Parent=HM137666 +Merlin progressiveMauve match_part 117353 117400 72.9166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 117401 117450 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 117451 117500 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 117501 117548 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 117549 117598 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 117599 117645 70.2127659574 + . Parent=HM137666 +Merlin progressiveMauve match_part 117646 117695 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 117696 117745 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 117746 117795 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 117796 117845 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 117846 117895 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 117896 117945 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 117946 117995 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 117996 118045 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 118046 118095 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 118096 118145 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 118146 118195 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 118196 118245 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 118246 118289 68.1818181818 + . Parent=HM137666 +Merlin progressiveMauve match_part 118290 118339 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 118340 118389 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 118390 118439 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 118440 118489 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 118490 118539 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 118540 118589 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 118590 118639 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 118640 118689 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 118690 118736 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 118737 118785 75.5102040816 + . Parent=HM137666 +Merlin progressiveMauve match_part 118786 118826 19.512195122 + . Parent=HM137666 +Merlin progressiveMauve match_part 118827 118860 58.8235294118 + . Parent=HM137666 +Merlin progressiveMauve match_part 118861 118904 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 118905 118944 57.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 118945 118980 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 118981 119029 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 119030 119079 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 119080 119128 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 119129 119166 47.3684210526 + . Parent=HM137666 +Merlin progressiveMauve match_part 119167 119216 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 119217 119266 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 119267 119312 60.8695652174 + . Parent=HM137666 +Merlin progressiveMauve match_part 119313 119348 63.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 119349 119398 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 119399 119448 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 119449 119498 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 119499 119528 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 119529 119570 52.380952381 + . Parent=HM137666 +Merlin progressiveMauve match_part 119571 119620 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 119621 119670 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 119671 119720 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 119721 119767 55.3191489362 + . Parent=HM137666 +Merlin progressiveMauve match_part 119768 119817 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 119818 119867 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 119868 119905 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 119906 119950 68.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 119951 119999 53.0612244898 + . Parent=HM137666 +Merlin progressiveMauve match_part 120000 120048 59.1836734694 + . Parent=HM137666 +Merlin progressiveMauve match_part 120049 120097 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 120098 120145 43.75 + . Parent=HM137666 +Merlin progressiveMauve match_part 120146 120195 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 120196 120245 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 120246 120292 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 120293 120341 46.9387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 120342 120383 52.380952381 + . Parent=HM137666 +Merlin progressiveMauve match_part 120384 120433 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 120434 120483 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 120484 120527 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 120528 120567 67.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 120568 120617 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 120618 120667 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 120668 120717 32 + . Parent=HM137666 +Merlin progressiveMauve match_part 120792 120820 55.1724137931 + . Parent=HM137666 +Merlin progressiveMauve match_part 120821 120870 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 120871 120920 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 120921 120970 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 120971 121020 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 121021 121070 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 121071 121120 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 121121 121170 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 121303 121319 76.4705882353 + . Parent=HM137666 +Merlin progressiveMauve match_part 121320 121369 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 121370 121419 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 121420 121469 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 121470 121519 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 121520 121569 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 121570 121619 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 121620 121668 53.0612244898 + . Parent=HM137666 +Merlin progressiveMauve match_part 121669 121718 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 121719 121768 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 121769 121818 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 121819 121868 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 121869 121918 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 121919 121968 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 121969 122018 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 122019 122068 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 122069 122118 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 122119 122168 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 122169 122218 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 122219 122268 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 122269 122318 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 122319 122368 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 122369 122403 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 122404 122437 61.7647058824 + . Parent=HM137666 +Merlin progressiveMauve match_part 122438 122478 63.4146341463 + . Parent=HM137666 +Merlin progressiveMauve match_part 122479 122527 77.5510204082 + . Parent=HM137666 +Merlin progressiveMauve match_part 122528 122574 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 122575 122624 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 122625 122674 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 122675 122721 70.2127659574 + . Parent=HM137666 +Merlin progressiveMauve match_part 122722 122771 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 122772 122810 74.358974359 + . Parent=HM137666 +Merlin progressiveMauve match_part 123963 123982 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 123983 124032 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 124033 124082 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 124083 124132 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 124133 124182 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 124183 124232 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 124233 124282 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 124283 124329 42.5531914894 + . Parent=HM137666 +Merlin progressiveMauve match_part 124469 124494 73.0769230769 + . Parent=HM137666 +Merlin progressiveMauve match_part 124495 124544 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 124601 124650 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 124651 124700 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 124701 124750 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 124751 124796 56.5217391304 + . Parent=HM137666 +Merlin progressiveMauve match_part 124797 124846 14 + . Parent=HM137666 +Merlin progressiveMauve match_part 124847 124868 27.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 124869 124918 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 124919 124964 45.652173913 + . Parent=HM137666 +Merlin progressiveMauve match_part 124965 125009 55.5555555556 + . Parent=HM137666 +Merlin progressiveMauve match_part 125010 125059 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 125060 125077 33.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 125078 125127 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 125128 125177 26 + . Parent=HM137666 +Merlin progressiveMauve match_part 125744 125793 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 125794 125843 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 125844 125893 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 125894 125943 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 125944 125993 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 125994 126043 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 126044 126093 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 126094 126143 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 126144 126193 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 126194 126240 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 126241 126290 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 126291 126333 58.1395348837 + . Parent=HM137666 +Merlin progressiveMauve match_part 126334 126378 71.1111111111 + . Parent=HM137666 +Merlin progressiveMauve match_part 126379 126425 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 126426 126468 67.4418604651 + . Parent=HM137666 +Merlin progressiveMauve match_part 126469 126515 74.4680851064 + . Parent=HM137666 +Merlin progressiveMauve match_part 126516 126565 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 126566 126603 60.5263157895 + . Parent=HM137666 +Merlin progressiveMauve match_part 126604 126653 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 126654 126703 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 126704 126753 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 126754 126803 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 126804 126853 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 126854 126903 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 126904 126953 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 126954 127003 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 127004 127053 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127054 127103 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 127104 127153 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 127154 127203 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 127204 127253 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 127254 127296 74.4186046512 + . Parent=HM137666 +Merlin progressiveMauve match_part 127297 127346 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127347 127390 70.4545454545 + . Parent=HM137666 +Merlin progressiveMauve match_part 127391 127440 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 127441 127484 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 127485 127534 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 127535 127584 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127585 127634 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 127635 127684 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 127685 127734 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 127735 127784 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 127785 127833 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 127834 127883 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 127884 127926 60.4651162791 + . Parent=HM137666 +Merlin progressiveMauve match_part 127927 127974 60.4166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 127975 128024 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 128025 128074 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 128075 128124 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 128125 128172 37.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 128740 128750 72.7272727273 + . Parent=HM137666 +Merlin progressiveMauve match_part 128751 128800 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 128801 128850 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 128851 128900 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 128901 128950 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 128951 129000 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 129001 129050 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 129051 129100 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 129101 129150 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 129151 129200 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 129201 129250 22 + . Parent=HM137666 +Merlin progressiveMauve match_part 130448 130493 52.1739130435 + . Parent=HM137666 +Merlin progressiveMauve match_part 130494 130540 76.5957446809 + . Parent=HM137666 +Merlin progressiveMauve match_part 130541 130590 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 130591 130640 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 130641 130690 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 130691 130740 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 130741 130790 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 130791 130840 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 130841 130878 78.9473684211 + . Parent=HM137666 +Merlin progressiveMauve match_part 130879 130927 40.8163265306 + . Parent=HM137666 +Merlin progressiveMauve match_part 131920 131966 82.9787234043 + . Parent=HM137666 +Merlin progressiveMauve match_part 131967 132013 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 132014 132063 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 132064 132113 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 132114 132163 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 132173 132190 94.4444444444 + . Parent=HM137666 +Merlin progressiveMauve match_part 132191 132239 67.3469387755 + . Parent=HM137666 +Merlin progressiveMauve match_part 132824 132839 100 + . Parent=HM137666 +Merlin progressiveMauve match_part 132840 132889 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 132890 132939 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 132940 132989 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 132990 133039 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 133040 133089 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 133090 133139 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 133140 133179 67.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 133180 133229 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 133230 133279 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 133280 133329 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 133330 133376 53.1914893617 + . Parent=HM137666 +Merlin progressiveMauve match_part 133377 133425 69.387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 133426 133475 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 133476 133525 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 133526 133575 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 133576 133625 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 133626 133669 70.4545454545 + . Parent=HM137666 +Merlin progressiveMauve match_part 133670 133719 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 133720 133769 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 134020 134068 2.04081632653 + . Parent=HM137666 +Merlin progressiveMauve match_part 134069 134118 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 134119 134168 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 134169 134218 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 134219 134268 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 134269 134318 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 134319 134359 87.8048780488 + . Parent=HM137666 +Merlin progressiveMauve match_part 134360 134391 62.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 134392 134441 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 134442 134491 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 134492 134541 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 134542 134591 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 134592 134641 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 134642 134689 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 134690 134739 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 134740 134785 52.1739130435 + . Parent=HM137666 +Merlin progressiveMauve match_part 134786 134835 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 134927 134937 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 134938 134986 59.1836734694 + . Parent=HM137666 +Merlin progressiveMauve match_part 134987 135036 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 135037 135085 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 135534 135558 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 135559 135605 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 135606 135655 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 135656 135705 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 135706 135743 39.4736842105 + . Parent=HM137666 +Merlin progressiveMauve match_part 135744 135793 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 135794 135843 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 135844 135893 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 135894 135943 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 135944 135993 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 135994 136043 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 136044 136087 61.3636363636 + . Parent=HM137666 +Merlin progressiveMauve match_part 136088 136137 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 136138 136187 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 136188 136237 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 136238 136287 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 136288 136325 68.4210526316 + . Parent=HM137666 +Merlin progressiveMauve match_part 136326 136375 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 136376 136425 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 136426 136469 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 136470 136517 64.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 136518 136564 59.5744680851 + . Parent=HM137666 +Merlin progressiveMauve match_part 136565 136614 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 136615 136664 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 136665 136714 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 136715 136764 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 136765 136814 12 + . Parent=HM137666 +Merlin progressiveMauve match_part 137888 137937 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 137938 137987 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 137988 138037 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 138038 138078 73.1707317073 + . Parent=HM137666 +Merlin progressiveMauve match_part 138079 138127 59.1836734694 + . Parent=HM137666 +Merlin progressiveMauve match_part 138128 138177 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 138178 138227 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 138228 138277 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 138278 138318 65.8536585366 + . Parent=HM137666 +Merlin progressiveMauve match_part 138319 138368 34 + . Parent=HM137666 +Merlin progressiveMauve match_part 138525 138544 55 + . Parent=HM137666 +Merlin progressiveMauve match_part 138545 138594 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 138595 138644 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 138645 138694 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 138695 138744 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 138745 138790 69.5652173913 + . Parent=HM137666 +Merlin progressiveMauve match_part 138791 138840 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 138841 138884 54.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 138885 138934 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 138935 138983 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 138984 139027 59.0909090909 + . Parent=HM137666 +Merlin progressiveMauve match_part 139028 139077 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 139078 139127 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 139128 139176 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 139177 139226 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 139227 139276 32 + . Parent=HM137666 +Merlin progressiveMauve match_part 139393 139442 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 139443 139488 65.2173913043 + . Parent=HM137666 +Merlin progressiveMauve match_part 139489 139538 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 139539 139585 38.2978723404 + . Parent=HM137666 +Merlin progressiveMauve match_part 139586 139631 71.7391304348 + . Parent=HM137666 +Merlin progressiveMauve match_part 139632 139681 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 139682 139731 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 139732 139773 73.8095238095 + . Parent=HM137666 +Merlin progressiveMauve match_part 139774 139823 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 139824 139873 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 139874 139923 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 139924 139973 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 139974 140023 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 140024 140073 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 140074 140123 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 140124 140173 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 140174 140220 72.3404255319 + . Parent=HM137666 +Merlin progressiveMauve match_part 140221 140270 4 + . Parent=HM137666 +Merlin progressiveMauve match_part 140452 140472 76.1904761905 + . Parent=HM137666 +Merlin progressiveMauve match_part 140473 140522 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 140523 140572 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 140573 140622 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 140623 140672 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 140673 140722 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 140723 140770 68.75 + . Parent=HM137666 +Merlin progressiveMauve match_part 140771 140811 46.3414634146 + . Parent=HM137666 +Merlin progressiveMauve match_part 140812 140861 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 140862 140910 67.3469387755 + . Parent=HM137666 +Merlin progressiveMauve match_part 140911 140960 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 140961 141010 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 141011 141060 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141061 141110 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141111 141160 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 141161 141210 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 141211 141260 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 141261 141310 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 141311 141360 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 141361 141385 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 141386 141411 84.6153846154 + . Parent=HM137666 +Merlin progressiveMauve match_part 141412 141461 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 141462 141504 62.7906976744 + . Parent=HM137666 +Merlin progressiveMauve match_part 141505 141534 93.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 141535 141584 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 141585 141634 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 141635 141684 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141685 141734 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 141735 141784 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 141785 141834 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 141835 141884 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 141885 141934 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 141935 141984 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 141985 142034 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 142035 142084 2 + . Parent=HM137666 +Merlin progressiveMauve match_part 142143 142192 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 142193 142242 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 142243 142292 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 142293 142342 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 142343 142392 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 142393 142442 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 142443 142492 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 142493 142542 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 142543 142592 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 142593 142642 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 142643 142692 92 + . Parent=HM137666 +Merlin progressiveMauve match_part 142693 142742 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 142743 142792 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 142793 142842 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 142843 142892 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 142893 142942 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 142943 142992 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 142993 143042 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143043 143089 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 143090 143139 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 143140 143189 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 143190 143239 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 143240 143289 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 143290 143339 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 143340 143389 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143390 143439 88 + . Parent=HM137666 +Merlin progressiveMauve match_part 143440 143489 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143490 143539 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 143540 143589 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 143590 143639 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 143640 143689 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 143690 143739 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 143740 143789 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 143790 143839 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 143840 143889 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 143890 143939 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 143940 143989 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 143990 144039 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 144040 144089 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 144090 144139 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 144140 144188 77.5510204082 + . Parent=HM137666 +Merlin progressiveMauve match_part 144189 144238 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 144239 144288 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 144289 144338 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 144339 144379 63.4146341463 + . Parent=HM137666 +Merlin progressiveMauve match_part 144380 144429 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 144430 144479 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 144480 144529 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 144530 144579 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 144580 144629 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 144630 144679 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 144957 144974 88.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 144975 145024 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 145025 145074 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145075 145124 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 145125 145173 73.4693877551 + . Parent=HM137666 +Merlin progressiveMauve match_part 145180 145202 82.6086956522 + . Parent=HM137666 +Merlin progressiveMauve match_part 145203 145252 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 145253 145302 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145303 145352 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 145353 145402 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 145403 145452 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 145453 145502 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145503 145552 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 145553 145602 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 145603 145652 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 146375 146424 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 146425 146474 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 146475 146519 77.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 146520 146569 14 + . Parent=HM137666 +Merlin progressiveMauve match_part 146757 146791 48.5714285714 + . Parent=HM137666 +Merlin progressiveMauve match_part 146792 146841 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 146842 146891 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 146892 146941 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 146942 146991 6 + . Parent=HM137666 +Merlin progressiveMauve match_part 149433 149454 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 149455 149504 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 149505 149538 58.8235294118 + . Parent=HM137666 +Merlin progressiveMauve match_part 149539 149580 61.9047619048 + . Parent=HM137666 +Merlin progressiveMauve match_part 149581 149629 51.0204081633 + . Parent=HM137666 +Merlin progressiveMauve match_part 149630 149674 57.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 149675 149715 56.0975609756 + . Parent=HM137666 +Merlin progressiveMauve match_part 149716 149747 59.375 + . Parent=HM137666 +Merlin progressiveMauve match_part 149748 149794 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 149795 149832 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 149833 149882 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 149883 149932 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 149933 149980 75 + . Parent=HM137666 +Merlin progressiveMauve match_part 149981 150030 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 150031 150080 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 150081 150130 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 150131 150180 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 150181 150230 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 150231 150280 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 150281 150330 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 150331 150380 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 150381 150430 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 150431 150480 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 150481 150530 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 150531 150580 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 150640 150672 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 150673 150722 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 150723 150772 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 150773 150822 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 150823 150872 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 150873 150922 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 150923 150972 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 150973 151022 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 151023 151072 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 151073 151122 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 151123 151172 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151173 151222 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 151223 151272 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 151273 151322 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 151323 151372 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 151373 151422 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 151423 151472 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151473 151522 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 151523 151572 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 151573 151620 77.0833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 151621 151670 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151671 151720 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151721 151770 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151771 151820 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 151821 151863 69.7674418605 + . Parent=HM137666 +Merlin progressiveMauve match_part 151864 151913 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 151914 151963 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 151964 152013 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 152014 152063 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 152064 152112 57.1428571429 + . Parent=HM137666 +Merlin progressiveMauve match_part 152113 152162 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 152163 152212 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 152213 152262 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 152263 152312 90 + . Parent=HM137666 +Merlin progressiveMauve match_part 152313 152362 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 152363 152412 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 152413 152462 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 152463 152512 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 152513 152562 86 + . Parent=HM137666 +Merlin progressiveMauve match_part 152563 152610 62.5 + . Parent=HM137666 +Merlin progressiveMauve match_part 152611 152654 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 152655 152704 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 152705 152754 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 152755 152804 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 152805 152818 85.7142857143 + . Parent=HM137666 +Merlin progressiveMauve match_part 152819 152862 70.4545454545 + . Parent=HM137666 +Merlin progressiveMauve match_part 152863 152912 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 152913 152962 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 152963 153012 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 153013 153062 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 153063 153109 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 153110 153159 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 153160 153208 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 153209 153256 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 153257 153306 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 153307 153353 53.1914893617 + . Parent=HM137666 +Merlin progressiveMauve match_part 153354 153403 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 153404 153453 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 153454 153503 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 153504 153553 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153554 153603 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153604 153653 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 153654 153703 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 153704 153753 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 153754 153803 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153804 153852 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 153853 153897 77.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 153898 153947 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 153948 153997 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 153998 154047 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 154048 154097 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 154098 154147 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 154148 154197 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 154198 154247 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 154248 154297 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 154298 154344 48.9361702128 + . Parent=HM137666 +Merlin progressiveMauve match_part 154345 154394 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 154395 154444 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 154445 154494 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 154495 154544 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 154605 154639 51.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 154640 154675 69.4444444444 + . Parent=HM137666 +Merlin progressiveMauve match_part 154676 154725 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 154726 154769 77.2727272727 + . Parent=HM137666 +Merlin progressiveMauve match_part 154770 154819 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 154820 154869 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 154870 154919 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 154920 154966 65.9574468085 + . Parent=HM137666 +Merlin progressiveMauve match_part 154967 155016 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 155017 155066 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 155067 155116 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 155117 155166 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 155167 155216 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 155217 155266 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 155267 155316 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 155317 155363 55.3191489362 + . Parent=HM137666 +Merlin progressiveMauve match_part 155364 155413 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 155464 155507 65.9090909091 + . Parent=HM137666 +Merlin progressiveMauve match_part 155508 155557 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 155558 155607 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 155608 155657 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 155658 155707 20 + . Parent=HM137666 +Merlin progressiveMauve match_part 156017 156040 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 156041 156087 53.1914893617 + . Parent=HM137666 +Merlin progressiveMauve match_part 156088 156137 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 156138 156187 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 156188 156218 6.45161290323 + . Parent=HM137666 +Merlin progressiveMauve match_part 156219 156268 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 156269 156312 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 156313 156359 68.085106383 + . Parent=HM137666 +Merlin progressiveMauve match_part 156360 156409 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 156410 156459 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 156460 156499 45 + . Parent=HM137666 +Merlin progressiveMauve match_part 156500 156549 50 + . Parent=HM137666 +Merlin progressiveMauve match_part 156550 156599 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 156600 156641 54.7619047619 + . Parent=HM137666 +Merlin progressiveMauve match_part 156642 156690 71.4285714286 + . Parent=HM137666 +Merlin progressiveMauve match_part 156691 156740 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 157836 157872 62.1621621622 + . Parent=HM137666 +Merlin progressiveMauve match_part 157873 157922 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 157923 157972 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 157973 158022 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158023 158072 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158073 158117 48.8888888889 + . Parent=HM137666 +Merlin progressiveMauve match_part 158118 158155 55.2631578947 + . Parent=HM137666 +Merlin progressiveMauve match_part 158156 158204 46.9387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 158205 158254 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 158255 158304 44 + . Parent=HM137666 +Merlin progressiveMauve match_part 158305 158348 56.8181818182 + . Parent=HM137666 +Merlin progressiveMauve match_part 158349 158393 57.7777777778 + . Parent=HM137666 +Merlin progressiveMauve match_part 158394 158441 64.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 158442 158491 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158492 158541 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 158542 158591 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158592 158641 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 158642 158691 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 158692 158741 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 159334 159379 58.6956521739 + . Parent=HM137666 +Merlin progressiveMauve match_part 159380 159429 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 159430 159479 38 + . Parent=HM137666 +Merlin progressiveMauve match_part 161952 161995 63.6363636364 + . Parent=HM137666 +Merlin progressiveMauve match_part 161996 162045 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 162046 162095 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 162096 162145 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 162146 162195 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 162196 162245 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 162246 162292 68.085106383 + . Parent=HM137666 +Merlin progressiveMauve match_part 162293 162342 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 162343 162392 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 162393 162438 73.9130434783 + . Parent=HM137666 +Merlin progressiveMauve match_part 162439 162488 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 162489 162538 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 162539 162588 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 162589 162638 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 162639 162686 83.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 162687 162734 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 162735 162783 48.9795918367 + . Parent=HM137666 +Merlin progressiveMauve match_part 163000 163031 90.625 + . Parent=HM137666 +Merlin progressiveMauve match_part 163032 163081 24 + . Parent=HM137666 +Merlin progressiveMauve match_part 163735 163782 72.9166666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 163783 163832 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 163833 163874 69.0476190476 + . Parent=HM137666 +Merlin progressiveMauve match_part 163875 163911 59.4594594595 + . Parent=HM137666 +Merlin progressiveMauve match_part 163912 163961 48 + . Parent=HM137666 +Merlin progressiveMauve match_part 163962 164011 46 + . Parent=HM137666 +Merlin progressiveMauve match_part 164012 164061 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 164062 164111 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 164112 164161 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 164162 164211 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 164212 164261 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 164262 164311 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 164312 164361 30 + . Parent=HM137666 +Merlin progressiveMauve match_part 164648 164676 72.4137931034 + . Parent=HM137666 +Merlin progressiveMauve match_part 164677 164726 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 164727 164776 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 164777 164826 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 164827 164876 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 164877 164926 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 164927 164972 54.347826087 + . Parent=HM137666 +Merlin progressiveMauve match_part 164973 165021 30.612244898 + . Parent=HM137666 +Merlin progressiveMauve match_part 165280 165325 67.3913043478 + . Parent=HM137666 +Merlin progressiveMauve match_part 165399 165444 60.8695652174 + . Parent=HM137666 +Merlin progressiveMauve match_part 165445 165494 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 165495 165544 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 165545 165594 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 165595 165644 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 165645 165694 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 165695 165744 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 165745 165794 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 165795 165844 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 165845 165894 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 165895 165944 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 165945 165994 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 165995 166042 89.5833333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 166043 166091 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 166092 166141 6 + . Parent=HM137666 +Merlin progressiveMauve match_part 167295 167333 64.1025641026 + . Parent=HM137666 +Merlin progressiveMauve match_part 167334 167383 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 167384 167433 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 167434 167483 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 167484 167533 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 167534 167580 63.829787234 + . Parent=HM137666 +Merlin progressiveMauve match_part 167581 167630 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 167631 167678 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 167679 167728 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 167729 167776 56.25 + . Parent=HM137666 +Merlin progressiveMauve match_part 167777 167826 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 167827 167876 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 167877 167926 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 167927 167976 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 167977 168026 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 168027 168074 58.3333333333 + . Parent=HM137666 +Merlin progressiveMauve match_part 168075 168124 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168125 168174 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168175 168224 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 168225 168274 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168275 168324 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 168325 168374 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 168375 168424 84 + . Parent=HM137666 +Merlin progressiveMauve match_part 168425 168474 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 168475 168524 82 + . Parent=HM137666 +Merlin progressiveMauve match_part 168525 168574 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 168575 168624 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 168625 168674 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 168675 168724 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 169065 169092 60.7142857143 + . Parent=HM137666 +Merlin progressiveMauve match_part 169093 169142 74 + . Parent=HM137666 +Merlin progressiveMauve match_part 169143 169192 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 169193 169242 60 + . Parent=HM137666 +Merlin progressiveMauve match_part 169243 169292 62 + . Parent=HM137666 +Merlin progressiveMauve match_part 169293 169342 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 169343 169374 59.375 + . Parent=HM137666 +Merlin progressiveMauve match_part 169375 169423 63.2653061224 + . Parent=HM137666 +Merlin progressiveMauve match_part 169424 169473 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 169474 169523 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 169524 169573 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 169574 169623 54 + . Parent=HM137666 +Merlin progressiveMauve match_part 169624 169673 40 + . Parent=HM137666 +Merlin progressiveMauve match_part 170000 170040 68.2926829268 + . Parent=HM137666 +Merlin progressiveMauve match_part 170041 170082 76.1904761905 + . Parent=HM137666 +Merlin progressiveMauve match_part 170083 170132 70 + . Parent=HM137666 +Merlin progressiveMauve match_part 170133 170182 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 170183 170232 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 170233 170282 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 170283 170332 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 170333 170382 72 + . Parent=HM137666 +Merlin progressiveMauve match_part 170383 170431 61.2244897959 + . Parent=HM137666 +Merlin progressiveMauve match_part 170432 170473 52.380952381 + . Parent=HM137666 +Merlin progressiveMauve match_part 170474 170523 58 + . Parent=HM137666 +Merlin progressiveMauve match_part 170524 170573 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 170574 170623 42 + . Parent=HM137666 +Merlin progressiveMauve match_part 170824 170849 38.4615384615 + . Parent=HM137666 +Merlin progressiveMauve match_part 170850 170898 65.306122449 + . Parent=HM137666 +Merlin progressiveMauve match_part 170899 170948 56 + . Parent=HM137666 +Merlin progressiveMauve match_part 170949 170991 67.4418604651 + . Parent=HM137666 +Merlin progressiveMauve match_part 170992 171040 46.9387755102 + . Parent=HM137666 +Merlin progressiveMauve match_part 171041 171090 52 + . Parent=HM137666 +Merlin progressiveMauve match_part 171091 171123 66.6666666667 + . Parent=HM137666 +Merlin progressiveMauve match_part 171124 171167 79.5454545455 + . Parent=HM137666 +Merlin progressiveMauve match_part 171168 171217 78 + . Parent=HM137666 +Merlin progressiveMauve match_part 171218 171264 57.4468085106 + . Parent=HM137666 +Merlin progressiveMauve match_part 171265 171314 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 171315 171364 68 + . Parent=HM137666 +Merlin progressiveMauve match_part 171365 171414 64 + . Parent=HM137666 +Merlin progressiveMauve match_part 171415 171464 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 171465 171514 76 + . Parent=HM137666 +Merlin progressiveMauve match_part 171515 171564 80 + . Parent=HM137666 +Merlin progressiveMauve match_part 171565 171614 66 + . Parent=HM137666 +Merlin progressiveMauve match_part 171615 171642 53.5714285714 + . Parent=HM137666 +Merlin progressiveMauve match 735 122810 . - . ID=NC_000866;Target=NC_000866 +Merlin progressiveMauve match_part 744 793 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 794 843 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 844 855 41.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 856 903 60.4166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 904 952 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 953 1000 52.0833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1001 1044 52.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1045 1094 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1095 1136 52.380952381 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1137 1186 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1187 1236 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1237 1286 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1287 1336 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1337 1383 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1384 1433 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1482 1531 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1532 1578 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1579 1622 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1623 1672 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1673 1719 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1720 1769 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1770 1819 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1820 1869 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1870 1919 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1920 1969 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 1970 2019 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2020 2069 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2070 2115 54.347826087 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2116 2162 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2163 2212 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2213 2262 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2263 2312 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2313 2362 4 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2855 2877 78.2608695652 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2878 2927 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2928 2977 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 2978 3027 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3028 3077 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3078 3127 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3128 3177 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3178 3199 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3200 3221 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3222 3258 54.0540540541 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3259 3305 78.7234042553 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3306 3355 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3356 3405 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3406 3455 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3456 3505 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3506 3555 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3556 3605 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3606 3655 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3656 3705 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3706 3755 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3756 3805 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3806 3855 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3856 3905 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3906 3955 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 3956 4005 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4006 4055 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4056 4105 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4106 4154 40.8163265306 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4155 4201 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4202 4251 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4252 4301 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4302 4351 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4352 4401 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4402 4451 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4452 4501 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4502 4551 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4552 4601 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4602 4651 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4652 4701 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 4702 4751 18 + . Parent=NC_000866 +Merlin progressiveMauve match_part 5359 5395 70.2702702703 + . Parent=NC_000866 +Merlin progressiveMauve match_part 5396 5445 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 5446 5495 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 5496 5545 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6288 6302 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6303 6346 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6347 6396 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6561 6596 63.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6597 6633 64.8648648649 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6634 6677 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6678 6727 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6728 6777 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6778 6827 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6828 6877 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6878 6918 58.5365853659 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6919 6968 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 6969 7018 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7587 7630 86.3636363636 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7631 7680 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7681 7730 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7731 7780 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7781 7830 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7831 7880 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7881 7930 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7931 7980 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 7981 8030 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8031 8080 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8081 8130 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8131 8180 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8181 8230 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8231 8280 10 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8426 8472 80.8510638298 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8473 8522 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8523 8572 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8573 8622 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8623 8672 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8673 8722 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8723 8772 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8773 8822 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8823 8872 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8873 8922 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8923 8972 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 8973 9022 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9023 9072 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9073 9122 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9123 9172 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9173 9222 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9223 9272 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9273 9322 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9323 9372 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9373 9422 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9423 9472 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9473 9522 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9523 9572 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9573 9622 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9623 9672 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9673 9722 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9723 9772 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9937 9985 59.1836734694 + . Parent=NC_000866 +Merlin progressiveMauve match_part 9986 10024 58.9743589744 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10025 10068 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10069 10110 64.2857142857 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10111 10160 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10161 10210 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10211 10260 38 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10503 10537 51.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10538 10587 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10588 10637 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10638 10687 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10688 10737 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10738 10787 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10788 10837 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10838 10887 2 + . Parent=NC_000866 +Merlin progressiveMauve match_part 10996 11013 55.5555555556 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11014 11061 52.0833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11062 11102 60.9756097561 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11103 11145 48.8372093023 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11146 11190 62.2222222222 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11191 11240 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11241 11290 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11291 11340 22 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11569 11613 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11614 11651 71.0526315789 + . Parent=NC_000866 +Merlin progressiveMauve match_part 11652 11698 36.170212766 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12474 12486 53.8461538462 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12487 12536 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12537 12583 53.1914893617 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12584 12632 34.693877551 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12764 12777 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12778 12823 76.0869565217 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12824 12873 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12874 12914 65.8536585366 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12915 12957 65.1162790698 + . Parent=NC_000866 +Merlin progressiveMauve match_part 12958 13007 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13307 13327 80.9523809524 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13328 13377 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13378 13427 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13428 13477 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13478 13527 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13528 13577 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13578 13627 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13628 13672 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13673 13709 81.0810810811 + . Parent=NC_000866 +Merlin progressiveMauve match_part 13710 13759 2 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14253 14274 81.8181818182 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14275 14324 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14325 14374 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14375 14424 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14425 14474 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14475 14524 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14525 14574 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14575 14624 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14625 14674 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14675 14724 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14725 14774 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14775 14823 87.7551020408 + . Parent=NC_000866 +Merlin progressiveMauve match_part 14824 14873 8 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15115 15164 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15165 15211 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15212 15255 65.9090909091 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15256 15301 54.347826087 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15302 15346 62.2222222222 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15347 15396 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15397 15446 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15447 15496 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15497 15546 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15547 15596 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15597 15646 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15647 15696 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15697 15746 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15747 15796 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15797 15846 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15847 15884 44.7368421053 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15885 15934 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15935 15984 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 15985 16032 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16033 16075 67.4418604651 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16076 16125 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16126 16175 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16176 16225 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16226 16275 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16276 16325 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16326 16375 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16418 16429 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16430 16479 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 16480 16529 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17150 17199 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17200 17249 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17250 17299 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17607 17629 56.5217391304 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17630 17679 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17680 17728 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17729 17778 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17779 17828 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17829 17878 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17879 17928 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17929 17978 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 17979 18028 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18029 18078 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18079 18128 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18129 18178 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18179 18228 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18229 18278 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18279 18328 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18329 18378 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18379 18428 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18429 18478 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18479 18528 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18529 18578 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18579 18628 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18629 18678 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18679 18728 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18729 18778 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18779 18828 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18829 18878 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18879 18928 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18929 18978 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 18979 19028 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19029 19078 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19079 19128 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19129 19178 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19179 19228 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19229 19275 44.6808510638 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19276 19325 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19326 19375 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19376 19425 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19426 19475 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19476 19525 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19526 19575 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19576 19625 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19626 19675 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19676 19725 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19726 19775 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19776 19825 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19826 19875 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19876 19925 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19926 19975 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 19976 20025 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20026 20075 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20076 20125 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20126 20175 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20176 20225 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20226 20275 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20276 20325 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20326 20375 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20376 20425 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20426 20475 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20476 20525 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20526 20575 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20576 20625 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20626 20675 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20767 20793 74.0740740741 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20794 20842 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20843 20892 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20893 20942 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20943 20991 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 20992 21041 36 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21103 21152 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21153 21202 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21203 21252 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21253 21301 55.1020408163 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21302 21345 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21346 21395 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21396 21445 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21446 21492 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21493 21540 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21541 21590 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21591 21640 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21641 21690 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21691 21740 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21741 21790 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21791 21840 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 21841 21890 8 + . Parent=NC_000866 +Merlin progressiveMauve match_part 22676 22709 64.7058823529 + . Parent=NC_000866 +Merlin progressiveMauve match_part 22710 22759 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 22760 22809 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 22810 22859 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 22860 22909 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 22910 22959 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 22960 23009 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23010 23059 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23060 23109 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23110 23159 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23160 23209 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23210 23259 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23260 23309 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23310 23359 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23360 23409 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23413 23433 76.1904761905 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23434 23474 73.1707317073 + . Parent=NC_000866 +Merlin progressiveMauve match_part 23475 23524 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24430 24464 68.5714285714 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24465 24514 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24515 24564 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24565 24614 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24615 24664 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24665 24714 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24715 24764 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24765 24814 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24815 24864 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24865 24914 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24915 24961 80.8510638298 + . Parent=NC_000866 +Merlin progressiveMauve match_part 24962 25011 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25012 25061 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25062 25111 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25112 25161 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25162 25211 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25212 25261 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25262 25311 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25312 25361 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25362 25411 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25412 25461 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25462 25511 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25512 25561 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25562 25611 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25612 25658 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25659 25708 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25709 25758 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25759 25808 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25809 25858 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25859 25908 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25909 25958 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 25959 26008 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26009 26058 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26059 26108 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26109 26158 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26159 26208 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26209 26258 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26259 26308 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26309 26358 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26359 26408 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26409 26458 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26459 26508 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26509 26558 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26559 26608 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26609 26658 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26659 26708 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26709 26758 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26759 26808 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26809 26858 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26859 26908 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26909 26958 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 26959 27008 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27009 27058 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27059 27105 87.2340425532 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27106 27151 82.6086956522 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27152 27201 10 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27436 27462 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27463 27512 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27513 27562 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27563 27612 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27613 27662 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27663 27712 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27713 27762 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27763 27812 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27813 27862 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27863 27912 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27913 27962 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 27963 28012 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28013 28062 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28063 28112 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28113 28162 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28163 28212 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28213 28262 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28263 28312 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28313 28362 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28363 28409 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28410 28459 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28460 28508 67.3469387755 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28509 28558 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28559 28608 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28609 28658 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28659 28708 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28709 28758 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28759 28808 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28809 28858 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28859 28908 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28909 28958 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 28959 29008 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29009 29058 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29059 29108 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29109 29158 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29159 29208 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29209 29258 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29259 29308 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29309 29357 79.5918367347 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29358 29406 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29407 29456 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29457 29506 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29507 29556 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29557 29606 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29607 29656 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29657 29706 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29707 29756 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29757 29806 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29807 29856 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29857 29906 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29907 29956 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 29957 30006 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30007 30056 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30057 30106 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30107 30148 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30149 30198 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30199 30244 63.0434782609 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30245 30292 60.4166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30293 30340 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30341 30383 55.8139534884 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30384 30433 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30434 30474 73.1707317073 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30475 30523 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30524 30573 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30574 30623 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30624 30673 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30679 30701 86.9565217391 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30702 30751 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30752 30801 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30802 30851 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30852 30901 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30902 30951 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 30952 31001 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31002 31051 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31052 31101 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31102 31151 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31152 31201 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31202 31251 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31252 31301 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31302 31351 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31352 31401 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31402 31449 64.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31450 31499 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31500 31549 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31550 31599 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31600 31649 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31650 31699 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31700 31749 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31750 31799 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31800 31849 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31850 31899 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31900 31949 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 31950 31999 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32000 32049 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32050 32099 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32100 32149 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32150 32199 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32200 32249 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32250 32299 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32300 32349 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32350 32399 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32400 32449 4 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32540 32568 58.6206896552 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32569 32618 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32619 32667 73.4693877551 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32668 32717 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32718 32767 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32768 32817 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32818 32867 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32868 32914 59.5744680851 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32915 32964 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 32965 33014 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33015 33064 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33065 33114 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33115 33164 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33165 33214 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33215 33264 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33265 33314 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33315 33363 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33364 33413 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33414 33463 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33464 33513 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33514 33563 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33564 33610 78.7234042553 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33611 33660 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 33661 33710 6 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34432 34477 54.347826087 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34478 34527 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34528 34577 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34578 34627 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34628 34677 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34678 34725 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34726 34773 47.9166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34774 34818 57.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34903 34949 70.2127659574 + . Parent=NC_000866 +Merlin progressiveMauve match_part 34950 34999 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35000 35049 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35050 35099 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35100 35149 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35150 35199 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35200 35249 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35250 35299 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35300 35349 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35350 35399 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35400 35449 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35450 35499 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35500 35549 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35550 35593 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 35594 35643 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 38668 38701 73.5294117647 + . Parent=NC_000866 +Merlin progressiveMauve match_part 38702 38751 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 38752 38801 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 38802 38851 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 38852 38901 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 38902 38949 64.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 38950 38999 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39000 39049 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39050 39099 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39100 39110 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39111 39125 73.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39126 39175 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39176 39225 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39226 39275 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39276 39325 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39326 39375 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39376 39425 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39426 39475 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39476 39525 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39526 39575 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39576 39625 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39626 39672 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39673 39722 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39723 39772 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39773 39822 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39823 39867 64.4444444444 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39868 39917 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39918 39966 55.1020408163 + . Parent=NC_000866 +Merlin progressiveMauve match_part 39967 40016 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40017 40066 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40067 40116 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40117 40166 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40167 40216 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40217 40266 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40267 40316 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40317 40366 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40367 40385 78.9473684211 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40386 40433 89.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40434 40483 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40484 40533 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40534 40583 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40584 40633 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40634 40683 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40684 40733 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40734 40783 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40784 40833 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40834 40883 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40884 40933 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40934 40983 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 40984 41033 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41034 41083 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41084 41133 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41134 41183 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41184 41233 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41234 41283 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41284 41333 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41334 41383 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41384 41430 70.2127659574 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41431 41480 10 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41612 41627 62.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41628 41677 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41678 41727 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41728 41773 52.1739130435 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41774 41823 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41824 41867 38.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41900 41942 62.7906976744 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41943 41992 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 41993 42042 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42043 42086 81.8181818182 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42087 42133 80.8510638298 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42134 42183 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42184 42233 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42234 42283 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42284 42331 70.8333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42332 42381 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42382 42431 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42432 42481 10 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42611 42651 68.2926829268 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42652 42701 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42702 42751 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 42752 42801 2 + . Parent=NC_000866 +Merlin progressiveMauve match_part 43122 43135 85.7142857143 + . Parent=NC_000866 +Merlin progressiveMauve match_part 43136 43185 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 43186 43235 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 43236 43285 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 43286 43335 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 48867 48914 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 48915 48964 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 48965 49014 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49015 49064 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49065 49114 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49115 49164 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49165 49214 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49215 49264 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49265 49314 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49315 49364 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49365 49414 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49415 49464 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49465 49514 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49515 49564 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49565 49614 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49615 49661 80.8510638298 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49662 49711 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49712 49760 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49761 49810 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 49811 49860 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50413 50425 84.6153846154 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50426 50475 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50476 50525 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50526 50575 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50576 50625 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50626 50675 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50676 50725 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50726 50775 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50776 50825 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50826 50875 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50876 50925 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50926 50972 51.0638297872 + . Parent=NC_000866 +Merlin progressiveMauve match_part 50973 51022 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51023 51072 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51073 51122 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51123 51172 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51173 51222 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51223 51272 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51273 51322 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51323 51372 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51373 51422 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 51423 51472 8 + . Parent=NC_000866 +Merlin progressiveMauve match_part 53804 53816 84.6153846154 + . Parent=NC_000866 +Merlin progressiveMauve match_part 53817 53862 52.1739130435 + . Parent=NC_000866 +Merlin progressiveMauve match_part 53863 53912 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 53913 53962 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 53963 54012 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54013 54057 68.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54058 54107 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54108 54157 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54158 54207 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54208 54254 61.7021276596 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54255 54289 51.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54290 54339 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54340 54389 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54390 54431 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54432 54478 59.5744680851 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54479 54528 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54529 54574 82.6086956522 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54575 54624 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54625 54674 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54675 54724 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54725 54774 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 54775 54823 32.6530612245 + . Parent=NC_000866 +Merlin progressiveMauve match_part 55720 55739 85 + . Parent=NC_000866 +Merlin progressiveMauve match_part 55740 55789 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 55790 55838 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 55839 55888 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 55889 55938 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 55939 55988 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 55989 56038 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 56039 56088 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 56089 56138 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 56139 56188 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 56189 56238 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 56239 56288 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57247 57258 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57259 57308 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57309 57358 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57359 57408 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57409 57451 67.4418604651 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57452 57501 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57502 57544 67.4418604651 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57545 57594 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57595 57644 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57645 57685 53.6585365854 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57686 57735 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57736 57782 70.2127659574 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57783 57832 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 57833 57882 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58525 58548 79.1666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58549 58595 42.5531914894 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58596 58645 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58646 58695 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58696 58745 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58746 58795 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58796 58845 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58846 58895 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58896 58939 65.9090909091 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58940 58989 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 58990 59039 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59040 59089 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59090 59139 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59140 59186 61.7021276596 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59187 59236 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59237 59263 51.8518518519 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59264 59313 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59314 59363 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59364 59413 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59414 59463 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59464 59513 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59514 59563 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59564 59610 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59611 59659 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59660 59706 8.51063829787 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59707 59749 65.1162790698 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59750 59797 39.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59798 59846 53.0612244898 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59847 59896 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59897 59943 42.5531914894 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59944 59988 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 59989 60038 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60039 60088 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60089 60138 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60189 60234 54.347826087 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60235 60284 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60329 60350 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60351 60400 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60401 60450 34 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60503 60529 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60530 60579 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60651 60688 71.0526315789 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60689 60733 48.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60734 60773 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60774 60823 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60824 60873 28 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60929 60953 36 + . Parent=NC_000866 +Merlin progressiveMauve match_part 60954 61003 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61004 61053 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61054 61097 52.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61098 61147 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61148 61195 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61196 61234 79.4871794872 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61235 61280 4.34782608696 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61281 61328 77.0833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61329 61378 38 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61379 61428 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61429 61478 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61479 61525 55.3191489362 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61526 61575 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61576 61625 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61626 61667 54.7619047619 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61668 61716 73.4693877551 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61717 61766 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61767 61812 76.0869565217 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61813 61862 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 61863 61912 18 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62173 62207 77.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62208 62257 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62258 62307 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62308 62357 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62358 62407 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62408 62457 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62458 62507 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62508 62557 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62558 62607 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62608 62657 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62658 62706 73.4693877551 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62707 62756 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62757 62806 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62807 62856 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62857 62906 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62907 62956 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 62957 63006 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 63007 63049 69.7674418605 + . Parent=NC_000866 +Merlin progressiveMauve match_part 63050 63094 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 63095 63144 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 63145 63194 2 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68346 68375 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68376 68425 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68426 68475 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68476 68525 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68526 68575 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68576 68625 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68626 68675 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68676 68725 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68726 68775 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 68776 68825 2 + . Parent=NC_000866 +Merlin progressiveMauve match_part 73949 73965 76.4705882353 + . Parent=NC_000866 +Merlin progressiveMauve match_part 73966 74009 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 74010 74058 46.9387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 74953 74993 65.8536585366 + . Parent=NC_000866 +Merlin progressiveMauve match_part 74994 75033 55 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75034 75082 40.8163265306 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75083 75132 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75133 75176 79.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75177 75218 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75219 75265 21.2765957447 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75371 75409 71.7948717949 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75410 75459 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75604 75627 75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75628 75677 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75678 75727 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75728 75777 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75778 75827 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75828 75877 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75878 75927 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75928 75977 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 75978 76027 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76028 76071 68.1818181818 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76072 76117 56.5217391304 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76118 76167 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76168 76206 58.9743589744 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76207 76256 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76257 76292 72.2222222222 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76293 76337 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76338 76387 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76388 76437 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76438 76487 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76488 76537 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76538 76587 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76588 76637 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76638 76686 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76687 76728 61.9047619048 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76729 76778 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76779 76828 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76829 76874 58.6956521739 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76875 76924 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76925 76974 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 76975 77024 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77025 77074 36 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77075 77124 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77125 77174 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77175 77224 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77225 77274 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77275 77324 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77325 77374 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77375 77424 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77425 77473 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77474 77523 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77524 77573 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77574 77605 81.25 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77606 77650 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77651 77689 79.4871794872 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77690 77736 80.8510638298 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77737 77786 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77787 77836 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77837 77886 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77887 77936 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77937 77986 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 77987 78036 14 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78451 78494 70.4545454545 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78495 78542 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78543 78591 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78592 78641 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78642 78691 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78692 78741 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78742 78791 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78792 78841 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78842 78891 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78892 78941 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78942 78989 68.75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 78990 79039 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79040 79089 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79090 79139 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79140 79189 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79190 79239 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79240 79289 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79290 79339 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79340 79389 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79390 79439 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79440 79489 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79490 79539 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79540 79589 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79590 79639 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79640 79689 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79690 79739 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79740 79789 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79790 79839 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79840 79889 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79890 79933 65.9090909091 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79934 79983 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 79984 80033 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80034 80083 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80084 80130 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80131 80180 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80181 80230 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80231 80280 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80281 80330 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80331 80380 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80381 80420 15 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80421 80448 78.5714285714 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80449 80498 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80499 80548 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80549 80598 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80599 80648 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80649 80695 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80696 80745 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80746 80795 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80796 80845 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80846 80895 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80896 80945 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80946 80995 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 80996 81045 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81046 81095 34 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81227 81237 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81238 81287 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81288 81337 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81338 81386 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81387 81436 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81437 81486 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81487 81530 65.9090909091 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81531 81580 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81581 81630 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81631 81680 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81681 81730 36 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81835 81862 67.8571428571 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81863 81912 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81913 81962 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 81963 82012 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82013 82062 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82063 82112 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82113 82150 78.9473684211 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82151 82200 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82201 82250 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82251 82300 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82301 82350 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82351 82400 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82401 82450 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82451 82500 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82501 82550 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82551 82600 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82601 82650 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82651 82700 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82701 82750 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82751 82800 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82801 82850 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82851 82900 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82901 82950 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 82951 83000 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83001 83050 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83051 83100 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83101 83150 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83151 83200 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83201 83250 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83251 83300 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83301 83350 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83351 83400 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83401 83450 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83451 83500 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83501 83550 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83551 83600 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83601 83650 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83651 83678 60.7142857143 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83679 83713 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83714 83763 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83764 83813 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83814 83855 54.7619047619 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83856 83905 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83906 83955 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 83956 84005 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84006 84055 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84056 84105 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84106 84155 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84156 84205 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84206 84253 60.4166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84254 84300 51.0638297872 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84301 84350 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84351 84400 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84401 84450 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84451 84500 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84501 84550 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84551 84600 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84601 84649 71.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84650 84699 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84700 84749 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84750 84799 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84800 84849 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84850 84899 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84900 84949 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 84950 84999 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85000 85049 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85050 85099 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85100 85149 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85150 85199 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85200 85248 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85249 85290 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85291 85340 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85341 85390 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85391 85440 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85441 85490 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85491 85540 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85541 85590 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85591 85640 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85641 85690 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85691 85736 63.0434782609 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85737 85786 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85787 85836 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85837 85886 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85887 85936 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85937 85965 20.6896551724 + . Parent=NC_000866 +Merlin progressiveMauve match_part 85966 86015 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86016 86065 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86066 86115 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86116 86165 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86166 86215 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86216 86265 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86266 86315 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86316 86365 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86366 86415 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86416 86465 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86466 86515 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86516 86565 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86566 86615 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86616 86665 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86666 86715 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86716 86765 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86766 86815 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86816 86865 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86866 86915 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86916 86965 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 86966 87015 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87016 87065 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87066 87115 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87116 87165 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87166 87215 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87216 87265 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87266 87315 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87316 87365 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87366 87415 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87416 87465 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87466 87515 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87516 87565 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87566 87615 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87616 87662 68.085106383 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87663 87710 64.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87711 87760 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87761 87810 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87811 87860 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87861 87910 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87911 87960 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 87961 88010 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88011 88060 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88061 88110 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88111 88160 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88161 88205 73.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88206 88255 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88256 88305 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88306 88355 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88356 88405 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88406 88455 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88456 88505 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88506 88555 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88556 88605 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88606 88645 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88646 88695 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88696 88745 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88746 88795 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88796 88845 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88846 88895 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88896 88945 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88946 88995 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 88996 89044 46.9387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89045 89086 61.9047619048 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89087 89133 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89134 89183 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89184 89233 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89234 89281 75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89282 89331 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89332 89381 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89382 89431 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89432 89476 64.4444444444 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89477 89526 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89527 89576 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89577 89621 68.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89622 89671 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89672 89721 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89722 89768 72.3404255319 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89769 89818 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89819 89868 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89869 89918 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89919 89964 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 89965 90011 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90012 90061 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90062 90111 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90112 90152 70.7317073171 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90153 90201 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90202 90247 73.9130434783 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90248 90296 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90297 90346 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90347 90396 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90397 90440 56.8181818182 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90441 90488 83.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90489 90538 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90539 90588 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90589 90638 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90639 90688 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90689 90738 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90739 90788 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90789 90838 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90839 90888 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90889 90938 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90939 90984 67.3913043478 + . Parent=NC_000866 +Merlin progressiveMauve match_part 90985 91029 62.2222222222 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91030 91079 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91080 91120 53.6585365854 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91121 91170 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91171 91209 43.5897435897 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91210 91255 65.2173913043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91256 91299 52.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91300 91347 56.25 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91348 91394 78.7234042553 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91395 91435 60.9756097561 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91436 91484 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91485 91533 59.1836734694 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91534 91583 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91584 91633 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91634 91683 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91843 91855 76.9230769231 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91856 91905 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91906 91952 44.6808510638 + . Parent=NC_000866 +Merlin progressiveMauve match_part 91953 92002 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92003 92052 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92053 92099 34.0425531915 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92100 92149 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92150 92199 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92200 92249 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92250 92299 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92300 92334 65.7142857143 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92335 92378 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92379 92428 26 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92475 92496 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92497 92546 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92547 92593 46.8085106383 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92594 92643 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92644 92693 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92694 92743 6 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92859 92894 44.4444444444 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92895 92944 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92945 92994 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 92995 93044 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93045 93094 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93095 93144 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93145 93185 58.5365853659 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93186 93235 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93236 93279 68.1818181818 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93280 93323 38.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93324 93373 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93374 93422 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93423 93472 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93473 93522 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93523 93567 53.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93568 93617 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93618 93667 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93905 93916 83.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93917 93966 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 93967 94016 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94017 94066 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94067 94105 58.9743589744 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94106 94155 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94156 94205 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94206 94255 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94302 94351 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94352 94395 56.8181818182 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94396 94445 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94446 94495 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94496 94545 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94546 94595 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94596 94645 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94646 94695 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94696 94745 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94746 94795 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94796 94845 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94846 94895 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94896 94945 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94946 94995 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 94996 95045 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95046 95095 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95096 95145 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95146 95195 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95196 95245 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95246 95295 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95296 95345 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95346 95384 64.1025641026 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95385 95434 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95435 95484 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95485 95534 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95535 95584 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95585 95634 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95635 95684 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95685 95734 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95735 95784 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95785 95834 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95835 95884 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95885 95934 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95935 95984 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 95985 96034 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96035 96084 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96085 96131 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96132 96178 76.5957446809 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96179 96228 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96229 96270 38.0952380952 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96271 96320 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96321 96370 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96371 96420 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96421 96470 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96471 96520 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96521 96570 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96571 96620 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96621 96670 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96671 96720 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96721 96770 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96771 96820 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96821 96867 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96868 96917 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96918 96967 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 96968 97011 68.1818181818 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97012 97061 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97062 97111 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97112 97161 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97162 97211 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97212 97261 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97262 97311 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97312 97355 65.9090909091 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97356 97405 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97406 97455 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97456 97505 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97506 97555 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97556 97605 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97606 97653 75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97654 97703 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97704 97753 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97754 97803 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97804 97853 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97854 97903 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97904 97953 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 97954 98003 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98004 98053 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98054 98103 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98104 98153 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98154 98203 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98204 98253 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98254 98303 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98304 98353 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98354 98403 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98404 98453 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98454 98503 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98504 98553 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98554 98603 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98604 98653 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98654 98703 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98704 98753 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98754 98803 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98804 98853 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98854 98903 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98904 98953 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 98954 99003 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99004 99053 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99054 99103 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99104 99153 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99154 99203 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99204 99253 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99254 99303 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99304 99353 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99354 99403 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99404 99453 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99454 99503 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99504 99553 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99554 99603 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99604 99653 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99654 99703 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99704 99753 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99754 99802 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99803 99852 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99853 99902 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99903 99952 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 99953 100002 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100003 100052 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100053 100102 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100103 100152 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100153 100202 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100203 100252 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100253 100299 74.4680851064 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100300 100349 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100350 100399 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100400 100449 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100450 100499 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100500 100549 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100550 100599 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100600 100649 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100650 100699 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100700 100749 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100750 100799 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100800 100849 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100850 100899 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100900 100949 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 100950 100999 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101000 101049 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101050 101099 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101100 101149 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101150 101199 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101200 101249 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101250 101299 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101300 101349 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101350 101399 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101400 101449 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101450 101499 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101500 101549 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101550 101599 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101600 101649 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101650 101699 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101700 101749 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101750 101799 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101800 101849 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101850 101899 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101900 101945 65.2173913043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101946 101981 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 101982 102031 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102032 102081 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102082 102131 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102132 102172 68.2926829268 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102173 102222 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102223 102272 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102273 102322 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102323 102372 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102373 102422 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102423 102472 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102473 102522 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102523 102572 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102573 102622 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102623 102672 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102673 102722 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102723 102772 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102773 102822 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102823 102872 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102873 102922 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102923 102972 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 102973 103022 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103023 103072 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103073 103122 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103123 103172 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103173 103222 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103223 103272 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103273 103322 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103323 103372 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103373 103422 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103423 103472 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103473 103522 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103523 103569 78.7234042553 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103570 103619 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103620 103669 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103670 103717 68.75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103718 103744 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103745 103780 91.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103781 103830 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103831 103880 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103881 103930 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103931 103980 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 103981 104030 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104031 104080 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104081 104130 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104131 104180 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104181 104230 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104231 104280 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104281 104330 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104331 104380 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104381 104430 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104431 104480 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104481 104530 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104531 104580 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104581 104630 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104631 104680 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104681 104730 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104731 104780 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104781 104827 70.2127659574 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104828 104877 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104878 104927 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104928 104977 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 104978 105027 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105028 105077 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105078 105127 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105128 105177 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105178 105227 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105228 105277 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105278 105327 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105328 105377 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105378 105427 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105428 105477 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105478 105527 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105528 105574 68.085106383 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105575 105618 77.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105619 105668 32 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105669 105715 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105716 105762 61.7021276596 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105763 105811 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105812 105861 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105862 105911 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105912 105961 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 105962 106011 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106012 106061 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106062 106111 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106112 106161 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106162 106211 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106212 106261 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106262 106311 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106312 106361 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106362 106411 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106412 106461 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106462 106511 96 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106512 106561 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106562 106611 94 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106612 106661 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106662 106711 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106712 106761 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106762 106811 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106812 106861 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106862 106911 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106912 106961 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 106962 107011 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107012 107061 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107062 107111 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107112 107158 87.2340425532 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107159 107205 59.5744680851 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107206 107253 70.8333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107254 107303 22 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107310 107326 82.3529411765 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107327 107376 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107377 107426 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107427 107476 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107477 107526 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107527 107576 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107577 107626 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107627 107676 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107677 107726 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107727 107776 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107777 107826 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107827 107876 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107877 107926 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107927 107976 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 107977 108026 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108027 108076 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108077 108126 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108127 108176 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108177 108226 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108227 108276 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108277 108326 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108327 108376 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108377 108426 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108427 108476 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108477 108526 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108527 108576 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108577 108626 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 108627 108676 32 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109177 109213 21.6216216216 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109214 109263 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109264 109313 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109314 109363 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109364 109413 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109414 109463 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109464 109513 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109514 109563 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109564 109607 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109608 109657 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109658 109704 59.5744680851 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109705 109754 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109755 109804 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109805 109854 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109855 109904 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109905 109954 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 109955 110004 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 110005 110054 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 110055 110098 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 110099 110148 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 110149 110198 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 110199 110248 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 110249 110298 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 110299 110348 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111266 111315 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111316 111365 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111366 111414 69.387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111415 111464 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111465 111514 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111515 111558 61.3636363636 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111559 111606 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111607 111656 20 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111914 111963 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 111964 112013 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112014 112063 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112064 112106 11.6279069767 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112107 112154 70.8333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112155 112204 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112205 112254 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112255 112304 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112305 112351 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112352 112395 56.8181818182 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112396 112442 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112443 112483 68.2926829268 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112484 112527 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112528 112557 63.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112558 112606 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112607 112656 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112657 112703 72.3404255319 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112704 112753 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112754 112784 6.45161290323 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112785 112807 69.5652173913 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112808 112857 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112858 112907 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112908 112957 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 112958 113007 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113008 113057 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113058 113107 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113108 113157 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113158 113207 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113208 113257 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113258 113307 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113308 113346 71.7948717949 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113347 113395 38.7755102041 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113396 113445 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113446 113495 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113496 113545 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113546 113595 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113596 113645 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113646 113695 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113696 113745 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113746 113795 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113796 113845 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113846 113895 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113896 113945 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113946 113995 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 113996 114045 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114046 114095 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114096 114145 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114146 114195 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114196 114245 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114246 114295 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114296 114309 28.5714285714 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114310 114359 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114360 114409 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114410 114459 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114460 114506 74.4680851064 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114507 114556 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114557 114606 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114607 114656 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114657 114706 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114707 114753 74.4680851064 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114754 114791 84.2105263158 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114792 114834 74.4186046512 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114835 114884 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114885 114934 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114935 114984 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 114985 115034 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115035 115083 67.3469387755 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115084 115133 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115134 115183 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115184 115233 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115234 115275 71.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115276 115321 65.2173913043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115322 115371 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115372 115421 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115422 115471 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115472 115521 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115522 115571 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115572 115621 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115622 115671 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115672 115721 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115722 115771 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115772 115821 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115822 115871 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115872 115921 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115922 115971 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 115972 116021 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116022 116071 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116072 116121 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116122 116171 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116172 116221 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116222 116271 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116272 116320 67.3469387755 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116321 116368 79.1666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116369 116418 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116419 116468 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116469 116518 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116519 116568 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116569 116618 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116619 116668 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116669 116718 34 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116862 116909 54.1666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116910 116956 61.7021276596 + . Parent=NC_000866 +Merlin progressiveMauve match_part 116957 117006 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117007 117056 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117057 117105 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117106 117153 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117154 117203 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117204 117253 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117254 117303 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117304 117352 75.5102040816 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117353 117400 72.9166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117401 117450 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117451 117500 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117501 117548 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117549 117598 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117599 117645 70.2127659574 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117646 117695 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117696 117745 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117746 117795 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117796 117845 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117846 117895 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117896 117945 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117946 117995 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 117996 118045 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118046 118095 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118096 118145 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118146 118195 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118196 118245 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118246 118289 68.1818181818 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118290 118339 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118340 118389 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118390 118439 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118440 118489 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118490 118539 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118540 118589 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118590 118639 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118640 118689 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118690 118736 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118737 118785 75.5102040816 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118786 118826 19.512195122 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118827 118860 58.8235294118 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118861 118904 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118905 118944 57.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118945 118980 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 118981 119029 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119030 119079 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119080 119128 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119129 119166 47.3684210526 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119167 119216 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119217 119266 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119267 119312 60.8695652174 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119313 119348 63.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119349 119398 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119399 119448 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119449 119498 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119499 119528 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119529 119570 52.380952381 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119571 119620 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119621 119670 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119671 119720 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119721 119767 55.3191489362 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119768 119817 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119818 119867 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119868 119905 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119906 119950 68.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 119951 119999 53.0612244898 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120000 120048 59.1836734694 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120049 120097 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120098 120145 43.75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120146 120195 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120196 120245 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120246 120292 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120293 120341 46.9387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120342 120383 52.380952381 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120384 120433 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120434 120483 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120484 120527 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120528 120567 67.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120568 120617 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120618 120667 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120668 120717 32 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120792 120820 55.1724137931 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120821 120870 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120871 120920 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120921 120970 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 120971 121020 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121021 121070 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121071 121120 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121121 121170 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121303 121319 76.4705882353 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121320 121369 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121370 121419 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121420 121469 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121470 121519 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121520 121569 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121570 121619 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121620 121668 53.0612244898 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121669 121718 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121719 121768 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121769 121818 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121819 121868 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121869 121918 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121919 121968 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 121969 122018 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122019 122068 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122069 122118 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122119 122168 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122169 122218 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122219 122268 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122269 122318 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122319 122368 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122369 122403 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122404 122437 61.7647058824 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122438 122478 63.4146341463 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122479 122527 73.4693877551 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122528 122574 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122575 122624 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122625 122674 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122675 122721 70.2127659574 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122722 122771 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 122772 122810 74.358974359 + . Parent=NC_000866 +Merlin progressiveMauve match_part 123963 123982 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 123983 124032 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124033 124082 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124083 124132 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124133 124182 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124183 124232 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124233 124282 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124283 124329 42.5531914894 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124469 124494 73.0769230769 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124495 124544 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124601 124650 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124651 124700 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124701 124750 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124751 124796 56.5217391304 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124797 124846 14 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124847 124868 27.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124869 124918 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124919 124964 45.652173913 + . Parent=NC_000866 +Merlin progressiveMauve match_part 124965 125009 55.5555555556 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125010 125059 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125060 125077 33.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125078 125127 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125128 125177 26 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125744 125793 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125794 125843 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125844 125893 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125894 125943 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125944 125993 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 125994 126043 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126044 126093 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126094 126143 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126144 126193 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126194 126240 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126241 126290 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126291 126333 58.1395348837 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126334 126378 71.1111111111 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126379 126425 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126426 126468 67.4418604651 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126469 126515 74.4680851064 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126516 126565 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126566 126603 60.5263157895 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126604 126653 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126654 126703 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126704 126753 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126754 126803 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126804 126853 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126854 126903 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126904 126953 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 126954 127003 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127004 127053 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127054 127103 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127104 127153 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127154 127203 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127204 127253 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127254 127296 74.4186046512 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127297 127346 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127347 127390 70.4545454545 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127391 127440 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127441 127484 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127485 127534 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127535 127584 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127585 127634 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127635 127684 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127685 127734 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127735 127784 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127785 127833 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127834 127883 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127884 127926 60.4651162791 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127927 127974 60.4166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 127975 128024 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128025 128074 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128075 128124 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128125 128172 37.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128740 128750 72.7272727273 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128751 128800 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128801 128850 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128851 128900 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128901 128950 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 128951 129000 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129001 129050 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129051 129100 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129101 129150 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129151 129200 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 129201 129250 22 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130448 130493 52.1739130435 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130494 130540 76.5957446809 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130541 130590 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130591 130640 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130641 130690 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130691 130740 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130741 130790 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130791 130840 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130841 130878 78.9473684211 + . Parent=NC_000866 +Merlin progressiveMauve match_part 130879 130927 40.8163265306 + . Parent=NC_000866 +Merlin progressiveMauve match_part 131920 131966 82.9787234043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 131967 132013 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132014 132063 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132064 132113 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132114 132163 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132173 132190 94.4444444444 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132191 132239 67.3469387755 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132824 132839 100 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132840 132889 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132890 132939 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132940 132989 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 132990 133039 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133040 133089 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133090 133139 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133140 133179 67.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133180 133229 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133230 133279 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133280 133329 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133330 133376 53.1914893617 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133377 133425 69.387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133426 133475 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133476 133525 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133526 133575 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133576 133625 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133626 133669 70.4545454545 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133670 133719 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 133720 133769 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134020 134068 2.04081632653 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134069 134118 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134119 134168 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134169 134218 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134219 134268 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134269 134318 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134319 134359 87.8048780488 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134360 134391 62.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134392 134441 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134442 134491 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134492 134541 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134542 134591 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134592 134641 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134642 134689 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134690 134739 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134740 134785 52.1739130435 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134786 134835 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134927 134937 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134938 134986 59.1836734694 + . Parent=NC_000866 +Merlin progressiveMauve match_part 134987 135036 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135037 135085 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135534 135558 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135559 135605 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135606 135655 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135656 135705 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135706 135743 39.4736842105 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135744 135793 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135794 135843 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135844 135893 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135894 135943 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135944 135993 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 135994 136043 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136044 136087 61.3636363636 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136088 136137 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136138 136187 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136188 136237 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136238 136287 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136288 136325 68.4210526316 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136326 136375 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136376 136425 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136426 136469 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136470 136517 64.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136518 136564 59.5744680851 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136565 136614 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136615 136664 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136665 136714 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136715 136764 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 136765 136814 12 + . Parent=NC_000866 +Merlin progressiveMauve match_part 137888 137937 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 137938 137987 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 137988 138037 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138038 138078 73.1707317073 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138079 138127 59.1836734694 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138128 138177 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138178 138227 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138228 138277 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138278 138318 65.8536585366 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138319 138368 34 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138525 138544 55 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138545 138594 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138595 138644 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138645 138694 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138695 138744 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138745 138790 69.5652173913 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138791 138840 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138841 138884 54.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138885 138934 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138935 138983 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 138984 139027 59.0909090909 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139028 139077 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139078 139127 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139128 139176 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139177 139226 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139227 139276 32 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139393 139442 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139443 139488 65.2173913043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139489 139538 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139539 139585 38.2978723404 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139586 139631 71.7391304348 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139632 139681 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139682 139731 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139732 139773 73.8095238095 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139774 139823 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139824 139873 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139874 139923 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139924 139973 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 139974 140023 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140024 140073 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140074 140123 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140124 140173 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140174 140220 72.3404255319 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140221 140270 4 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140452 140472 76.1904761905 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140473 140522 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140523 140572 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140573 140622 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140623 140672 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140673 140722 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140723 140770 68.75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140771 140811 46.3414634146 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140812 140861 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140862 140910 67.3469387755 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140911 140960 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 140961 141010 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141011 141060 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141061 141110 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141111 141160 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141161 141210 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141211 141260 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141261 141310 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141311 141360 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141361 141385 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141386 141411 84.6153846154 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141412 141461 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141462 141504 62.7906976744 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141505 141534 93.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141535 141584 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141585 141634 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141635 141684 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141685 141734 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141735 141784 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141785 141834 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141835 141884 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141885 141934 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141935 141984 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 141985 142034 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142035 142084 2 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142143 142192 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142193 142242 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142243 142292 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142293 142342 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142343 142392 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142393 142442 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142443 142492 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142493 142542 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142543 142592 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142593 142642 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142643 142692 92 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142693 142742 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142743 142792 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142793 142842 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142843 142892 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142893 142942 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142943 142992 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 142993 143042 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143043 143089 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143090 143139 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143140 143189 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143190 143239 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143240 143289 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143290 143339 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143340 143389 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143390 143439 88 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143440 143489 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143490 143539 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143540 143589 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143590 143639 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143640 143689 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143690 143739 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143740 143789 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143790 143839 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143840 143889 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143890 143939 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143940 143989 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 143990 144039 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144040 144089 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144090 144139 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144140 144188 77.5510204082 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144189 144238 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144239 144288 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144289 144338 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144339 144379 63.4146341463 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144380 144429 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144430 144479 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144480 144529 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144530 144579 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144580 144629 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144630 144679 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144957 144974 88.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 144975 145024 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145025 145074 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145075 145124 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145125 145173 73.4693877551 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145180 145202 82.6086956522 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145203 145252 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145253 145302 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145303 145352 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145353 145402 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145403 145452 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145453 145502 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145503 145552 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145553 145602 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 145603 145652 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146375 146424 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146425 146474 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146475 146519 77.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146520 146569 14 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146757 146791 48.5714285714 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146792 146841 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146842 146891 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146892 146941 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 146942 146991 6 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149433 149454 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149455 149504 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149505 149538 58.8235294118 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149539 149580 61.9047619048 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149581 149629 51.0204081633 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149630 149674 57.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149675 149715 56.0975609756 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149716 149747 59.375 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149748 149794 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149795 149832 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149833 149882 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149883 149932 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149933 149980 75 + . Parent=NC_000866 +Merlin progressiveMauve match_part 149981 150030 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150031 150080 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150081 150130 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150131 150180 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150181 150230 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150231 150280 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150281 150330 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150331 150380 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150381 150430 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150431 150480 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150481 150530 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150531 150580 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150640 150672 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150673 150722 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150723 150772 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150773 150822 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150823 150872 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150873 150922 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150923 150972 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 150973 151022 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151023 151072 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151073 151122 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151123 151172 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151173 151222 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151223 151272 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151273 151322 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151323 151372 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151373 151422 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151423 151472 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151473 151522 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151523 151572 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151573 151620 77.0833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151621 151670 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151671 151720 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151721 151770 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151771 151820 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151821 151863 69.7674418605 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151864 151913 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151914 151963 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 151964 152013 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152014 152063 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152064 152112 57.1428571429 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152113 152162 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152163 152212 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152213 152262 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152263 152312 90 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152313 152362 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152363 152412 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152413 152462 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152463 152512 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152513 152562 86 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152563 152610 62.5 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152611 152654 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152655 152704 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152705 152754 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152755 152804 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152805 152818 85.7142857143 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152819 152862 70.4545454545 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152863 152912 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152913 152962 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 152963 153012 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153013 153062 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153063 153109 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153110 153159 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153160 153208 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153209 153256 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153257 153306 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153307 153353 53.1914893617 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153354 153403 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153404 153453 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153454 153503 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153504 153553 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153554 153603 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153604 153653 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153654 153703 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153704 153753 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153754 153803 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153804 153852 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153853 153897 77.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153898 153947 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153948 153997 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 153998 154047 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154048 154097 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154098 154147 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154148 154197 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154198 154247 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154248 154297 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154298 154344 48.9361702128 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154345 154394 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154395 154444 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154445 154494 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154495 154544 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154605 154639 51.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154640 154675 69.4444444444 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154676 154725 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154726 154769 77.2727272727 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154770 154819 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154820 154869 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154870 154919 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154920 154966 65.9574468085 + . Parent=NC_000866 +Merlin progressiveMauve match_part 154967 155016 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155017 155066 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155067 155116 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155117 155166 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155167 155216 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155217 155266 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155267 155316 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155317 155363 55.3191489362 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155364 155413 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155464 155507 65.9090909091 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155508 155557 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155558 155607 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155608 155657 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 155658 155707 20 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156017 156040 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156041 156087 53.1914893617 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156088 156137 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156138 156187 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156188 156218 6.45161290323 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156219 156268 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156269 156312 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156313 156359 68.085106383 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156360 156409 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156410 156459 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156460 156499 45 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156500 156549 50 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156550 156599 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156600 156641 54.7619047619 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156642 156690 71.4285714286 + . Parent=NC_000866 +Merlin progressiveMauve match_part 156691 156740 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157836 157872 59.4594594595 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157873 157922 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157923 157972 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 157973 158022 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158023 158072 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158073 158117 48.8888888889 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158118 158155 55.2631578947 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158156 158204 46.9387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158205 158254 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158255 158304 44 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158305 158348 56.8181818182 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158349 158393 57.7777777778 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158394 158441 64.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158442 158491 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158492 158541 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158542 158591 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158592 158641 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158642 158691 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 158692 158741 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 159334 159379 58.6956521739 + . Parent=NC_000866 +Merlin progressiveMauve match_part 159380 159429 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 159430 159479 38 + . Parent=NC_000866 +Merlin progressiveMauve match_part 161952 161995 63.6363636364 + . Parent=NC_000866 +Merlin progressiveMauve match_part 161996 162045 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162046 162095 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162096 162145 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162146 162195 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162196 162245 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162246 162292 68.085106383 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162293 162342 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162343 162392 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162393 162438 73.9130434783 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162439 162488 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162489 162538 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162539 162588 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162589 162638 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162639 162686 83.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162687 162734 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 162735 162783 48.9795918367 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163000 163031 90.625 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163032 163081 24 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163735 163782 72.9166666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163783 163832 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163833 163874 69.0476190476 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163875 163911 59.4594594595 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163912 163961 48 + . Parent=NC_000866 +Merlin progressiveMauve match_part 163962 164011 46 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164012 164061 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164062 164111 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164112 164161 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164162 164211 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164212 164261 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164262 164311 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164312 164361 30 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164648 164676 72.4137931034 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164677 164726 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164727 164776 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164777 164826 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164827 164876 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164877 164926 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164927 164972 54.347826087 + . Parent=NC_000866 +Merlin progressiveMauve match_part 164973 165021 30.612244898 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165280 165325 65.2173913043 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165399 165444 60.8695652174 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165445 165494 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165495 165544 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165545 165594 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165595 165644 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165645 165694 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165695 165744 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165745 165794 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165795 165844 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165845 165894 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165895 165944 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165945 165994 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 165995 166042 89.5833333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 166043 166091 65.306122449 + . Parent=NC_000866 +Merlin progressiveMauve match_part 166092 166141 6 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167295 167333 64.1025641026 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167334 167383 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167384 167433 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167434 167483 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167484 167533 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167534 167580 63.829787234 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167581 167630 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167631 167678 66.6666666667 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167679 167728 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167729 167776 56.25 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167777 167826 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167827 167876 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167877 167926 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167927 167976 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 167977 168026 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168027 168074 58.3333333333 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168075 168124 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168125 168174 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168175 168224 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168225 168274 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168275 168324 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168325 168374 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168375 168424 84 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168425 168474 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168475 168524 82 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168525 168574 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168575 168624 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168625 168674 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 168675 168724 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169065 169092 60.7142857143 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169093 169142 74 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169143 169192 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169193 169242 60 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169243 169292 62 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169293 169342 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169343 169374 59.375 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169375 169423 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169424 169473 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169474 169523 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169524 169573 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169574 169623 54 + . Parent=NC_000866 +Merlin progressiveMauve match_part 169624 169673 40 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170000 170040 68.2926829268 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170041 170082 76.1904761905 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170083 170132 70 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170133 170182 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170183 170232 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170233 170282 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170283 170332 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170333 170382 72 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170383 170431 61.2244897959 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170432 170473 52.380952381 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170474 170523 58 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170524 170573 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170574 170623 42 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170824 170849 38.4615384615 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170850 170898 63.2653061224 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170899 170948 56 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170949 170991 67.4418604651 + . Parent=NC_000866 +Merlin progressiveMauve match_part 170992 171040 46.9387755102 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171041 171090 52 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171091 171123 69.696969697 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171124 171167 79.5454545455 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171168 171217 78 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171218 171264 57.4468085106 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171265 171314 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171315 171364 68 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171365 171414 64 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171415 171464 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171465 171514 76 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171515 171564 80 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171565 171614 66 + . Parent=NC_000866 +Merlin progressiveMauve match_part 171615 171642 53.5714285714 + . Parent=NC_000866 +###
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test.yml Thu Jun 18 12:10:51 2015 -0400 @@ -0,0 +1,54 @@ +--- + - + file: test-data/154.bam + ext: bam + label: Sequencing Data + category: "Sequencing Data" + options: + __unused__: "Not used...just to ensure options has at least one key" + auto_snp: true + bam_index: test-data/154.bam.bai + - + file: test-data/merlin.gff + ext: gff3 + label: "Gene Calls" + category: "Default" + options: + __unused__: "Not used...just to ensure options has at least one key" + match: false + - + file: test-data/154.bw + ext: bigwig + label: "Bigwig Test" + category: "Sequencing Data" + options: + __unused__: "Not used...just to ensure options has at least one key" + type: JBrowse/View/Track/Wiggle/XYPlot + variance_band: true + autoscale: local + - + file: test-data/test.vcf + ext: vcf + label: "Variant Test" + category: "Sequencing Data" + options: + __unused__: "Not used...just to ensure options has at least one key" + - + file: test-data/blast.xml + ext: blastxml + label: "BlastP Hits" + category: "Comparative Genomics" + options: + __unused__: "Not used...just to ensure options has at least one key" + parent: test-data/merlin.gff + protein: true + min_gap: 10 + match: true + - + file: test-data/xmfa.gff + ext: gff3 + label: "Progressive Mauve comparison" + category: "Comparative Genomics" + options: + __unused__: "Not used...just to ensure options has at least one key" + match: true
--- a/tool_dependencies.xml Mon May 04 17:21:38 2015 -0400 +++ b/tool_dependencies.xml Thu Jun 18 12:10:51 2015 -0400 @@ -3,4 +3,16 @@ <package name="jbrowse" version="1.11.6"> <repository changeset_revision="d5ab749c9e97" name="package_jbrowse_1_11_6" owner="iuc" toolshed="https://toolshed.g2.bx.psu.edu" /> </package> + <package name="python" version="2.7"> + <repository changeset_revision="44bb4258922f" name="package_python_2_7" owner="iuc" toolshed="https://toolshed.g2.bx.psu.edu" /> + </package> + <package name="perl" version="5.18"> + <repository changeset_revision="114b6af405fa" name="package_perl_5_18" owner="iuc" toolshed="https://toolshed.g2.bx.psu.edu" /> + </package> + <package name="samtools" version="1.2"> + <repository changeset_revision="6eea04363026" name="package_samtools_1_2" owner="iuc" toolshed="https://toolshed.g2.bx.psu.edu" /> + </package> + <package name="bundle_jbrowse" version="1.0"> + <repository changeset_revision="361f7cf7a442" name="package_perl_bundle_jbrowse_1_0" owner="iuc" toolshed="https://toolshed.g2.bx.psu.edu" /> + </package> </tool_dependency>
