diff --git a/change_log.txt b/change_log.txt index 174dea3..2c3d22c 100644 --- a/change_log.txt +++ b/change_log.txt @@ -1,5 +1,8 @@ Major changes to ClipKIT are summarized here. +2.0.0 through 2.1.0 +Introduce and refactor MSA class. Rely on Numpy functionality to accelerate processes. + 1.3.0 long description of sequences, rather than identifiers, are kept in the ClipKIT output diff --git a/clipkit/api.py b/clipkit/api.py index 1baef8c..4db0061 100644 --- a/clipkit/api.py +++ b/clipkit/api.py @@ -3,7 +3,7 @@ from .clipkit import run from .files import FileFormat -from .helpers import SeqType, write_keep_msa +from .helpers import SeqType, write_msa from .logger import logger from .modes import TrimmingMode @@ -59,5 +59,5 @@ def clipkit( if not output_file_path: return trim_run, stats else: - write_keep_msa(trim_run.keep_msa, output_file_path, trim_run.output_file_format) + write_msa(trim_run.msa, output_file_path, trim_run.output_file_format) return output_file_path, stats diff --git a/clipkit/clipkit.py b/clipkit/clipkit.py index 9fee2aa..bdb66c9 100644 --- a/clipkit/clipkit.py +++ b/clipkit/clipkit.py @@ -8,13 +8,13 @@ from Bio.Align import MultipleSeqAlignment from .args_processing import process_args from .exceptions import InvalidInputFileFormat -from .files import get_alignment_and_format, FileFormat +from .files import get_alignment_and_format, FileFormat, write_debug_log_file from .helpers import ( + create_msa, get_seq_type, get_gap_chars, - keep_trim_and_log, - write_keep_msa, - write_trim_msa, + write_msa, + write_complement, SeqType, ) from .logger import logger, log_file_logger @@ -23,16 +23,16 @@ from .parser import create_parser from .settings import DEFAULT_AA_GAP_CHARS, DEFAULT_NT_GAP_CHARS from .smart_gap_helper import smart_gap_threshold_determination -from .stats import TrimmingStats from .version import __version__ as current_version from .warnings import ( warn_if_all_sites_were_trimmed, warn_if_entry_contains_only_gaps, ) from .write import ( - write_determining_smart_gap_threshold, write_user_args, write_output_stats, + write_processing_aln, + write_output_files_message, ) from dataclasses import dataclass @@ -41,23 +41,21 @@ @dataclass class TrimRun: alignment: MultipleSeqAlignment - keep_msa: MSA - trim_msa: MSA + msa: MSA gap_characters: list sequence_type: SeqType input_file_format: FileFormat output_file_format: FileFormat - site_classification_counts: dict gaps: float version: str = current_version @property def complement(self): - return self.trim_msa.to_bio_msa() if self.trim_msa else None + return self.msa.complement_to_bio_msa() @property def trimmed(self): - return self.keep_msa.to_bio_msa() + return self.msa.to_bio_msa() def run( @@ -98,28 +96,22 @@ def run( TrimmingMode.kpi_smart_gap, TrimmingMode.kpic_smart_gap, }: - write_determining_smart_gap_threshold() - gaps = smart_gap_threshold_determination(alignment, gap_characters, quiet) + gaps = smart_gap_threshold_determination(alignment, gap_characters) - # instantiates MSAs to track what we keep/trim from the alignment - keep_msa, trim_msa, site_classification_counts = keep_trim_and_log( - alignment, gaps, mode, use_log, output_file, complement, gap_characters, quiet - ) + msa = create_msa(alignment, gap_characters) + msa.trim(mode, gap_threshold=gaps) trim_run = TrimRun( alignment, - keep_msa, - trim_msa, + msa, gap_characters, sequence_type, input_file_format, output_file_format, - site_classification_counts, gaps, ) - stats = TrimmingStats(trim_run.alignment, trim_run.keep_msa, trim_run.trim_msa) - return trim_run, stats + return trim_run, msa.stats def execute( @@ -149,6 +141,7 @@ def execute( # for reporting runtime duration to user start_time = time.time() + write_processing_aln() trim_run, stats = run( input_file, input_file_format, @@ -162,6 +155,7 @@ def execute( use_log, quiet, ) + write_output_files_message(output_file, complement, use_log) # display to user what args are being used in stdout write_user_args( @@ -178,14 +172,15 @@ def execute( ) if use_log: - warn_if_all_sites_were_trimmed(trim_run.keep_msa) - warn_if_entry_contains_only_gaps(trim_run.keep_msa, trim_run.sequence_type) + warn_if_all_sites_were_trimmed(trim_run.msa) + warn_if_entry_contains_only_gaps(trim_run.msa) + write_debug_log_file(trim_run.msa) - write_keep_msa(trim_run.keep_msa, output_file, trim_run.output_file_format) + write_msa(trim_run.msa, output_file, trim_run.output_file_format) # if the -c/--complementary argument was used, create an alignment of the trimmed sequences if complement: - write_trim_msa(trim_run.trim_msa, output_file, trim_run.output_file_format) + write_complement(trim_run.msa, output_file, trim_run.output_file_format) write_output_stats(stats, start_time) diff --git a/clipkit/files.py b/clipkit/files.py index c37038b..b88d093 100644 --- a/clipkit/files.py +++ b/clipkit/files.py @@ -1,5 +1,5 @@ from enum import Enum -import logging +from .logger import log_file_logger from Bio import AlignIO from Bio.Align import MultipleSeqAlignment @@ -7,9 +7,6 @@ from .exceptions import InvalidInputFileFormat -log = logging.getLogger(__name__) - - class FileFormat(Enum): fasta = "fasta" clustal = "clustal" @@ -47,3 +44,8 @@ def get_alignment_and_format( continue raise InvalidInputFileFormat("File could not be read") + + +def write_debug_log_file(msa): + for info in msa.generate_debug_log_info(): + log_file_logger.debug(f"{str(info[0] + 1)} {info[1]} {info[2].value} {info[3]}") diff --git a/clipkit/helpers.py b/clipkit/helpers.py index c6405ff..29ed4de 100644 --- a/clipkit/helpers.py +++ b/clipkit/helpers.py @@ -5,10 +5,10 @@ from tqdm import tqdm from .msa import MSA -from .modes import SiteClassificationType, TrimmingMode, trim +from .modes import TrimmingMode from .settings import DEFAULT_AA_GAP_CHARS, DEFAULT_NT_GAP_CHARS from .files import FileFormat -from .write import write_processing_aln, write_output_files_message +from .stats import TrimmingStats from enum import Enum @@ -38,12 +38,6 @@ def get_seq_type(alignment: MultipleSeqAlignment) -> SeqType: return sequence_type -def get_alignment_column(alignment: MultipleSeqAlignment, index: int) -> str: - alignment_column = "" - alignment_column += alignment[:, index] - return alignment_column.upper() - - def get_gap_chars(seq_type: SeqType) -> list[str]: if seq_type == SeqType.nt: return DEFAULT_NT_GAP_CHARS @@ -51,89 +45,18 @@ def get_gap_chars(seq_type: SeqType) -> list[str]: return DEFAULT_AA_GAP_CHARS -def report_column_features( - alignment: MultipleSeqAlignment, index: int, gap_chars: list -) -> tuple[str, float]: - """ - Count the occurence of each character at a given position - in an alignment. This information is used to determine - if the alignment is parsimony informative or not. When - counting characters, gaps are excluded. - """ - alignment_column = get_alignment_column(alignment, index) - - column_length = len(alignment_column) - - number_of_gaps = sum([alignment_column.count(char) for char in gap_chars]) - gappyness = number_of_gaps / column_length - - return alignment_column, gappyness - - -def count_characters_at_position(alignment_column: str, gap_chars: list) -> dict: - character_counts = {} - - alignment_column = remove_gaps(alignment_column, gap_chars) - for char in set(alignment_column): - character_counts[char] = alignment_column.count(char) - return character_counts - - -def determine_site_classification_type( - character_counts: dict, -) -> SiteClassificationType: - """ - Determines if a site is parsimony informative or constant. - A site is parsimony-informative if it contains at least two types of nucleotides - (or amino acids), and at least two of them occur with a minimum frequency of two. - https://www.megasoftware.net/web_help_7/rh_parsimony_informative_site.htm - - A site is constant if it contains only one character and that character occurs - at least twice. https://www.megasoftware.net/web_help_7/rh_constant_site.htm - - A singleton is a site that contains at least two types of characters with, at most, - one occuring multiple times. https://www.megasoftware.net/web_help_7/rh_singleton_sites.htm - """ - parsimony_informative_threshold = 2 - counts_gte_threshold = 0 - - for count in character_counts.values(): - if count >= 2: - counts_gte_threshold += 1 - if counts_gte_threshold >= parsimony_informative_threshold: - return SiteClassificationType.parsimony_informative - - if counts_gte_threshold == 1 and len(character_counts) == 1: - return SiteClassificationType.constant - elif counts_gte_threshold == 1 and len(character_counts) > 1: - return SiteClassificationType.singleton - - return SiteClassificationType.other - - -def create_keep_and_trim_msas( - alignment: MultipleSeqAlignment, complement: bool -) -> tuple[MSA, MSA]: +def create_msa(alignment: MultipleSeqAlignment, gap_chars: list[str] = None) -> MSA: """ - Creates MSA classes to track sites kept and trimmed + Create MSA class """ + return MSA.from_bio_msa(alignment, gap_chars) - keep_msa = MSA.from_bio_msa(alignment) - if complement: - trim_msa = MSA.from_bio_msa(alignment) - else: - trim_msa = None - - return keep_msa, trim_msa - -def write_keep_msa( - keep_msa: MSA, out_file_name: str, out_file_format: FileFormat -) -> None: +def write_msa(msa: MSA, out_file_name: str, out_file_format: FileFormat) -> None: """ - keep_msa is populated with sites that are kept after trimming is finished + msa is populated with sites that are kept after trimming is finished """ - output_msa = keep_msa.to_bio_msa() + output_msa = msa.to_bio_msa() if out_file_format.value == "phylip_relaxed": SeqIO.write(output_msa, out_file_name, "phylip-relaxed") elif out_file_format.value == "phylip_sequential": @@ -142,65 +65,14 @@ def write_keep_msa( SeqIO.write(output_msa, out_file_name, out_file_format.value) -def write_trim_msa(trim_msa: MSA, out_file: str, out_file_format: FileFormat) -> None: +def write_complement(msa: MSA, out_file: str, out_file_format: FileFormat) -> None: """ - trim_msa is populated with sites that are trimmed after trimming is finished + msa is populated with sites that are trimmed after trimming is finished """ - output_msa = trim_msa.to_bio_msa() + output_msa = msa.complement_to_bio_msa() completmentOut = str(out_file) + ".complement" if out_file_format.value == "phylip_relaxed": SeqIO.write(output_msa, out_file, "phylip-relaxed") elif out_file_format.value == "phylip_sequential": SeqIO.write(output_msa, out_file, "phylip-sequential") SeqIO.write(output_msa, completmentOut, out_file_format.value) - - -def keep_trim_and_log( - alignment: MultipleSeqAlignment, - gaps: float, - mode: TrimmingMode, - use_log: bool, - out_file_name: str, - complement: bool, - gap_chars: list, - quiet: bool, -) -> tuple[MSA, MSA]: - """ - Determines positions to keep or trim and saves these positions on the MSA classes. - """ - # initialize MSA classes - keep_msa, trim_msa = create_keep_and_trim_msas(alignment, complement) - - alignment_length = alignment.get_alignment_length() - - site_classification_counts = dict() - site_classification_counts[SiteClassificationType.parsimony_informative] = 0 - site_classification_counts[SiteClassificationType.constant] = 0 - site_classification_counts[SiteClassificationType.singleton] = 0 - site_classification_counts[SiteClassificationType.other] = 0 - - write_processing_aln() - for i in tqdm(range(alignment_length), disable=quiet, postfix="trimmer"): - sequence_at_index, gappyness = report_column_features(alignment, i, gap_chars) - - character_counts = count_characters_at_position(sequence_at_index, gap_chars) - - # determine if a site is parsimony informative, singleton, or constant - site_classification_type = determine_site_classification_type(character_counts) - - keep_msa, trim_msa = trim( - gappyness, - site_classification_type, - site_classification_counts, - keep_msa, - trim_msa, - i, - gaps, - alignment, - mode, - use_log, - ) - - # inform user that output files are being written - write_output_files_message(out_file_name, complement, use_log) - return keep_msa, trim_msa, site_classification_counts diff --git a/clipkit/modes.py b/clipkit/modes.py index 3606498..e4001a2 100644 --- a/clipkit/modes.py +++ b/clipkit/modes.py @@ -7,13 +7,6 @@ from .msa import MSA -class SiteClassificationType(Enum): - parsimony_informative = "parsimony-informative" - constant = "constant" - singleton = "singleton" - other = "other" - - class TrimmingMode(Enum): gappy = "gappy" smart_gap = "smart-gap" @@ -23,80 +16,3 @@ class TrimmingMode(Enum): kpic = "kpic" kpic_gappy = "kpic-gappy" kpic_smart_gap = "kpic-smart-gap" - - -def should_keep_site( - mode: TrimmingMode, - site_classification_type: "SiteClassificationType", - gappyness: float, - gaps: float, -) -> bool: - if mode == TrimmingMode.kpi_gappy: - return ( - gappyness <= gaps - and site_classification_type == SiteClassificationType.parsimony_informative - ) - elif mode == TrimmingMode.gappy: - return gappyness <= gaps - elif mode == TrimmingMode.kpi: - return site_classification_type == SiteClassificationType.parsimony_informative - elif mode == TrimmingMode.kpic: - return ( - site_classification_type == SiteClassificationType.parsimony_informative - or site_classification_type == SiteClassificationType.constant - ) - elif mode == TrimmingMode.kpic_gappy: - return gappyness <= gaps and ( - site_classification_type == SiteClassificationType.parsimony_informative - or site_classification_type == SiteClassificationType.constant - ) - elif mode == TrimmingMode.smart_gap: - return round(gappyness, 4) < gaps - elif mode == TrimmingMode.kpic_smart_gap: - return round(gappyness, 4) < gaps and ( - site_classification_type == SiteClassificationType.parsimony_informative - or site_classification_type == SiteClassificationType.constant - ) - elif mode == TrimmingMode.kpi_smart_gap: - return ( - round(gappyness, 4) < gaps - and site_classification_type == SiteClassificationType.parsimony_informative - ) - - -def trim( - gappyness: float, - site_classification_type: "SiteClassificationType", - site_classification_counts: dict, - keep_msa: "MSA", - trim_msa: "MSA", - alignment_position: int, - gaps: float, - alignment: "MultipleSeqAlignment", - mode: TrimmingMode, - use_log: bool, -) -> tuple["MSA", "MSA"]: - if should_keep_site(mode, site_classification_type, gappyness, gaps): - site_classification_counts[site_classification_type] += 1 - for entry in alignment: - new_value = entry.seq._data[alignment_position : alignment_position + 1] - keep_msa.set_entry_sequence_at_position( - entry.description, alignment_position, new_value - ) - if use_log: - log_file_logger.debug( - f"{str(alignment_position + 1)} keep {site_classification_type.value} {gappyness}" - ) - else: - if trim_msa is not None: - for entry in alignment: - new_value = entry.seq._data[alignment_position : alignment_position + 1] - trim_msa.set_entry_sequence_at_position( - entry.description, alignment_position, new_value - ) - if use_log: - log_file_logger.debug( - f"{str(alignment_position + 1)} trim {site_classification_type.value} {gappyness}" - ) - - return keep_msa, trim_msa diff --git a/clipkit/msa.py b/clipkit/msa.py index e63d638..a72beec 100644 --- a/clipkit/msa.py +++ b/clipkit/msa.py @@ -4,75 +4,210 @@ import numpy as np from typing import Union +from .modes import TrimmingMode +from .site_classification import ( + SiteClassificationType, + determine_site_classification_type, +) from .settings import DEFAULT_AA_GAP_CHARS +from .stats import TrimmingStats class MSA: - def __init__(self, entries: list[str], starting_length: int) -> None: - self.starting_length = starting_length - self.entries = entries - self._data = self._init_data() - self._joined = None + def __init__( + self, header_info, seq_records, gap_chars=DEFAULT_AA_GAP_CHARS + ) -> None: + self.header_info = header_info + self.seq_records = seq_records + self._original_length = len(self.seq_records[0]) + self._site_positions_to_keep = np.arange(self._original_length) + self._site_positions_to_trim = np.array([]) + self._site_classification_types = None + self._column_character_frequencies = None + self._gap_chars = gap_chars + + @staticmethod + def from_bio_msa(alignment: MultipleSeqAlignment, gap_chars=None) -> "MSA": + header_info = [ + {"id": rec.id, "name": rec.name, "description": rec.description} + for rec in alignment + ] + seq_records = np.array([list(rec) for rec in alignment]) + return MSA(header_info, seq_records, gap_chars) + + def to_bio_msa(self) -> MultipleSeqAlignment: + return self._to_bio_msa(self.sites_kept) - def _init_data(self) -> dict[str, np.array]: - data = {} - for entry in self.entries: - data[entry] = np.zeros([self.starting_length], dtype=bytes) - return data + def complement_to_bio_msa(self) -> MultipleSeqAlignment: + return self._to_bio_msa(self.sites_trimmed) - def _reset_joined(self) -> None: - self._joined = None + def _to_bio_msa(self, sites) -> MultipleSeqAlignment: + # NOTE: we use the description as the id to preserve the full sequence description - see issue #20 + return MultipleSeqAlignment( + [ + SeqRecord( + Seq("".join(rec)), id=str(info["description"]), description="" + ) + for rec, info in zip(sites.tolist(), self.header_info) + ] + ) + + @property + def trimmed(self): + if len(self._site_positions_to_trim) == 0: + return self.seq_records + return np.delete(self.seq_records, self._site_positions_to_trim, axis=1) + + @property + def sites_kept(self): + return np.take(self.seq_records, self._site_positions_to_keep, axis=1) + + @property + def sites_trimmed(self): + return np.take(self.seq_records, self._site_positions_to_trim, axis=1) @property def length(self) -> int: - return np.count_nonzero(next(iter(self._data.values()))) + return len(self._site_positions_to_keep) + + @property + def original_length(self): + return self._original_length + + @property + def gap_chars(self): + return self._gap_chars + + @property + def site_gappyness(self) -> np.floating: + site_gappyness = (np.isin(self.seq_records, self._gap_chars)).mean(axis=0) + return np.around(site_gappyness, decimals=4) @property def is_empty(self) -> bool: - all_zeros = np.all(self._data[self.entries[0]] == b"") + all_zeros = np.all(self.sites_kept[0] == "") return all_zeros @property - def string_sequences(self) -> dict[str, str]: - if self._joined: - return self._joined - else: - joined = {} - for entry, sequence in self._data.items(): - joined[entry] = "".join(np.char.decode(sequence)) - self._joined = joined - return self._joined + def stats(self) -> TrimmingStats: + return TrimmingStats(self) - @staticmethod - def from_bio_msa(alignment: MultipleSeqAlignment) -> "MSA": - entries = [entry.description for entry in alignment] - length = alignment.get_alignment_length() - return MSA(entries, length) + def is_any_entry_sequence_only_gaps(self) -> tuple[bool, Union[str, None]]: + for idx, row in enumerate(self.trimmed): + if np.all(row == row[0]) and ( # all values the same + row[0] in self.gap_chars + ): + return True, self.header_info[idx].get("id") + return False, None - def to_bio_msa(self) -> MultipleSeqAlignment: - seqList = [] - for entry, joined in self.string_sequences.items(): - seqList.append(SeqRecord(Seq(str(joined)), id=str(entry), description="")) - return MultipleSeqAlignment(seqList) + def trim( + self, + mode: TrimmingMode, + gap_threshold=None, + ) -> np.array: + self._site_positions_to_trim = self.determine_site_positions_to_trim( + mode, gap_threshold + ) + self._site_positions_to_keep = np.delete( + np.arange(self._original_length), self._site_positions_to_trim + ) - def set_entry_sequence_at_position( - self, entry: str, position: int, value: str - ) -> None: - self._data[entry][position] = value - - # since we've mutated the sequence data we need to release our cached _joined - self._reset_joined() - - def is_any_entry_sequence_only_gaps( - self, gap_chars=DEFAULT_AA_GAP_CHARS - ) -> tuple[bool, Union[str, None]]: - for entry, sequence in self._data.items(): - first_sequence_value = sequence[0] - sequence_values_all_same = np.all(sequence == first_sequence_value) - if ( - sequence_values_all_same - and first_sequence_value.decode("utf-8") in gap_chars - ): - return True, entry + @property + def column_character_frequencies(self): + if self._column_character_frequencies is not None: + return self._column_character_frequencies - return False, None + column_character_frequencies = [] + for column in self.seq_records.T: + col_sorted_unique_values_for, col_counts_per_char = np.unique( + [char.upper() for char in column], return_counts=True + ) + freqs = dict(zip(col_sorted_unique_values_for, col_counts_per_char)) + for gap_char in self.gap_chars: + try: + del freqs[gap_char] + except KeyError: + continue + column_character_frequencies.append(freqs) + self._column_character_frequencies = column_character_frequencies + return self._column_character_frequencies + + @property + def site_classification_types(self): + if self._site_classification_types is not None: + return self._site_classification_types + + site_classification_types = np.array( + [ + determine_site_classification_type(col_char_freq) + for col_char_freq in self.column_character_frequencies + ] + ) + self._site_classification_types = site_classification_types + return self._site_classification_types + + def determine_site_positions_to_trim(self, mode, gap_threshold): + if mode in (TrimmingMode.gappy, TrimmingMode.smart_gap): + sites_to_trim = np.where(self.site_gappyness >= gap_threshold)[0] + elif mode == TrimmingMode.kpi: + col_char_freqs = self.column_character_frequencies + site_classification_types = self.site_classification_types + sites_to_trim = np.where( + site_classification_types + != SiteClassificationType.parsimony_informative + )[0] + elif mode in (TrimmingMode.kpi_gappy, TrimmingMode.kpi_smart_gap): + sites_to_trim_gaps_based = np.where(self.site_gappyness > gap_threshold)[0] + col_char_freqs = self.column_character_frequencies + site_classification_types = self.site_classification_types + sites_to_trim_classification_based = np.where( + site_classification_types + != SiteClassificationType.parsimony_informative + )[0] + sites_to_trim = np.unique( + np.concatenate( + (sites_to_trim_gaps_based, sites_to_trim_classification_based) + ) + ) + elif mode == TrimmingMode.kpic: + col_char_freqs = self.column_character_frequencies + site_classification_types = self.site_classification_types + sites_to_trim = np.where( + (site_classification_types == SiteClassificationType.other) + | (site_classification_types == SiteClassificationType.singleton) + )[0] + elif mode in (TrimmingMode.kpic_gappy, TrimmingMode.kpic_smart_gap): + sites_to_trim_gaps_based = np.where(self.site_gappyness >= gap_threshold)[0] + + col_char_freqs = self.column_character_frequencies + site_classification_types = self.site_classification_types + sites_to_trim_classification_based = np.where( + (site_classification_types == SiteClassificationType.other) + | (site_classification_types == SiteClassificationType.singleton) + )[0] + + sites_to_trim = np.unique( + np.concatenate( + (sites_to_trim_gaps_based, sites_to_trim_classification_based) + ) + ) + + return sites_to_trim + + def generate_debug_log_info(self): + """ + Returns tuples of site position, keep or trim, site classification type, and gappyness + """ + keep_or_trim_lookup = {} + for keep_idx in self._site_positions_to_keep: + keep_or_trim_lookup[keep_idx] = "keep" + for trim_idx in self._site_positions_to_trim: + keep_or_trim_lookup[trim_idx] = "trim" + + for idx, gappyness in enumerate(self.site_gappyness): + yield ( + idx, + keep_or_trim_lookup[idx], + self.site_classification_types[idx], + gappyness, + ) diff --git a/clipkit/site_classification.py b/clipkit/site_classification.py new file mode 100644 index 0000000..eeb3073 --- /dev/null +++ b/clipkit/site_classification.py @@ -0,0 +1,40 @@ +from enum import Enum + + +class SiteClassificationType(Enum): + parsimony_informative = "parsimony-informative" + constant = "constant" + singleton = "singleton" + other = "other" + + +def determine_site_classification_type( + character_counts: dict, +) -> SiteClassificationType: + """ + Determines if a site is parsimony informative or constant. + A site is parsimony-informative if it contains at least two types of nucleotides + (or amino acids), and at least two of them occur with a minimum frequency of two. + https://www.megasoftware.net/web_help_7/rh_parsimony_informative_site.htm + + A site is constant if it contains only one character and that character occurs + at least twice. https://www.megasoftware.net/web_help_7/rh_constant_site.htm + + A singleton is a site that contains at least two types of characters with, at most, + one occuring multiple times. https://www.megasoftware.net/web_help_7/rh_singleton_sites.htm + """ + parsimony_informative_threshold = 2 + counts_gte_threshold = 0 + + for count in character_counts.values(): + if count >= 2: + counts_gte_threshold += 1 + if counts_gte_threshold >= parsimony_informative_threshold: + return SiteClassificationType.parsimony_informative + + if counts_gte_threshold == 1 and len(character_counts) == 1: + return SiteClassificationType.constant + elif counts_gte_threshold == 1 and len(character_counts) > 1: + return SiteClassificationType.singleton + + return SiteClassificationType.other diff --git a/clipkit/smart_gap_helper.py b/clipkit/smart_gap_helper.py index 25c6f11..8a8a4f4 100644 --- a/clipkit/smart_gap_helper.py +++ b/clipkit/smart_gap_helper.py @@ -4,17 +4,16 @@ import numpy as np from tqdm import tqdm -from .helpers import report_column_features from .logger import logger def smart_gap_threshold_determination( - alignment: MultipleSeqAlignment, gap_chars: list, quiet: bool + alignment: MultipleSeqAlignment, gap_chars: list ) -> float: alignment_length = alignment.get_alignment_length() # get distribution of gaps rounded to the fourth decimal place - gaps_dist = get_gaps_distribution(alignment, alignment_length, gap_chars, quiet) + gaps_dist = get_gaps_distribution(alignment, gap_chars) # count freq of gaps and convert to sorted np array gaps_arr = count_and_sort_gaps(gaps_dist) @@ -57,15 +56,12 @@ def gap_to_gap_slope(gaps_arr: np.array, alignment_length: int) -> list[float]: def get_gaps_distribution( - alignment: MultipleSeqAlignment, alignment_length: int, gap_chars: list, quiet: bool + alignment: MultipleSeqAlignment, gap_chars: list ) -> list[float]: - gaps_dist = [] - for i in tqdm(range(0, alignment_length), disable=quiet, postfix="smart-gap"): - _, gappyness = report_column_features(alignment, i, gap_chars) - gappyness = round(gappyness, 4) - gaps_dist.append(gappyness) + msa_array = np.array([list(rec) for rec in alignment]) + gaps_dist = (np.isin(msa_array, gap_chars)).mean(axis=0) - return gaps_dist + return np.round(gaps_dist, decimals=4).tolist() def count_and_sort_gaps(gaps_dist: list) -> list: diff --git a/clipkit/stats.py b/clipkit/stats.py index 7cb05d6..5d7ae8b 100644 --- a/clipkit/stats.py +++ b/clipkit/stats.py @@ -1,23 +1,23 @@ from dataclasses import dataclass +from typing import TYPE_CHECKING from Bio.Align import MultipleSeqAlignment -from .msa import MSA +if TYPE_CHECKING: + from .msa import MSA @dataclass class TrimmingStats: - alignment: MultipleSeqAlignment - keep_msa: MSA - trim_msa: MSA + msa: "MSA" @property def alignment_length(self) -> int: - return self.alignment.get_alignment_length() + return self.msa.original_length @property def output_length(self) -> int: - return self.keep_msa.length + return self.msa.length @property def trimmed_length(self) -> int: diff --git a/clipkit/version.py b/clipkit/version.py index 159d48b..9aa3f90 100644 --- a/clipkit/version.py +++ b/clipkit/version.py @@ -1 +1 @@ -__version__ = "2.0.1" +__version__ = "2.1.0" diff --git a/clipkit/warnings.py b/clipkit/warnings.py index 92eba1a..0f669e0 100644 --- a/clipkit/warnings.py +++ b/clipkit/warnings.py @@ -12,18 +12,14 @@ logger = logging.getLogger(__name__) -def warn_if_all_sites_were_trimmed(keep_msa: "MSA") -> None: - if keep_msa.is_empty: +def warn_if_all_sites_were_trimmed(msa: "MSA") -> None: + if msa.is_empty: logger.warning( "WARNING: All sites trimmed from alignment. Please use different parameters." ) -def warn_if_entry_contains_only_gaps(keep_msa: "MSA", sequence_type: SeqType) -> None: - if sequence_type == SeqType.aa: - gap_chars = DEFAULT_AA_GAP_CHARS - else: - gap_chars = DEFAULT_NT_GAP_CHARS - should_warn, entry = keep_msa.is_any_entry_sequence_only_gaps(gap_chars) +def warn_if_entry_contains_only_gaps(msa: "MSA") -> None: + should_warn, entry = msa.is_any_entry_sequence_only_gaps() if should_warn: logger.warning(f"WARNING: header id '{entry}' contains only gaps") diff --git a/clipkit/write.py b/clipkit/write.py index 2f9475f..0173311 100644 --- a/clipkit/write.py +++ b/clipkit/write.py @@ -105,18 +105,3 @@ def write_output_stats(stats: "TrimmingStats", start_time: float) -> None: """ ) ) - - -def write_determining_smart_gap_threshold() -> None: - """ - Function to inform using that the smart-gap threshold is being determined - """ - logger.info( - textwrap.dedent( - """\ - ----------------------------------- - | Determining smart-gap threshold | - ----------------------------------- - """ - ) - ) diff --git a/eg b/eg deleted file mode 100644 index 2a39c28..0000000 --- a/eg +++ /dev/null @@ -1,10 +0,0 @@ ->1 -AGAT ->2 -AGAT ->3 -AGTA ->4 -AATA ->5 -AaT- diff --git a/eg.log b/eg.log deleted file mode 100644 index 8a37254..0000000 --- a/eg.log +++ /dev/null @@ -1,1026 +0,0 @@ -1 trim constant 0.0 -2 trim constant 0.0 -3 keep parsimony-informative 0.0 -4 trim constant 0.0 -5 trim constant 0.0 -6 trim singleton 0.0 -7 trim constant 0.0 -8 trim constant 0.0 -9 trim constant 0.0 -10 trim constant 0.0 -11 keep parsimony-informative 0.0 -12 trim singleton 0.0 -13 keep parsimony-informative 0.0 -14 trim constant 0.0 -15 keep parsimony-informative 0.0 -16 keep parsimony-informative 0.0 -17 keep parsimony-informative 0.0 -18 trim constant 0.0 -19 keep parsimony-informative 0.0 -20 keep parsimony-informative 0.0 -21 keep parsimony-informative 0.0 -22 trim constant 0.0 -23 keep parsimony-informative 0.0 -24 trim constant 0.0 -25 keep parsimony-informative 0.0 -26 trim singleton 0.0 -27 trim constant 0.0 -28 keep parsimony-informative 0.0 -29 trim singleton 0.0 -30 trim constant 0.0 -31 trim constant 0.0 -32 trim constant 0.0 -33 trim singleton 0.0 -34 keep parsimony-informative 0.0 -35 keep parsimony-informative 0.0 -36 keep parsimony-informative 0.0 -37 keep parsimony-informative 0.0 -38 trim constant 0.0 -39 keep parsimony-informative 0.0 -40 keep parsimony-informative 0.0 -41 trim singleton 0.0 -42 keep parsimony-informative 0.0 -43 keep parsimony-informative 0.0 -44 keep parsimony-informative 0.0 -45 trim singleton 0.0 -46 trim constant 0.0 -47 keep parsimony-informative 0.0 -48 keep parsimony-informative 0.0 -49 trim constant 0.0 -50 keep parsimony-informative 0.0 -51 keep parsimony-informative 0.0 -52 keep parsimony-informative 0.0 -53 keep parsimony-informative 0.0 -54 trim constant 0.0 -55 trim constant 0.0 -56 keep parsimony-informative 0.0 -57 trim singleton 0.0 -58 trim constant 0.0 -59 keep parsimony-informative 0.0 -60 keep parsimony-informative 0.0 -61 trim constant 0.0 -62 trim singleton 0.0 -63 trim constant 0.0 -64 trim singleton 0.0 -65 trim constant 0.0 -66 trim constant 0.0 -67 keep parsimony-informative 0.0 -68 keep parsimony-informative 0.0 -69 trim singleton 0.0 -70 keep parsimony-informative 0.05982905982905983 -71 trim other 0.9829059829059829 -72 keep parsimony-informative 0.05982905982905983 -73 trim other 0.9914529914529915 -74 trim parsimony-informative 0.9401709401709402 -75 keep parsimony-informative 0.08547008547008547 -76 trim constant 0.9829059829059829 -77 keep parsimony-informative 0.03418803418803419 -78 trim singleton 0.02564102564102564 -79 trim singleton 0.02564102564102564 -80 trim singleton 0.07692307692307693 -81 trim constant 0.11965811965811966 -82 trim singleton 0.8803418803418803 -83 trim parsimony-informative 0.8803418803418803 -84 keep parsimony-informative 0.0 -85 keep parsimony-informative 0.0 -86 keep parsimony-informative 0.0 -87 keep parsimony-informative 0.0 -88 keep parsimony-informative 0.0 -89 keep parsimony-informative 0.017094017094017096 -90 keep parsimony-informative 0.0 -91 keep parsimony-informative 0.0 -92 keep parsimony-informative 0.0 -93 trim constant 0.7521367521367521 -94 keep parsimony-informative 0.0 -95 trim constant 0.0 -96 keep parsimony-informative 0.0 -97 keep parsimony-informative 0.02564102564102564 -98 trim parsimony-informative 0.9487179487179487 -99 trim constant 0.9487179487179487 -100 trim singleton 0.9487179487179487 -101 keep parsimony-informative 0.0 -102 trim constant 0.0 -103 trim constant 0.0 -104 keep parsimony-informative 0.0 -105 keep parsimony-informative 0.8376068376068376 -106 keep parsimony-informative 0.008547008547008548 -107 trim constant 0.0 -108 trim constant 0.0 -109 keep parsimony-informative 0.0 -110 keep parsimony-informative 0.0 -111 keep parsimony-informative 0.0 -112 keep parsimony-informative 0.0 -113 keep parsimony-informative 0.0 -114 keep parsimony-informative 0.0 -115 keep parsimony-informative 0.0 -116 trim constant 0.9487179487179487 -117 trim other 0.9914529914529915 -118 trim other 0.9914529914529915 -119 trim other 0.9914529914529915 -120 trim other 0.9914529914529915 -121 trim constant 0.9487179487179487 -122 trim singleton 0.9487179487179487 -123 trim other 0.9914529914529915 -124 trim other 0.9914529914529915 -125 trim other 0.9914529914529915 -126 trim other 0.9914529914529915 -127 trim other 0.9914529914529915 -128 trim other 0.9914529914529915 -129 trim other 0.9914529914529915 -130 trim other 0.9914529914529915 -131 trim other 0.9914529914529915 -132 trim other 0.9914529914529915 -133 trim other 0.9914529914529915 -134 trim other 0.9914529914529915 -135 trim other 0.9914529914529915 -136 trim other 0.9914529914529915 -137 trim other 0.9914529914529915 -138 trim other 0.9914529914529915 -139 trim other 0.9914529914529915 -140 trim other 0.9914529914529915 -141 trim other 0.9914529914529915 -142 trim other 0.9914529914529915 -143 trim other 0.9914529914529915 -144 trim other 0.9914529914529915 -145 trim other 0.9914529914529915 -146 trim other 0.9914529914529915 -147 trim other 0.9914529914529915 -148 trim other 0.9914529914529915 -149 trim other 0.9914529914529915 -150 trim other 0.9914529914529915 -151 trim other 0.9914529914529915 -152 trim other 0.9914529914529915 -153 trim other 0.9914529914529915 -154 trim other 0.9914529914529915 -155 trim other 0.9914529914529915 -156 trim other 0.9914529914529915 -157 trim other 0.9914529914529915 -158 trim other 0.9914529914529915 -159 trim other 0.9914529914529915 -160 trim other 0.9914529914529915 -161 trim other 0.9914529914529915 -162 trim other 0.9914529914529915 -163 trim other 0.9914529914529915 -164 trim other 0.9914529914529915 -165 trim other 0.9914529914529915 -166 trim other 0.9914529914529915 -167 trim other 0.9914529914529915 -168 trim other 0.9914529914529915 -169 trim other 0.9914529914529915 -170 trim other 0.9914529914529915 -171 trim other 0.9914529914529915 -172 trim other 0.9914529914529915 -173 trim other 0.9914529914529915 -174 trim other 0.9914529914529915 -175 trim other 0.9914529914529915 -176 trim other 0.9914529914529915 -177 trim other 0.9914529914529915 -178 trim other 0.9914529914529915 -179 trim other 0.9914529914529915 -180 trim other 0.9914529914529915 -181 trim other 0.9914529914529915 -182 trim other 0.9914529914529915 -183 trim other 0.9914529914529915 -184 trim other 0.9914529914529915 -185 trim other 0.9914529914529915 -186 trim other 0.9914529914529915 -187 trim other 0.9914529914529915 -188 trim other 0.9914529914529915 -189 trim other 0.9914529914529915 -190 trim other 0.9914529914529915 -191 trim other 0.9914529914529915 -192 trim other 0.9914529914529915 -193 trim other 0.9914529914529915 -194 trim other 0.9914529914529915 -195 trim other 0.9914529914529915 -196 trim other 0.9914529914529915 -197 trim other 0.9914529914529915 -198 trim other 0.9914529914529915 -199 trim other 0.9914529914529915 -200 trim other 0.9914529914529915 -201 trim other 0.9914529914529915 -202 trim other 0.9914529914529915 -203 trim singleton 0.9487179487179487 -204 keep parsimony-informative 0.0 -205 keep parsimony-informative 0.0 -206 trim constant 0.8461538461538461 -207 trim constant 0.8461538461538461 -208 trim constant 0.8034188034188035 -209 trim constant 0.8034188034188035 -210 trim constant 0.8034188034188035 -211 trim constant 0.8034188034188035 -212 keep parsimony-informative 0.7948717948717948 -213 keep parsimony-informative 0.7606837606837606 -214 keep parsimony-informative 0.7606837606837606 -215 trim constant 0.7692307692307693 -216 trim constant 0.7692307692307693 -217 trim constant 0.7692307692307693 -218 trim constant 0.7692307692307693 -219 trim constant 0.9829059829059829 -220 trim constant 0.7692307692307693 -221 trim constant 0.7692307692307693 -222 trim constant 0.7692307692307693 -223 trim constant 0.7692307692307693 -224 trim constant 0.7692307692307693 -225 trim constant 0.7692307692307693 -226 trim constant 0.7692307692307693 -227 trim constant 0.7692307692307693 -228 trim constant 0.7692307692307693 -229 trim constant 0.7692307692307693 -230 trim constant 0.7692307692307693 -231 trim constant 0.7692307692307693 -232 trim constant 0.7692307692307693 -233 trim constant 0.7692307692307693 -234 trim singleton 0.7606837606837606 -235 trim constant 0.7606837606837606 -236 trim constant 0.7692307692307693 -237 trim constant 0.7692307692307693 -238 trim constant 0.7692307692307693 -239 trim constant 0.7692307692307693 -240 trim constant 0.7606837606837606 -241 trim singleton 0.7606837606837606 -242 trim singleton 0.7606837606837606 -243 trim constant 0.7606837606837606 -244 trim constant 0.7606837606837606 -245 trim constant 0.7692307692307693 -246 trim constant 0.7692307692307693 -247 trim constant 0.7692307692307693 -248 trim constant 0.7692307692307693 -249 trim constant 0.7692307692307693 -250 trim constant 0.7692307692307693 -251 trim constant 0.7692307692307693 -252 trim constant 0.7606837606837606 -253 trim singleton 0.7606837606837606 -254 trim constant 0.7692307692307693 -255 trim constant 0.7692307692307693 -256 trim constant 0.7692307692307693 -257 trim constant 0.7692307692307693 -258 trim constant 0.7692307692307693 -259 trim constant 0.7692307692307693 -260 trim constant 0.7692307692307693 -261 trim constant 0.7692307692307693 -262 trim constant 0.7692307692307693 -263 trim constant 0.7692307692307693 -264 trim constant 0.7692307692307693 -265 trim constant 0.7692307692307693 -266 trim constant 0.7692307692307693 -267 trim constant 0.7692307692307693 -268 trim constant 0.7692307692307693 -269 trim constant 0.7692307692307693 -270 trim singleton 0.7521367521367521 -271 trim singleton 0.7521367521367521 -272 trim singleton 0.7521367521367521 -273 trim constant 0.7521367521367521 -274 trim constant 0.7692307692307693 -275 trim constant 0.7692307692307693 -276 trim constant 0.7692307692307693 -277 trim constant 0.7606837606837606 -278 trim constant 0.7606837606837606 -279 trim singleton 0.7606837606837606 -280 trim singleton 0.7606837606837606 -281 trim singleton 0.7606837606837606 -282 trim singleton 0.7606837606837606 -283 trim constant 0.7606837606837606 -284 trim constant 0.7692307692307693 -285 trim constant 0.7692307692307693 -286 trim constant 0.7692307692307693 -287 trim constant 0.7692307692307693 -288 trim constant 0.7692307692307693 -289 trim constant 0.7692307692307693 -290 trim constant 0.7692307692307693 -291 trim constant 0.7692307692307693 -292 trim constant 0.7692307692307693 -293 trim constant 0.7692307692307693 -294 trim constant 0.7692307692307693 -295 trim constant 0.7692307692307693 -296 trim constant 0.7692307692307693 -297 trim constant 0.7692307692307693 -298 trim constant 0.7692307692307693 -299 trim constant 0.7692307692307693 -300 trim constant 0.7692307692307693 -301 trim constant 0.7692307692307693 -302 trim constant 0.7692307692307693 -303 trim constant 0.7692307692307693 -304 trim constant 0.7692307692307693 -305 trim constant 0.7692307692307693 -306 trim constant 0.7692307692307693 -307 trim constant 0.7692307692307693 -308 trim constant 0.7692307692307693 -309 trim constant 0.7692307692307693 -310 trim constant 0.7692307692307693 -311 keep parsimony-informative 0.6666666666666666 -312 keep parsimony-informative 0.6666666666666666 -313 keep parsimony-informative 0.6666666666666666 -314 trim constant 0.6666666666666666 -315 keep parsimony-informative 0.6666666666666666 -316 trim constant 0.7692307692307693 -317 trim constant 0.7692307692307693 -318 trim constant 0.7692307692307693 -319 trim constant 0.7692307692307693 -320 trim constant 0.7692307692307693 -321 trim constant 0.7692307692307693 -322 trim constant 0.7692307692307693 -323 trim constant 0.7692307692307693 -324 trim constant 0.7692307692307693 -325 trim constant 0.7692307692307693 -326 trim constant 0.7692307692307693 -327 trim constant 0.7692307692307693 -328 trim constant 0.7692307692307693 -329 trim constant 0.7692307692307693 -330 trim constant 0.7692307692307693 -331 trim constant 0.7692307692307693 -332 trim constant 0.7606837606837606 -333 trim constant 0.7606837606837606 -334 trim constant 0.7692307692307693 -335 trim constant 0.7692307692307693 -336 trim constant 0.7692307692307693 -337 trim constant 0.7692307692307693 -338 trim constant 0.7692307692307693 -339 trim constant 0.7692307692307693 -340 trim constant 0.7692307692307693 -341 trim constant 0.7692307692307693 -342 trim constant 0.7692307692307693 -343 trim singleton 0.7692307692307693 -344 trim singleton 0.7606837606837606 -345 trim constant 0.7692307692307693 -346 trim singleton 0.7692307692307693 -347 trim singleton 0.7692307692307693 -348 trim constant 0.7692307692307693 -349 trim constant 0.8205128205128205 -350 trim constant 0.8205128205128205 -351 trim constant 0.8376068376068376 -352 trim constant 0.8376068376068376 -353 trim constant 0.8376068376068376 -354 trim constant 0.8376068376068376 -355 trim constant 0.8376068376068376 -356 trim constant 0.8376068376068376 -357 trim constant 0.8717948717948718 -358 trim constant 0.8717948717948718 -359 trim constant 0.8717948717948718 -360 trim constant 0.8717948717948718 -361 trim constant 0.8717948717948718 -362 trim singleton 0.8803418803418803 -363 trim constant 0.9487179487179487 -364 trim constant 0.9487179487179487 -365 trim constant 0.9487179487179487 -366 trim constant 0.9487179487179487 -367 trim constant 0.9487179487179487 -368 trim constant 0.9487179487179487 -369 trim constant 0.9487179487179487 -370 trim constant 0.9316239316239316 -371 trim constant 0.9316239316239316 -372 trim constant 0.8888888888888888 -373 trim parsimony-informative 0.8888888888888888 -374 trim parsimony-informative 0.8888888888888888 -375 trim constant 0.8888888888888888 -376 trim parsimony-informative 0.8888888888888888 -377 trim parsimony-informative 0.8888888888888888 -378 trim parsimony-informative 0.8888888888888888 -379 trim parsimony-informative 0.8888888888888888 -380 trim constant 0.9572649572649573 -381 trim constant 0.9572649572649573 -382 trim constant 0.9572649572649573 -383 trim constant 0.9572649572649573 -384 trim constant 0.9572649572649573 -385 trim constant 0.8803418803418803 -386 trim constant 0.8803418803418803 -387 trim constant 0.8803418803418803 -388 trim parsimony-informative 0.8803418803418803 -389 trim parsimony-informative 0.8803418803418803 -390 trim constant 0.9316239316239316 -391 trim constant 0.9316239316239316 -392 trim constant 0.9316239316239316 -393 trim constant 0.9316239316239316 -394 trim constant 0.9316239316239316 -395 trim constant 0.9316239316239316 -396 trim constant 0.9316239316239316 -397 trim constant 0.9316239316239316 -398 trim constant 0.9230769230769231 -399 trim constant 0.9230769230769231 -400 trim singleton 0.9230769230769231 -401 trim singleton 0.9230769230769231 -402 trim singleton 0.9230769230769231 -403 trim singleton 0.9230769230769231 -404 trim singleton 0.8717948717948718 -405 keep parsimony-informative 0.8717948717948718 -406 keep parsimony-informative 0.8717948717948718 -407 keep parsimony-informative 0.8717948717948718 -408 keep parsimony-informative 0.8717948717948718 -409 trim parsimony-informative 0.8803418803418803 -410 trim parsimony-informative 0.8803418803418803 -411 trim parsimony-informative 0.8803418803418803 -412 trim parsimony-informative 0.8803418803418803 -413 trim parsimony-informative 0.8803418803418803 -414 trim parsimony-informative 0.8803418803418803 -415 trim constant 0.8803418803418803 -416 trim parsimony-informative 0.8803418803418803 -417 trim parsimony-informative 0.8803418803418803 -418 trim constant 0.9487179487179487 -419 trim constant 0.9487179487179487 -420 trim constant 0.9487179487179487 -421 trim constant 0.9487179487179487 -422 trim constant 0.9487179487179487 -423 trim parsimony-informative 0.8803418803418803 -424 trim parsimony-informative 0.8803418803418803 -425 trim constant 0.8803418803418803 -426 trim parsimony-informative 0.8803418803418803 -427 trim parsimony-informative 0.8803418803418803 -428 trim singleton 0.8632478632478633 -429 keep parsimony-informative 0.8632478632478633 -430 trim constant 0.8632478632478633 -431 trim constant 0.9316239316239316 -432 trim constant 0.9316239316239316 -433 trim constant 0.9316239316239316 -434 trim constant 0.8717948717948718 -435 trim constant 0.9316239316239316 -436 trim constant 0.9316239316239316 -437 trim constant 0.9316239316239316 -438 trim constant 0.8717948717948718 -439 trim constant 0.8717948717948718 -440 trim constant 0.9316239316239316 -441 trim constant 0.9316239316239316 -442 trim constant 0.9316239316239316 -443 trim constant 0.9316239316239316 -444 trim constant 0.9316239316239316 -445 trim constant 0.9316239316239316 -446 keep parsimony-informative 0.8717948717948718 -447 keep parsimony-informative 0.7692307692307693 -448 keep parsimony-informative 0.7692307692307693 -449 trim constant 0.7692307692307693 -450 trim constant 0.7692307692307693 -451 trim constant 0.7692307692307693 -452 trim constant 0.7692307692307693 -453 keep parsimony-informative 0.7692307692307693 -454 trim constant 0.7692307692307693 -455 keep parsimony-informative 0.7692307692307693 -456 trim constant 0.7692307692307693 -457 keep parsimony-informative 0.7692307692307693 -458 trim constant 0.7692307692307693 -459 trim constant 0.7692307692307693 -460 trim constant 0.7692307692307693 -461 trim constant 0.7692307692307693 -462 keep parsimony-informative 0.7692307692307693 -463 trim constant 0.7692307692307693 -464 keep parsimony-informative 0.7692307692307693 -465 keep parsimony-informative 0.7692307692307693 -466 trim constant 0.7692307692307693 -467 trim constant 0.7692307692307693 -468 trim constant 0.7692307692307693 -469 keep parsimony-informative 0.7692307692307693 -470 trim constant 0.7692307692307693 -471 trim constant 0.7692307692307693 -472 keep parsimony-informative 0.7692307692307693 -473 trim constant 0.7692307692307693 -474 trim constant 0.7692307692307693 -475 keep parsimony-informative 0.7692307692307693 -476 trim constant 0.7692307692307693 -477 trim singleton 0.7692307692307693 -478 trim constant 0.7692307692307693 -479 keep parsimony-informative 0.7692307692307693 -480 trim constant 0.7692307692307693 -481 keep parsimony-informative 0.7692307692307693 -482 trim constant 0.7692307692307693 -483 trim constant 0.7692307692307693 -484 trim constant 0.7692307692307693 -485 trim constant 0.7692307692307693 -486 trim constant 0.7692307692307693 -487 trim constant 0.7692307692307693 -488 trim constant 0.7606837606837606 -489 trim singleton 0.7606837606837606 -490 trim singleton 0.7606837606837606 -491 trim constant 0.7606837606837606 -492 trim singleton 0.7606837606837606 -493 trim singleton 0.7606837606837606 -494 trim singleton 0.7606837606837606 -495 trim singleton 0.7606837606837606 -496 trim constant 0.7606837606837606 -497 trim constant 0.7692307692307693 -498 keep parsimony-informative 0.7692307692307693 -499 trim singleton 0.7692307692307693 -500 trim constant 0.7692307692307693 -501 trim constant 0.7692307692307693 -502 trim constant 0.7692307692307693 -503 trim constant 0.7692307692307693 -504 trim constant 0.7692307692307693 -505 trim constant 0.7692307692307693 -506 trim constant 0.7692307692307693 -507 trim constant 0.7692307692307693 -508 trim constant 0.7692307692307693 -509 keep parsimony-informative 0.7692307692307693 -510 keep parsimony-informative 0.7606837606837606 -511 trim singleton 0.7606837606837606 -512 trim constant 0.7606837606837606 -513 trim singleton 0.7606837606837606 -514 trim singleton 0.7606837606837606 -515 trim constant 0.7606837606837606 -516 keep parsimony-informative 0.7692307692307693 -517 trim constant 0.7692307692307693 -518 trim constant 0.7692307692307693 -519 trim constant 0.7692307692307693 -520 trim constant 0.7692307692307693 -521 trim constant 0.7692307692307693 -522 trim constant 0.7692307692307693 -523 keep parsimony-informative 0.7692307692307693 -524 trim constant 0.7692307692307693 -525 trim constant 0.7692307692307693 -526 trim constant 0.7692307692307693 -527 trim constant 0.7692307692307693 -528 trim constant 0.7692307692307693 -529 trim constant 0.7692307692307693 -530 keep parsimony-informative 0.7692307692307693 -531 trim constant 0.7692307692307693 -532 trim constant 0.7692307692307693 -533 trim constant 0.7692307692307693 -534 trim constant 0.7692307692307693 -535 keep parsimony-informative 0.7692307692307693 -536 trim constant 0.7692307692307693 -537 trim constant 0.7692307692307693 -538 keep parsimony-informative 0.7692307692307693 -539 trim constant 0.7692307692307693 -540 keep parsimony-informative 0.7692307692307693 -541 trim constant 0.7692307692307693 -542 trim constant 0.7692307692307693 -543 trim constant 0.7692307692307693 -544 trim constant 0.7692307692307693 -545 keep parsimony-informative 0.7692307692307693 -546 keep parsimony-informative 0.7692307692307693 -547 trim constant 0.7692307692307693 -548 trim singleton 0.7606837606837606 -549 trim singleton 0.7606837606837606 -550 trim constant 0.7606837606837606 -551 trim singleton 0.7606837606837606 -552 trim singleton 0.7606837606837606 -553 keep parsimony-informative 0.7606837606837606 -554 keep parsimony-informative 0.7606837606837606 -555 trim constant 0.7606837606837606 -556 trim singleton 0.7606837606837606 -557 trim singleton 0.7606837606837606 -558 trim singleton 0.7606837606837606 -559 trim singleton 0.7606837606837606 -560 trim singleton 0.7606837606837606 -561 trim singleton 0.7606837606837606 -562 trim singleton 0.7606837606837606 -563 trim singleton 0.7606837606837606 -564 trim singleton 0.7606837606837606 -565 trim singleton 0.7606837606837606 -566 trim singleton 0.7606837606837606 -567 trim constant 0.7606837606837606 -568 keep parsimony-informative 0.7606837606837606 -569 keep parsimony-informative 0.7606837606837606 -570 trim singleton 0.7606837606837606 -571 keep parsimony-informative 0.7606837606837606 -572 trim constant 0.7606837606837606 -573 trim singleton 0.7606837606837606 -574 trim singleton 0.7606837606837606 -575 keep parsimony-informative 0.7606837606837606 -576 trim singleton 0.7606837606837606 -577 trim singleton 0.7606837606837606 -578 trim singleton 0.7606837606837606 -579 trim singleton 0.7606837606837606 -580 keep parsimony-informative 0.7606837606837606 -581 trim constant 0.7692307692307693 -582 trim constant 0.7692307692307693 -583 trim constant 0.7692307692307693 -584 trim singleton 0.7692307692307693 -585 trim constant 0.7692307692307693 -586 trim constant 0.7692307692307693 -587 keep parsimony-informative 0.7606837606837606 -588 trim constant 0.7606837606837606 -589 trim constant 0.7606837606837606 -590 keep parsimony-informative 0.7606837606837606 -591 keep parsimony-informative 0.7692307692307693 -592 trim singleton 0.7692307692307693 -593 trim constant 0.7692307692307693 -594 keep parsimony-informative 0.7692307692307693 -595 keep parsimony-informative 0.7606837606837606 -596 trim singleton 0.7606837606837606 -597 trim singleton 0.7606837606837606 -598 trim singleton 0.7606837606837606 -599 trim singleton 0.7606837606837606 -600 trim singleton 0.7606837606837606 -601 trim singleton 0.7606837606837606 -602 trim constant 0.7606837606837606 -603 trim singleton 0.7606837606837606 -604 trim singleton 0.7606837606837606 -605 trim singleton 0.7606837606837606 -606 trim singleton 0.7606837606837606 -607 trim constant 0.7606837606837606 -608 trim singleton 0.7606837606837606 -609 trim singleton 0.7606837606837606 -610 trim constant 0.7606837606837606 -611 trim singleton 0.7606837606837606 -612 trim singleton 0.7606837606837606 -613 trim singleton 0.7606837606837606 -614 trim singleton 0.7606837606837606 -615 trim singleton 0.7606837606837606 -616 trim constant 0.7606837606837606 -617 trim singleton 0.7606837606837606 -618 trim other 0.9914529914529915 -619 trim other 0.9914529914529915 -620 trim other 0.9914529914529915 -621 trim other 0.9914529914529915 -622 trim other 0.9914529914529915 -623 trim other 0.9914529914529915 -624 trim other 0.9914529914529915 -625 trim other 0.9914529914529915 -626 trim other 0.9914529914529915 -627 trim constant 0.7606837606837606 -628 trim singleton 0.7606837606837606 -629 trim singleton 0.7606837606837606 -630 keep parsimony-informative 0.7606837606837606 -631 trim singleton 0.7606837606837606 -632 trim singleton 0.7606837606837606 -633 keep parsimony-informative 0.7606837606837606 -634 keep parsimony-informative 0.7606837606837606 -635 trim singleton 0.7606837606837606 -636 trim singleton 0.7606837606837606 -637 keep parsimony-informative 0.7606837606837606 -638 keep parsimony-informative 0.7606837606837606 -639 keep parsimony-informative 0.7606837606837606 -640 trim singleton 0.7606837606837606 -641 trim constant 0.7606837606837606 -642 keep parsimony-informative 0.7606837606837606 -643 keep parsimony-informative 0.7606837606837606 -644 trim singleton 0.7606837606837606 -645 keep parsimony-informative 0.7606837606837606 -646 trim singleton 0.7606837606837606 -647 keep parsimony-informative 0.7606837606837606 -648 trim singleton 0.7606837606837606 -649 trim singleton 0.7606837606837606 -650 keep parsimony-informative 0.7606837606837606 -651 trim singleton 0.7606837606837606 -652 trim constant 0.7606837606837606 -653 trim constant 0.7606837606837606 -654 trim singleton 0.7606837606837606 -655 trim singleton 0.7606837606837606 -656 trim constant 0.7606837606837606 -657 trim singleton 0.7606837606837606 -658 trim singleton 0.7606837606837606 -659 trim constant 0.7606837606837606 -660 trim singleton 0.7606837606837606 -661 trim constant 0.7606837606837606 -662 trim constant 0.7692307692307693 -663 trim constant 0.7692307692307693 -664 keep parsimony-informative 0.7692307692307693 -665 trim constant 0.7692307692307693 -666 trim constant 0.7692307692307693 -667 trim constant 0.7692307692307693 -668 trim constant 0.7606837606837606 -669 trim constant 0.7692307692307693 -670 keep parsimony-informative 0.7692307692307693 -671 trim constant 0.7692307692307693 -672 trim singleton 0.7606837606837606 -673 keep parsimony-informative 0.7606837606837606 -674 keep parsimony-informative 0.7606837606837606 -675 trim constant 0.7606837606837606 -676 keep parsimony-informative 0.7692307692307693 -677 trim constant 0.7692307692307693 -678 trim constant 0.7692307692307693 -679 trim constant 0.7692307692307693 -680 trim constant 0.7692307692307693 -681 trim constant 0.7692307692307693 -682 trim constant 0.7692307692307693 -683 trim constant 0.7692307692307693 -684 keep parsimony-informative 0.7692307692307693 -685 trim constant 0.7692307692307693 -686 trim constant 0.7692307692307693 -687 trim constant 0.7692307692307693 -688 trim constant 0.7692307692307693 -689 keep parsimony-informative 0.10256410256410256 -690 keep parsimony-informative 0.10256410256410256 -691 trim singleton 0.7606837606837606 -692 trim constant 0.7692307692307693 -693 trim constant 0.7692307692307693 -694 trim constant 0.7692307692307693 -695 trim constant 0.7692307692307693 -696 trim constant 0.7692307692307693 -697 trim constant 0.7692307692307693 -698 trim constant 0.7692307692307693 -699 trim constant 0.7692307692307693 -700 trim constant 0.7692307692307693 -701 trim constant 0.7692307692307693 -702 trim constant 0.7692307692307693 -703 trim constant 0.7692307692307693 -704 keep parsimony-informative 0.7692307692307693 -705 trim constant 0.7692307692307693 -706 trim constant 0.7692307692307693 -707 trim constant 0.7692307692307693 -708 keep parsimony-informative 0.7692307692307693 -709 trim constant 0.7692307692307693 -710 trim constant 0.7692307692307693 -711 trim constant 0.7692307692307693 -712 trim constant 0.7692307692307693 -713 trim constant 0.7692307692307693 -714 trim constant 0.7692307692307693 -715 trim constant 0.7692307692307693 -716 trim constant 0.7692307692307693 -717 trim constant 0.7692307692307693 -718 trim constant 0.7692307692307693 -719 trim constant 0.7692307692307693 -720 trim constant 0.7692307692307693 -721 trim constant 0.7692307692307693 -722 trim constant 0.7692307692307693 -723 trim constant 0.7692307692307693 -724 trim constant 0.7692307692307693 -725 trim constant 0.7692307692307693 -726 trim constant 0.7606837606837606 -727 trim singleton 0.7606837606837606 -728 trim singleton 0.7606837606837606 -729 trim constant 0.7606837606837606 -730 trim singleton 0.7606837606837606 -731 trim singleton 0.7606837606837606 -732 trim singleton 0.7606837606837606 -733 trim singleton 0.7606837606837606 -734 trim singleton 0.7606837606837606 -735 trim singleton 0.7606837606837606 -736 trim singleton 0.7606837606837606 -737 trim singleton 0.7606837606837606 -738 trim constant 0.7606837606837606 -739 trim constant 0.7606837606837606 -740 trim constant 0.7606837606837606 -741 trim singleton 0.7606837606837606 -742 keep parsimony-informative 0.7606837606837606 -743 trim singleton 0.7606837606837606 -744 trim singleton 0.7606837606837606 -745 trim singleton 0.7606837606837606 -746 keep parsimony-informative 0.7606837606837606 -747 keep parsimony-informative 0.7606837606837606 -748 trim constant 0.7606837606837606 -749 trim constant 0.7692307692307693 -750 trim singleton 0.7692307692307693 -751 trim constant 0.7606837606837606 -752 trim singleton 0.7606837606837606 -753 trim constant 0.7606837606837606 -754 trim singleton 0.7606837606837606 -755 trim singleton 0.7606837606837606 -756 trim singleton 0.7606837606837606 -757 trim singleton 0.7606837606837606 -758 trim singleton 0.7606837606837606 -759 trim singleton 0.7606837606837606 -760 trim singleton 0.7606837606837606 -761 trim singleton 0.7606837606837606 -762 trim singleton 0.7606837606837606 -763 trim constant 0.7606837606837606 -764 trim singleton 0.7606837606837606 -765 trim constant 0.7606837606837606 -766 trim singleton 0.7606837606837606 -767 trim singleton 0.7606837606837606 -768 trim singleton 0.7606837606837606 -769 trim singleton 0.7606837606837606 -770 trim singleton 0.7606837606837606 -771 keep parsimony-informative 0.7606837606837606 -772 trim singleton 0.7606837606837606 -773 keep parsimony-informative 0.7606837606837606 -774 trim singleton 0.7606837606837606 -775 keep parsimony-informative 0.7606837606837606 -776 trim constant 0.7606837606837606 -777 trim singleton 0.7606837606837606 -778 trim singleton 0.7606837606837606 -779 trim singleton 0.7606837606837606 -780 keep parsimony-informative 0.7606837606837606 -781 keep parsimony-informative 0.7606837606837606 -782 trim constant 0.7606837606837606 -783 trim singleton 0.7606837606837606 -784 trim singleton 0.7606837606837606 -785 trim singleton 0.7521367521367521 -786 trim constant 0.7606837606837606 -787 trim singleton 0.7606837606837606 -788 trim singleton 0.7606837606837606 -789 trim singleton 0.7606837606837606 -790 trim singleton 0.7606837606837606 -791 trim singleton 0.7606837606837606 -792 trim constant 0.7606837606837606 -793 trim singleton 0.7606837606837606 -794 trim singleton 0.7606837606837606 -795 trim constant 0.7606837606837606 -796 trim singleton 0.7606837606837606 -797 trim singleton 0.7606837606837606 -798 trim singleton 0.7606837606837606 -799 trim singleton 0.7606837606837606 -800 trim singleton 0.7606837606837606 -801 trim singleton 0.7606837606837606 -802 trim singleton 0.7606837606837606 -803 trim singleton 0.7606837606837606 -804 trim constant 0.7606837606837606 -805 trim singleton 0.7606837606837606 -806 trim singleton 0.7606837606837606 -807 trim singleton 0.7606837606837606 -808 trim singleton 0.7606837606837606 -809 trim singleton 0.7606837606837606 -810 keep parsimony-informative 0.7606837606837606 -811 trim singleton 0.7606837606837606 -812 trim singleton 0.7606837606837606 -813 trim constant 0.7606837606837606 -814 trim singleton 0.7606837606837606 -815 trim singleton 0.7606837606837606 -816 trim constant 0.7606837606837606 -817 trim singleton 0.7606837606837606 -818 keep parsimony-informative 0.7606837606837606 -819 trim constant 0.7692307692307693 -820 trim constant 0.7692307692307693 -821 trim constant 0.7692307692307693 -822 trim constant 0.7692307692307693 -823 trim constant 0.7692307692307693 -824 trim constant 0.7692307692307693 -825 keep parsimony-informative 0.7606837606837606 -826 trim singleton 0.7606837606837606 -827 trim singleton 0.7606837606837606 -828 trim constant 0.7606837606837606 -829 keep parsimony-informative 0.7606837606837606 -830 trim constant 0.7606837606837606 -831 trim singleton 0.7692307692307693 -832 trim constant 0.7692307692307693 -833 trim constant 0.7692307692307693 -834 trim constant 0.7692307692307693 -835 trim singleton 0.7692307692307693 -836 trim constant 0.7606837606837606 -837 trim singleton 0.7606837606837606 -838 trim constant 0.7606837606837606 -839 trim singleton 0.7606837606837606 -840 trim singleton 0.7606837606837606 -841 trim other 0.9914529914529915 -842 trim singleton 0.7606837606837606 -843 trim constant 0.7606837606837606 -844 trim constant 0.7606837606837606 -845 trim singleton 0.7606837606837606 -846 trim singleton 0.7606837606837606 -847 trim singleton 0.7606837606837606 -848 trim constant 0.7606837606837606 -849 trim other 0.9914529914529915 -850 trim other 0.9914529914529915 -851 trim other 0.9914529914529915 -852 trim other 0.9914529914529915 -853 trim other 0.9914529914529915 -854 trim other 0.9914529914529915 -855 trim other 0.9914529914529915 -856 trim singleton 0.7606837606837606 -857 trim singleton 0.7606837606837606 -858 trim constant 0.7606837606837606 -859 keep parsimony-informative 0.7606837606837606 -860 trim other 0.9914529914529915 -861 trim other 0.9914529914529915 -862 trim other 0.9914529914529915 -863 trim other 0.9914529914529915 -864 trim other 0.9914529914529915 -865 trim other 0.9914529914529915 -866 trim other 0.9914529914529915 -867 trim other 0.9914529914529915 -868 trim other 0.9914529914529915 -869 trim other 0.9914529914529915 -870 trim other 0.9914529914529915 -871 trim other 0.9914529914529915 -872 trim other 0.9914529914529915 -873 trim other 0.9914529914529915 -874 trim singleton 0.7606837606837606 -875 trim singleton 0.7606837606837606 -876 trim singleton 0.7606837606837606 -877 trim constant 0.7606837606837606 -878 trim singleton 0.7606837606837606 -879 trim singleton 0.7606837606837606 -880 trim constant 0.7606837606837606 -881 trim constant 0.7606837606837606 -882 trim other 0.9914529914529915 -883 trim other 0.9914529914529915 -884 trim other 0.9914529914529915 -885 trim singleton 0.7606837606837606 -886 trim singleton 0.7606837606837606 -887 trim constant 0.7606837606837606 -888 trim constant 0.7606837606837606 -889 trim singleton 0.7606837606837606 -890 trim singleton 0.7606837606837606 -891 trim singleton 0.7606837606837606 -892 trim singleton 0.7606837606837606 -893 trim singleton 0.7606837606837606 -894 trim singleton 0.7606837606837606 -895 trim constant 0.7692307692307693 -896 trim constant 0.7692307692307693 -897 trim constant 0.7606837606837606 -898 trim constant 0.7692307692307693 -899 trim singleton 0.7606837606837606 -900 trim singleton 0.7606837606837606 -901 trim constant 0.7606837606837606 -902 trim constant 0.7692307692307693 -903 trim constant 0.7692307692307693 -904 trim constant 0.7692307692307693 -905 trim constant 0.7692307692307693 -906 trim constant 0.7692307692307693 -907 trim constant 0.7692307692307693 -908 keep parsimony-informative 0.7692307692307693 -909 trim singleton 0.7606837606837606 -910 trim singleton 0.7606837606837606 -911 trim constant 0.7606837606837606 -912 trim singleton 0.7606837606837606 -913 trim singleton 0.7606837606837606 -914 trim singleton 0.7606837606837606 -915 keep parsimony-informative 0.7606837606837606 -916 trim constant 0.7606837606837606 -917 trim constant 0.7692307692307693 -918 trim constant 0.7692307692307693 -919 trim constant 0.7692307692307693 -920 trim constant 0.7692307692307693 -921 trim constant 0.7692307692307693 -922 trim constant 0.7692307692307693 -923 trim constant 0.7692307692307693 -924 trim constant 0.7692307692307693 -925 trim constant 0.8034188034188035 -926 trim singleton 0.8034188034188035 -927 keep parsimony-informative 0.8034188034188035 -928 trim constant 0.8034188034188035 -929 trim constant 0.8034188034188035 -930 trim singleton 0.8034188034188035 -931 trim singleton 0.8034188034188035 -932 trim singleton 0.8034188034188035 -933 trim constant 0.8034188034188035 -934 keep parsimony-informative 0.8034188034188035 -935 trim singleton 0.8034188034188035 -936 trim constant 0.811965811965812 -937 trim constant 0.811965811965812 -938 trim constant 0.811965811965812 -939 trim constant 0.811965811965812 -940 trim constant 0.811965811965812 -941 trim constant 0.811965811965812 -942 trim constant 0.811965811965812 -943 trim singleton 0.8034188034188035 -944 trim singleton 0.8034188034188035 -945 trim singleton 0.8034188034188035 -946 trim constant 0.8034188034188035 -947 trim singleton 0.8461538461538461 -948 keep parsimony-informative 0.8461538461538461 -949 keep parsimony-informative 0.8461538461538461 -950 keep parsimony-informative 0.8461538461538461 -951 trim singleton 0.8461538461538461 -952 keep parsimony-informative 0.8461538461538461 -953 keep parsimony-informative 0.8461538461538461 -954 trim singleton 0.8461538461538461 -955 keep parsimony-informative 0.8461538461538461 -956 keep parsimony-informative 0.8461538461538461 -957 trim singleton 0.8461538461538461 -958 keep parsimony-informative 0.8461538461538461 -959 trim singleton 0.8461538461538461 -960 trim constant 0.8461538461538461 -961 trim singleton 0.8461538461538461 -962 trim singleton 0.8461538461538461 -963 keep parsimony-informative 0.8717948717948718 -964 trim singleton 0.8717948717948718 -965 trim constant 0.8717948717948718 -966 keep parsimony-informative 0.8717948717948718 -967 keep parsimony-informative 0.8717948717948718 -968 trim constant 0.8717948717948718 -969 trim constant 0.8717948717948718 -970 trim constant 0.8717948717948718 -971 trim constant 0.8717948717948718 -972 trim constant 0.8717948717948718 -973 trim constant 0.8717948717948718 -974 trim constant 0.8717948717948718 -975 trim constant 0.8717948717948718 -976 trim singleton 0.8717948717948718 -977 trim constant 0.8717948717948718 -978 trim constant 0.8632478632478633 -979 trim constant 0.8632478632478633 -980 trim constant 0.8632478632478633 -981 trim singleton 0.8632478632478633 -982 trim singleton 0.8632478632478633 -983 trim constant 0.8632478632478633 -984 trim singleton 0.8632478632478633 -985 trim singleton 0.8632478632478633 -986 trim singleton 0.8632478632478633 -987 trim singleton 0.8632478632478633 -988 trim singleton 0.8632478632478633 -989 trim constant 0.8632478632478633 -990 trim constant 0.8717948717948718 -991 trim constant 0.8717948717948718 -992 trim constant 0.8717948717948718 -993 keep parsimony-informative 0.8717948717948718 -994 trim constant 0.8717948717948718 -995 trim constant 0.8717948717948718 -996 trim singleton 0.8717948717948718 -997 trim constant 0.8888888888888888 -998 trim singleton 0.8888888888888888 -999 trim constant 0.8888888888888888 -1000 trim parsimony-informative 0.8888888888888888 -1001 trim parsimony-informative 0.8888888888888888 -1002 trim parsimony-informative 0.8888888888888888 -1003 trim parsimony-informative 0.8888888888888888 -1004 trim singleton 0.8888888888888888 -1005 trim singleton 0.8888888888888888 -1006 trim singleton 0.8888888888888888 -1007 trim singleton 0.8888888888888888 -1008 trim other 0.9829059829059829 -1009 trim other 0.9914529914529915 -1010 trim other 0.9914529914529915 -1011 trim other 0.9914529914529915 -1012 trim other 0.9914529914529915 -1013 trim other 0.9914529914529915 -1014 trim other 0.9914529914529915 -1015 trim other 0.9914529914529915 -1016 trim other 0.9914529914529915 -1017 trim other 0.9914529914529915 -1018 trim other 0.9914529914529915 -1019 trim other 0.9914529914529915 -1020 trim other 0.9914529914529915 -1021 trim other 0.9914529914529915 -1022 trim other 0.9914529914529915 -1023 trim other 0.9914529914529915 -1024 trim other 0.9914529914529915 -1025 trim other 0.9914529914529915 -1026 trim singleton 0.8974358974358975 diff --git a/test-api.py b/test-api.py index 181faca..9967aea 100644 --- a/test-api.py +++ b/test-api.py @@ -1,7 +1,7 @@ from clipkit import clipkit from clipkit.files import FileFormat -trim_run = clipkit( +trim_run, stats = clipkit( # raw_alignment=">1\nA-GTAT\n>2\nA-G-AT\n>3\nA-G-TA\n>4\nAGA-TA\n>5\nACa-T-\n", input_file_path="tests/integration/samples/simple.fa", # output_file_path="./programmatic-temp.phylip", @@ -12,4 +12,4 @@ sequence_type="nt", ) -print(trim_run.site_classification_counts) +print(trim_run.version) diff --git a/tests/integration/expected/12_YIL115C_Anc_2.253_codon_aln.fasta.clipkit.log b/tests/integration/expected/12_YIL115C_Anc_2.253_codon_aln.fasta.clipkit.log index 1e4b970..2d94155 100644 --- a/tests/integration/expected/12_YIL115C_Anc_2.253_codon_aln.fasta.clipkit.log +++ b/tests/integration/expected/12_YIL115C_Anc_2.253_codon_aln.fasta.clipkit.log @@ -1,27 +1,27 @@ 1 keep constant 0.0 2 keep constant 0.0 3 keep constant 0.0 -4 keep other 0.8333333333333334 -5 keep other 0.8333333333333334 -6 keep other 0.8333333333333334 -7 keep constant 0.08333333333333333 -8 keep constant 0.08333333333333333 -9 keep parsimony-informative 0.08333333333333333 -10 keep parsimony-informative 0.08333333333333333 -11 keep parsimony-informative 0.08333333333333333 -12 keep parsimony-informative 0.08333333333333333 -13 keep parsimony-informative 0.08333333333333333 -14 keep constant 0.08333333333333333 -15 keep parsimony-informative 0.08333333333333333 +4 keep other 0.8333 +5 keep other 0.8333 +6 keep other 0.8333 +7 keep constant 0.0833 +8 keep constant 0.0833 +9 keep parsimony-informative 0.0833 +10 keep parsimony-informative 0.0833 +11 keep parsimony-informative 0.0833 +12 keep parsimony-informative 0.0833 +13 keep parsimony-informative 0.0833 +14 keep constant 0.0833 +15 keep parsimony-informative 0.0833 16 keep parsimony-informative 0.0 17 keep parsimony-informative 0.0 18 keep parsimony-informative 0.0 19 keep singleton 0.0 20 keep constant 0.0 21 keep parsimony-informative 0.0 -22 trim other 0.9166666666666666 -23 trim other 0.9166666666666666 -24 trim other 0.9166666666666666 +22 trim other 0.9167 +23 trim other 0.9167 +24 trim other 0.9167 25 keep constant 0.0 26 keep constant 0.0 27 keep parsimony-informative 0.0 @@ -76,9 +76,9 @@ 76 keep singleton 0.0 77 keep parsimony-informative 0.0 78 keep parsimony-informative 0.0 -79 trim other 0.9166666666666666 -80 trim other 0.9166666666666666 -81 trim other 0.9166666666666666 +79 trim other 0.9167 +80 trim other 0.9167 +81 trim other 0.9167 82 keep parsimony-informative 0.0 83 keep parsimony-informative 0.0 84 keep parsimony-informative 0.0 @@ -97,9 +97,9 @@ 97 keep singleton 0.0 98 keep parsimony-informative 0.0 99 keep parsimony-informative 0.0 -100 keep other 0.8333333333333334 -101 keep other 0.8333333333333334 -102 keep other 0.8333333333333334 +100 keep other 0.8333 +101 keep other 0.8333 +102 keep other 0.8333 103 keep parsimony-informative 0.0 104 keep singleton 0.0 105 keep parsimony-informative 0.0 @@ -148,18 +148,18 @@ 148 keep singleton 0.0 149 keep constant 0.0 150 keep parsimony-informative 0.0 -151 trim other 0.9166666666666666 -152 trim other 0.9166666666666666 -153 trim other 0.9166666666666666 -154 trim other 0.9166666666666666 -155 trim other 0.9166666666666666 -156 trim other 0.9166666666666666 -157 trim other 0.9166666666666666 -158 trim other 0.9166666666666666 -159 trim other 0.9166666666666666 -160 trim other 0.9166666666666666 -161 trim other 0.9166666666666666 -162 trim other 0.9166666666666666 +151 trim other 0.9167 +152 trim other 0.9167 +153 trim other 0.9167 +154 trim other 0.9167 +155 trim other 0.9167 +156 trim other 0.9167 +157 trim other 0.9167 +158 trim other 0.9167 +159 trim other 0.9167 +160 trim other 0.9167 +161 trim other 0.9167 +162 trim other 0.9167 163 keep parsimony-informative 0.0 164 keep parsimony-informative 0.0 165 keep parsimony-informative 0.0 @@ -250,78 +250,78 @@ 250 keep parsimony-informative 0.0 251 keep parsimony-informative 0.0 252 keep parsimony-informative 0.0 -253 trim other 0.9166666666666666 -254 trim other 0.9166666666666666 -255 trim other 0.9166666666666666 -256 trim other 0.9166666666666666 -257 trim other 0.9166666666666666 -258 trim other 0.9166666666666666 -259 trim other 0.9166666666666666 -260 trim other 0.9166666666666666 -261 trim other 0.9166666666666666 -262 trim other 0.9166666666666666 -263 trim other 0.9166666666666666 -264 trim other 0.9166666666666666 -265 trim other 0.9166666666666666 -266 trim other 0.9166666666666666 -267 trim other 0.9166666666666666 -268 trim other 0.9166666666666666 -269 trim other 0.9166666666666666 -270 trim other 0.9166666666666666 -271 trim other 0.9166666666666666 -272 trim other 0.9166666666666666 -273 trim other 0.9166666666666666 -274 trim other 0.9166666666666666 -275 trim other 0.9166666666666666 -276 trim other 0.9166666666666666 -277 trim other 0.9166666666666666 -278 trim other 0.9166666666666666 -279 trim other 0.9166666666666666 -280 trim other 0.9166666666666666 -281 trim other 0.9166666666666666 -282 trim other 0.9166666666666666 -283 trim other 0.9166666666666666 -284 trim other 0.9166666666666666 -285 trim other 0.9166666666666666 -286 keep other 0.8333333333333334 -287 keep constant 0.8333333333333334 -288 keep other 0.8333333333333334 -289 keep constant 0.8333333333333334 -290 keep other 0.8333333333333334 -291 keep other 0.8333333333333334 -292 keep constant 0.8333333333333334 -293 keep other 0.8333333333333334 -294 keep other 0.8333333333333334 -295 keep other 0.8333333333333334 -296 keep other 0.8333333333333334 -297 keep other 0.8333333333333334 -298 keep other 0.8333333333333334 -299 keep constant 0.8333333333333334 -300 keep constant 0.8333333333333334 -301 keep constant 0.8333333333333334 -302 keep constant 0.8333333333333334 -303 keep other 0.8333333333333334 -304 keep constant 0.8333333333333334 -305 keep constant 0.8333333333333334 -306 keep constant 0.8333333333333334 -307 trim other 0.9166666666666666 -308 trim other 0.9166666666666666 -309 trim other 0.9166666666666666 -310 trim other 0.9166666666666666 -311 trim other 0.9166666666666666 -312 trim other 0.9166666666666666 -313 trim other 0.9166666666666666 -314 trim other 0.9166666666666666 -315 trim other 0.9166666666666666 -316 keep singleton 0.4166666666666667 -317 keep parsimony-informative 0.4166666666666667 -318 keep parsimony-informative 0.4166666666666667 -319 keep parsimony-informative 0.4166666666666667 -320 keep parsimony-informative 0.4166666666666667 -321 keep parsimony-informative 0.4166666666666667 -322 keep singleton 0.3333333333333333 -323 keep parsimony-informative 0.3333333333333333 -324 keep parsimony-informative 0.3333333333333333 +253 trim other 0.9167 +254 trim other 0.9167 +255 trim other 0.9167 +256 trim other 0.9167 +257 trim other 0.9167 +258 trim other 0.9167 +259 trim other 0.9167 +260 trim other 0.9167 +261 trim other 0.9167 +262 trim other 0.9167 +263 trim other 0.9167 +264 trim other 0.9167 +265 trim other 0.9167 +266 trim other 0.9167 +267 trim other 0.9167 +268 trim other 0.9167 +269 trim other 0.9167 +270 trim other 0.9167 +271 trim other 0.9167 +272 trim other 0.9167 +273 trim other 0.9167 +274 trim other 0.9167 +275 trim other 0.9167 +276 trim other 0.9167 +277 trim other 0.9167 +278 trim other 0.9167 +279 trim other 0.9167 +280 trim other 0.9167 +281 trim other 0.9167 +282 trim other 0.9167 +283 trim other 0.9167 +284 trim other 0.9167 +285 trim other 0.9167 +286 keep other 0.8333 +287 keep constant 0.8333 +288 keep other 0.8333 +289 keep constant 0.8333 +290 keep other 0.8333 +291 keep other 0.8333 +292 keep constant 0.8333 +293 keep other 0.8333 +294 keep other 0.8333 +295 keep other 0.8333 +296 keep other 0.8333 +297 keep other 0.8333 +298 keep other 0.8333 +299 keep constant 0.8333 +300 keep constant 0.8333 +301 keep constant 0.8333 +302 keep constant 0.8333 +303 keep other 0.8333 +304 keep constant 0.8333 +305 keep constant 0.8333 +306 keep constant 0.8333 +307 trim other 0.9167 +308 trim other 0.9167 +309 trim other 0.9167 +310 trim other 0.9167 +311 trim other 0.9167 +312 trim other 0.9167 +313 trim other 0.9167 +314 trim other 0.9167 +315 trim other 0.9167 +316 keep singleton 0.4167 +317 keep parsimony-informative 0.4167 +318 keep parsimony-informative 0.4167 +319 keep parsimony-informative 0.4167 +320 keep parsimony-informative 0.4167 +321 keep parsimony-informative 0.4167 +322 keep singleton 0.3333 +323 keep parsimony-informative 0.3333 +324 keep parsimony-informative 0.3333 325 keep parsimony-informative 0.5 326 keep parsimony-informative 0.5 327 keep parsimony-informative 0.5 @@ -331,15 +331,15 @@ 331 keep parsimony-informative 0.0 332 keep singleton 0.0 333 keep parsimony-informative 0.0 -334 keep parsimony-informative 0.08333333333333333 -335 keep parsimony-informative 0.08333333333333333 -336 keep parsimony-informative 0.08333333333333333 -337 keep parsimony-informative 0.08333333333333333 -338 keep parsimony-informative 0.08333333333333333 -339 keep parsimony-informative 0.08333333333333333 -340 keep parsimony-informative 0.08333333333333333 -341 keep parsimony-informative 0.08333333333333333 -342 keep parsimony-informative 0.08333333333333333 +334 keep parsimony-informative 0.0833 +335 keep parsimony-informative 0.0833 +336 keep parsimony-informative 0.0833 +337 keep parsimony-informative 0.0833 +338 keep parsimony-informative 0.0833 +339 keep parsimony-informative 0.0833 +340 keep parsimony-informative 0.0833 +341 keep parsimony-informative 0.0833 +342 keep parsimony-informative 0.0833 343 keep singleton 0.0 344 keep singleton 0.0 345 keep singleton 0.0 @@ -349,9 +349,9 @@ 349 keep singleton 0.0 350 keep parsimony-informative 0.0 351 keep parsimony-informative 0.0 -352 keep other 0.8333333333333334 -353 keep other 0.8333333333333334 -354 keep other 0.8333333333333334 +352 keep other 0.8333 +353 keep other 0.8333 +354 keep other 0.8333 355 keep parsimony-informative 0.0 356 keep parsimony-informative 0.0 357 keep parsimony-informative 0.0 @@ -391,9 +391,9 @@ 391 keep parsimony-informative 0.0 392 keep parsimony-informative 0.0 393 keep parsimony-informative 0.0 -394 keep parsimony-informative 0.6666666666666666 -395 keep parsimony-informative 0.6666666666666666 -396 keep singleton 0.6666666666666666 +394 keep parsimony-informative 0.6667 +395 keep parsimony-informative 0.6667 +396 keep singleton 0.6667 397 keep parsimony-informative 0.0 398 keep singleton 0.0 399 keep parsimony-informative 0.0 @@ -418,15 +418,15 @@ 418 keep parsimony-informative 0.0 419 keep parsimony-informative 0.0 420 keep singleton 0.0 -421 keep singleton 0.3333333333333333 -422 keep singleton 0.3333333333333333 -423 keep parsimony-informative 0.3333333333333333 -424 trim other 0.9166666666666666 -425 trim other 0.9166666666666666 -426 trim other 0.9166666666666666 -427 trim other 0.9166666666666666 -428 trim other 0.9166666666666666 -429 trim other 0.9166666666666666 +421 keep singleton 0.3333 +422 keep singleton 0.3333 +423 keep parsimony-informative 0.3333 +424 trim other 0.9167 +425 trim other 0.9167 +426 trim other 0.9167 +427 trim other 0.9167 +428 trim other 0.9167 +429 trim other 0.9167 430 keep parsimony-informative 0.0 431 keep parsimony-informative 0.0 432 keep parsimony-informative 0.0 @@ -460,9 +460,9 @@ 460 keep parsimony-informative 0.0 461 keep parsimony-informative 0.0 462 keep parsimony-informative 0.0 -463 keep singleton 0.6666666666666666 -464 keep singleton 0.6666666666666666 -465 keep parsimony-informative 0.6666666666666666 +463 keep singleton 0.6667 +464 keep singleton 0.6667 +465 keep parsimony-informative 0.6667 466 keep singleton 0.0 467 keep singleton 0.0 468 keep parsimony-informative 0.0 @@ -475,12 +475,12 @@ 475 keep parsimony-informative 0.0 476 keep parsimony-informative 0.0 477 keep parsimony-informative 0.0 -478 keep parsimony-informative 0.08333333333333333 -479 keep parsimony-informative 0.08333333333333333 -480 keep parsimony-informative 0.08333333333333333 -481 keep parsimony-informative 0.08333333333333333 -482 keep parsimony-informative 0.08333333333333333 -483 keep parsimony-informative 0.08333333333333333 +478 keep parsimony-informative 0.0833 +479 keep parsimony-informative 0.0833 +480 keep parsimony-informative 0.0833 +481 keep parsimony-informative 0.0833 +482 keep parsimony-informative 0.0833 +483 keep parsimony-informative 0.0833 484 keep parsimony-informative 0.0 485 keep parsimony-informative 0.0 486 keep parsimony-informative 0.0 @@ -514,15 +514,15 @@ 514 keep parsimony-informative 0.0 515 keep parsimony-informative 0.0 516 keep parsimony-informative 0.0 -517 trim other 0.9166666666666666 -518 trim other 0.9166666666666666 -519 trim other 0.9166666666666666 +517 trim other 0.9167 +518 trim other 0.9167 +519 trim other 0.9167 520 keep constant 0.75 521 keep constant 0.75 522 keep constant 0.75 -523 keep constant 0.8333333333333334 -524 keep other 0.8333333333333334 -525 keep other 0.8333333333333334 +523 keep constant 0.8333 +524 keep other 0.8333 +525 keep other 0.8333 526 keep singleton 0.75 527 keep singleton 0.75 528 keep singleton 0.75 @@ -589,9 +589,9 @@ 589 keep parsimony-informative 0.0 590 keep parsimony-informative 0.0 591 keep parsimony-informative 0.0 -592 trim other 0.9166666666666666 -593 trim other 0.9166666666666666 -594 trim other 0.9166666666666666 +592 trim other 0.9167 +593 trim other 0.9167 +594 trim other 0.9167 595 keep parsimony-informative 0.0 596 keep singleton 0.0 597 keep parsimony-informative 0.0 @@ -610,9 +610,9 @@ 610 keep singleton 0.75 611 keep constant 0.75 612 keep singleton 0.75 -613 trim other 0.9166666666666666 -614 trim other 0.9166666666666666 -615 trim other 0.9166666666666666 +613 trim other 0.9167 +614 trim other 0.9167 +615 trim other 0.9167 616 keep parsimony-informative 0.0 617 keep singleton 0.0 618 keep parsimony-informative 0.0 @@ -643,15 +643,15 @@ 643 keep parsimony-informative 0.0 644 keep constant 0.0 645 keep parsimony-informative 0.0 -646 trim other 0.9166666666666666 -647 trim other 0.9166666666666666 -648 trim other 0.9166666666666666 -649 trim other 0.9166666666666666 -650 trim other 0.9166666666666666 -651 trim other 0.9166666666666666 -652 trim other 0.9166666666666666 -653 trim other 0.9166666666666666 -654 trim other 0.9166666666666666 +646 trim other 0.9167 +647 trim other 0.9167 +648 trim other 0.9167 +649 trim other 0.9167 +650 trim other 0.9167 +651 trim other 0.9167 +652 trim other 0.9167 +653 trim other 0.9167 +654 trim other 0.9167 655 keep parsimony-informative 0.0 656 keep parsimony-informative 0.0 657 keep parsimony-informative 0.0 @@ -682,15 +682,15 @@ 682 keep parsimony-informative 0.0 683 keep parsimony-informative 0.0 684 keep parsimony-informative 0.0 -685 trim other 0.9166666666666666 -686 trim other 0.9166666666666666 -687 trim other 0.9166666666666666 -688 trim other 0.9166666666666666 -689 trim other 0.9166666666666666 -690 trim other 0.9166666666666666 -691 trim other 0.9166666666666666 -692 trim other 0.9166666666666666 -693 trim other 0.9166666666666666 +685 trim other 0.9167 +686 trim other 0.9167 +687 trim other 0.9167 +688 trim other 0.9167 +689 trim other 0.9167 +690 trim other 0.9167 +691 trim other 0.9167 +692 trim other 0.9167 +693 trim other 0.9167 694 keep parsimony-informative 0.0 695 keep parsimony-informative 0.0 696 keep parsimony-informative 0.0 @@ -712,21 +712,21 @@ 712 keep singleton 0.0 713 keep parsimony-informative 0.0 714 keep parsimony-informative 0.0 -715 keep other 0.8333333333333334 -716 keep other 0.8333333333333334 -717 keep other 0.8333333333333334 -718 trim other 0.9166666666666666 -719 trim other 0.9166666666666666 -720 trim other 0.9166666666666666 -721 trim other 0.9166666666666666 -722 trim other 0.9166666666666666 -723 trim other 0.9166666666666666 -724 trim other 0.9166666666666666 -725 trim other 0.9166666666666666 -726 trim other 0.9166666666666666 -727 keep other 0.8333333333333334 -728 keep constant 0.8333333333333334 -729 keep other 0.8333333333333334 +715 keep other 0.8333 +716 keep other 0.8333 +717 keep other 0.8333 +718 trim other 0.9167 +719 trim other 0.9167 +720 trim other 0.9167 +721 trim other 0.9167 +722 trim other 0.9167 +723 trim other 0.9167 +724 trim other 0.9167 +725 trim other 0.9167 +726 trim other 0.9167 +727 keep other 0.8333 +728 keep constant 0.8333 +729 keep other 0.8333 730 keep parsimony-informative 0.0 731 keep parsimony-informative 0.0 732 keep parsimony-informative 0.0 @@ -748,12 +748,12 @@ 748 keep parsimony-informative 0.0 749 keep singleton 0.0 750 keep parsimony-informative 0.0 -751 keep parsimony-informative 0.08333333333333333 -752 keep parsimony-informative 0.08333333333333333 -753 keep parsimony-informative 0.08333333333333333 -754 keep parsimony-informative 0.08333333333333333 -755 keep parsimony-informative 0.08333333333333333 -756 keep parsimony-informative 0.08333333333333333 +751 keep parsimony-informative 0.0833 +752 keep parsimony-informative 0.0833 +753 keep parsimony-informative 0.0833 +754 keep parsimony-informative 0.0833 +755 keep parsimony-informative 0.0833 +756 keep parsimony-informative 0.0833 757 keep parsimony-informative 0.0 758 keep parsimony-informative 0.0 759 keep parsimony-informative 0.0 @@ -799,9 +799,9 @@ 799 keep parsimony-informative 0.0 800 keep parsimony-informative 0.0 801 keep parsimony-informative 0.0 -802 keep constant 0.8333333333333334 -803 keep constant 0.8333333333333334 -804 keep constant 0.8333333333333334 +802 keep constant 0.8333 +803 keep constant 0.8333 +804 keep constant 0.8333 805 keep constant 0.0 806 keep constant 0.0 807 keep parsimony-informative 0.0 @@ -835,9 +835,9 @@ 835 keep parsimony-informative 0.0 836 keep constant 0.0 837 keep parsimony-informative 0.0 -838 trim other 0.9166666666666666 -839 trim other 0.9166666666666666 -840 trim other 0.9166666666666666 +838 trim other 0.9167 +839 trim other 0.9167 +840 trim other 0.9167 841 keep parsimony-informative 0.0 842 keep parsimony-informative 0.0 843 keep parsimony-informative 0.0 @@ -880,18 +880,18 @@ 880 keep parsimony-informative 0.0 881 keep parsimony-informative 0.0 882 keep parsimony-informative 0.0 -883 trim other 0.9166666666666666 -884 trim other 0.9166666666666666 -885 trim other 0.9166666666666666 -886 trim other 0.9166666666666666 -887 trim other 0.9166666666666666 -888 trim other 0.9166666666666666 -889 keep parsimony-informative 0.08333333333333333 -890 keep parsimony-informative 0.08333333333333333 -891 keep parsimony-informative 0.08333333333333333 -892 keep parsimony-informative 0.08333333333333333 -893 keep parsimony-informative 0.08333333333333333 -894 keep parsimony-informative 0.08333333333333333 +883 trim other 0.9167 +884 trim other 0.9167 +885 trim other 0.9167 +886 trim other 0.9167 +887 trim other 0.9167 +888 trim other 0.9167 +889 keep parsimony-informative 0.0833 +890 keep parsimony-informative 0.0833 +891 keep parsimony-informative 0.0833 +892 keep parsimony-informative 0.0833 +893 keep parsimony-informative 0.0833 +894 keep parsimony-informative 0.0833 895 keep parsimony-informative 0.0 896 keep parsimony-informative 0.0 897 keep parsimony-informative 0.0 @@ -934,21 +934,21 @@ 934 keep parsimony-informative 0.0 935 keep parsimony-informative 0.0 936 keep parsimony-informative 0.0 -937 trim other 0.9166666666666666 -938 trim other 0.9166666666666666 -939 trim other 0.9166666666666666 -940 trim other 0.9166666666666666 -941 trim other 0.9166666666666666 -942 trim other 0.9166666666666666 -943 trim other 0.9166666666666666 -944 trim other 0.9166666666666666 -945 trim other 0.9166666666666666 -946 trim other 0.9166666666666666 -947 trim other 0.9166666666666666 -948 trim other 0.9166666666666666 -949 keep parsimony-informative 0.08333333333333333 -950 keep singleton 0.08333333333333333 -951 keep parsimony-informative 0.08333333333333333 +937 trim other 0.9167 +938 trim other 0.9167 +939 trim other 0.9167 +940 trim other 0.9167 +941 trim other 0.9167 +942 trim other 0.9167 +943 trim other 0.9167 +944 trim other 0.9167 +945 trim other 0.9167 +946 trim other 0.9167 +947 trim other 0.9167 +948 trim other 0.9167 +949 keep parsimony-informative 0.0833 +950 keep singleton 0.0833 +951 keep parsimony-informative 0.0833 952 keep parsimony-informative 0.0 953 keep parsimony-informative 0.0 954 keep parsimony-informative 0.0 @@ -961,9 +961,9 @@ 961 keep parsimony-informative 0.0 962 keep parsimony-informative 0.0 963 keep parsimony-informative 0.0 -964 trim other 0.9166666666666666 -965 trim other 0.9166666666666666 -966 trim other 0.9166666666666666 +964 trim other 0.9167 +965 trim other 0.9167 +966 trim other 0.9167 967 keep parsimony-informative 0.0 968 keep parsimony-informative 0.0 969 keep parsimony-informative 0.0 @@ -1057,9 +1057,9 @@ 1057 keep parsimony-informative 0.0 1058 keep constant 0.0 1059 keep parsimony-informative 0.0 -1060 trim other 0.9166666666666666 -1061 trim other 0.9166666666666666 -1062 trim other 0.9166666666666666 +1060 trim other 0.9167 +1061 trim other 0.9167 +1062 trim other 0.9167 1063 keep parsimony-informative 0.0 1064 keep constant 0.0 1065 keep parsimony-informative 0.0 @@ -1399,246 +1399,246 @@ 1399 keep parsimony-informative 0.0 1400 keep singleton 0.0 1401 keep parsimony-informative 0.0 -1402 trim other 0.9166666666666666 -1403 trim other 0.9166666666666666 -1404 trim other 0.9166666666666666 -1405 keep parsimony-informative 0.16666666666666666 -1406 keep parsimony-informative 0.16666666666666666 -1407 keep parsimony-informative 0.16666666666666666 -1408 keep parsimony-informative 0.16666666666666666 -1409 keep singleton 0.16666666666666666 -1410 keep parsimony-informative 0.16666666666666666 -1411 keep parsimony-informative 0.5833333333333334 -1412 keep singleton 0.5833333333333334 -1413 keep parsimony-informative 0.5833333333333334 -1414 keep parsimony-informative 0.5833333333333334 -1415 keep singleton 0.5833333333333334 -1416 keep singleton 0.5833333333333334 +1402 trim other 0.9167 +1403 trim other 0.9167 +1404 trim other 0.9167 +1405 keep parsimony-informative 0.1667 +1406 keep parsimony-informative 0.1667 +1407 keep parsimony-informative 0.1667 +1408 keep parsimony-informative 0.1667 +1409 keep singleton 0.1667 +1410 keep parsimony-informative 0.1667 +1411 keep parsimony-informative 0.5833 +1412 keep singleton 0.5833 +1413 keep parsimony-informative 0.5833 +1414 keep parsimony-informative 0.5833 +1415 keep singleton 0.5833 +1416 keep singleton 0.5833 1417 keep parsimony-informative 0.5 1418 keep singleton 0.5 1419 keep parsimony-informative 0.5 1420 keep parsimony-informative 0.5 1421 keep parsimony-informative 0.5 1422 keep singleton 0.5 -1423 trim other 0.9166666666666666 -1424 trim other 0.9166666666666666 -1425 trim other 0.9166666666666666 -1426 trim other 0.9166666666666666 -1427 trim other 0.9166666666666666 -1428 trim other 0.9166666666666666 -1429 trim other 0.9166666666666666 -1430 trim other 0.9166666666666666 -1431 trim other 0.9166666666666666 -1432 trim other 0.9166666666666666 -1433 trim other 0.9166666666666666 -1434 trim other 0.9166666666666666 -1435 keep other 0.8333333333333334 -1436 keep other 0.8333333333333334 -1437 keep other 0.8333333333333334 -1438 keep other 0.8333333333333334 -1439 keep other 0.8333333333333334 -1440 keep other 0.8333333333333334 -1441 keep other 0.8333333333333334 -1442 keep other 0.8333333333333334 -1443 keep constant 0.8333333333333334 +1423 trim other 0.9167 +1424 trim other 0.9167 +1425 trim other 0.9167 +1426 trim other 0.9167 +1427 trim other 0.9167 +1428 trim other 0.9167 +1429 trim other 0.9167 +1430 trim other 0.9167 +1431 trim other 0.9167 +1432 trim other 0.9167 +1433 trim other 0.9167 +1434 trim other 0.9167 +1435 keep other 0.8333 +1436 keep other 0.8333 +1437 keep other 0.8333 +1438 keep other 0.8333 +1439 keep other 0.8333 +1440 keep other 0.8333 +1441 keep other 0.8333 +1442 keep other 0.8333 +1443 keep constant 0.8333 1444 keep singleton 0.75 1445 keep other 0.75 1446 keep other 0.75 -1447 keep parsimony-informative 0.08333333333333333 -1448 keep parsimony-informative 0.08333333333333333 -1449 keep parsimony-informative 0.08333333333333333 -1450 keep parsimony-informative 0.08333333333333333 -1451 keep parsimony-informative 0.08333333333333333 -1452 keep parsimony-informative 0.08333333333333333 -1453 keep parsimony-informative 0.08333333333333333 -1454 keep parsimony-informative 0.08333333333333333 -1455 keep parsimony-informative 0.08333333333333333 +1447 keep parsimony-informative 0.0833 +1448 keep parsimony-informative 0.0833 +1449 keep parsimony-informative 0.0833 +1450 keep parsimony-informative 0.0833 +1451 keep parsimony-informative 0.0833 +1452 keep parsimony-informative 0.0833 +1453 keep parsimony-informative 0.0833 +1454 keep parsimony-informative 0.0833 +1455 keep parsimony-informative 0.0833 1456 keep parsimony-informative 0.25 1457 keep parsimony-informative 0.25 1458 keep parsimony-informative 0.25 -1459 keep parsimony-informative 0.08333333333333333 -1460 keep parsimony-informative 0.08333333333333333 -1461 keep parsimony-informative 0.08333333333333333 -1462 keep parsimony-informative 0.08333333333333333 -1463 keep parsimony-informative 0.08333333333333333 -1464 keep parsimony-informative 0.08333333333333333 -1465 keep parsimony-informative 0.08333333333333333 -1466 keep parsimony-informative 0.08333333333333333 -1467 keep parsimony-informative 0.08333333333333333 -1468 keep parsimony-informative 0.08333333333333333 -1469 keep parsimony-informative 0.08333333333333333 -1470 keep parsimony-informative 0.08333333333333333 -1471 keep parsimony-informative 0.08333333333333333 -1472 keep parsimony-informative 0.08333333333333333 -1473 keep parsimony-informative 0.08333333333333333 -1474 keep parsimony-informative 0.08333333333333333 -1475 keep parsimony-informative 0.08333333333333333 -1476 keep parsimony-informative 0.08333333333333333 -1477 keep parsimony-informative 0.08333333333333333 -1478 keep parsimony-informative 0.08333333333333333 -1479 keep parsimony-informative 0.08333333333333333 -1480 keep parsimony-informative 0.08333333333333333 -1481 keep parsimony-informative 0.08333333333333333 -1482 keep parsimony-informative 0.08333333333333333 +1459 keep parsimony-informative 0.0833 +1460 keep parsimony-informative 0.0833 +1461 keep parsimony-informative 0.0833 +1462 keep parsimony-informative 0.0833 +1463 keep parsimony-informative 0.0833 +1464 keep parsimony-informative 0.0833 +1465 keep parsimony-informative 0.0833 +1466 keep parsimony-informative 0.0833 +1467 keep parsimony-informative 0.0833 +1468 keep parsimony-informative 0.0833 +1469 keep parsimony-informative 0.0833 +1470 keep parsimony-informative 0.0833 +1471 keep parsimony-informative 0.0833 +1472 keep parsimony-informative 0.0833 +1473 keep parsimony-informative 0.0833 +1474 keep parsimony-informative 0.0833 +1475 keep parsimony-informative 0.0833 +1476 keep parsimony-informative 0.0833 +1477 keep parsimony-informative 0.0833 +1478 keep parsimony-informative 0.0833 +1479 keep parsimony-informative 0.0833 +1480 keep parsimony-informative 0.0833 +1481 keep parsimony-informative 0.0833 +1482 keep parsimony-informative 0.0833 1483 keep parsimony-informative 0.0 1484 keep parsimony-informative 0.0 1485 keep parsimony-informative 0.0 1486 keep parsimony-informative 0.0 1487 keep constant 0.0 1488 keep parsimony-informative 0.0 -1489 keep parsimony-informative 0.08333333333333333 -1490 keep parsimony-informative 0.08333333333333333 -1491 keep parsimony-informative 0.08333333333333333 -1492 keep parsimony-informative 0.08333333333333333 -1493 keep parsimony-informative 0.08333333333333333 -1494 keep parsimony-informative 0.08333333333333333 -1495 keep parsimony-informative 0.08333333333333333 -1496 keep parsimony-informative 0.08333333333333333 -1497 keep parsimony-informative 0.08333333333333333 +1489 keep parsimony-informative 0.0833 +1490 keep parsimony-informative 0.0833 +1491 keep parsimony-informative 0.0833 +1492 keep parsimony-informative 0.0833 +1493 keep parsimony-informative 0.0833 +1494 keep parsimony-informative 0.0833 +1495 keep parsimony-informative 0.0833 +1496 keep parsimony-informative 0.0833 +1497 keep parsimony-informative 0.0833 1498 keep parsimony-informative 0.5 1499 keep singleton 0.5 1500 keep parsimony-informative 0.5 -1501 keep parsimony-informative 0.08333333333333333 -1502 keep singleton 0.08333333333333333 -1503 keep parsimony-informative 0.08333333333333333 -1504 keep parsimony-informative 0.08333333333333333 -1505 keep constant 0.08333333333333333 -1506 keep parsimony-informative 0.08333333333333333 -1507 keep parsimony-informative 0.08333333333333333 -1508 keep parsimony-informative 0.08333333333333333 -1509 keep parsimony-informative 0.08333333333333333 -1510 keep parsimony-informative 0.08333333333333333 -1511 keep constant 0.08333333333333333 -1512 keep parsimony-informative 0.08333333333333333 -1513 keep parsimony-informative 0.08333333333333333 -1514 keep parsimony-informative 0.08333333333333333 -1515 keep parsimony-informative 0.08333333333333333 -1516 keep parsimony-informative 0.08333333333333333 -1517 keep parsimony-informative 0.08333333333333333 -1518 keep parsimony-informative 0.08333333333333333 -1519 keep parsimony-informative 0.08333333333333333 -1520 keep parsimony-informative 0.08333333333333333 -1521 keep parsimony-informative 0.08333333333333333 -1522 keep parsimony-informative 0.08333333333333333 -1523 keep parsimony-informative 0.08333333333333333 -1524 keep parsimony-informative 0.08333333333333333 -1525 keep parsimony-informative 0.16666666666666666 -1526 keep parsimony-informative 0.16666666666666666 -1527 keep parsimony-informative 0.16666666666666666 +1501 keep parsimony-informative 0.0833 +1502 keep singleton 0.0833 +1503 keep parsimony-informative 0.0833 +1504 keep parsimony-informative 0.0833 +1505 keep constant 0.0833 +1506 keep parsimony-informative 0.0833 +1507 keep parsimony-informative 0.0833 +1508 keep parsimony-informative 0.0833 +1509 keep parsimony-informative 0.0833 +1510 keep parsimony-informative 0.0833 +1511 keep constant 0.0833 +1512 keep parsimony-informative 0.0833 +1513 keep parsimony-informative 0.0833 +1514 keep parsimony-informative 0.0833 +1515 keep parsimony-informative 0.0833 +1516 keep parsimony-informative 0.0833 +1517 keep parsimony-informative 0.0833 +1518 keep parsimony-informative 0.0833 +1519 keep parsimony-informative 0.0833 +1520 keep parsimony-informative 0.0833 +1521 keep parsimony-informative 0.0833 +1522 keep parsimony-informative 0.0833 +1523 keep parsimony-informative 0.0833 +1524 keep parsimony-informative 0.0833 +1525 keep parsimony-informative 0.1667 +1526 keep parsimony-informative 0.1667 +1527 keep parsimony-informative 0.1667 1528 keep parsimony-informative 0.25 1529 keep parsimony-informative 0.25 1530 keep parsimony-informative 0.25 -1531 keep parsimony-informative 0.3333333333333333 -1532 keep parsimony-informative 0.3333333333333333 -1533 keep singleton 0.3333333333333333 -1534 keep parsimony-informative 0.3333333333333333 -1535 keep singleton 0.3333333333333333 -1536 keep parsimony-informative 0.3333333333333333 -1537 keep parsimony-informative 0.3333333333333333 -1538 keep singleton 0.3333333333333333 -1539 keep parsimony-informative 0.3333333333333333 -1540 keep parsimony-informative 0.5833333333333334 -1541 keep parsimony-informative 0.5833333333333334 -1542 keep singleton 0.5833333333333334 -1543 keep parsimony-informative 0.5833333333333334 -1544 keep singleton 0.5833333333333334 -1545 keep singleton 0.5833333333333334 -1546 keep constant 0.8333333333333334 -1547 keep other 0.8333333333333334 -1548 keep other 0.8333333333333334 -1549 keep other 0.8333333333333334 -1550 keep other 0.8333333333333334 -1551 keep other 0.8333333333333334 -1552 keep constant 0.8333333333333334 -1553 keep other 0.8333333333333334 -1554 keep other 0.8333333333333334 -1555 keep other 0.8333333333333334 -1556 keep constant 0.8333333333333334 -1557 keep other 0.8333333333333334 -1558 keep other 0.8333333333333334 -1559 keep constant 0.8333333333333334 -1560 keep other 0.8333333333333334 -1561 keep other 0.8333333333333334 -1562 keep other 0.8333333333333334 -1563 keep other 0.8333333333333334 -1564 keep other 0.8333333333333334 -1565 keep other 0.8333333333333334 -1566 keep constant 0.8333333333333334 -1567 keep other 0.8333333333333334 -1568 keep constant 0.8333333333333334 -1569 keep constant 0.8333333333333334 -1570 trim other 0.9166666666666666 -1571 trim other 0.9166666666666666 -1572 trim other 0.9166666666666666 -1573 trim other 0.9166666666666666 -1574 trim other 0.9166666666666666 -1575 trim other 0.9166666666666666 -1576 trim other 0.9166666666666666 -1577 trim other 0.9166666666666666 -1578 trim other 0.9166666666666666 -1579 trim other 0.9166666666666666 -1580 trim other 0.9166666666666666 -1581 trim other 0.9166666666666666 -1582 trim other 0.9166666666666666 -1583 trim other 0.9166666666666666 -1584 trim other 0.9166666666666666 -1585 trim other 0.9166666666666666 -1586 trim other 0.9166666666666666 -1587 trim other 0.9166666666666666 -1588 trim other 0.9166666666666666 -1589 trim other 0.9166666666666666 -1590 trim other 0.9166666666666666 -1591 trim other 0.9166666666666666 -1592 trim other 0.9166666666666666 -1593 trim other 0.9166666666666666 -1594 trim other 0.9166666666666666 -1595 trim other 0.9166666666666666 -1596 trim other 0.9166666666666666 -1597 trim other 0.9166666666666666 -1598 trim other 0.9166666666666666 -1599 trim other 0.9166666666666666 -1600 trim other 0.9166666666666666 -1601 trim other 0.9166666666666666 -1602 trim other 0.9166666666666666 -1603 trim other 0.9166666666666666 -1604 trim other 0.9166666666666666 -1605 trim other 0.9166666666666666 -1606 trim other 0.9166666666666666 -1607 trim other 0.9166666666666666 -1608 trim other 0.9166666666666666 -1609 trim other 0.9166666666666666 -1610 trim other 0.9166666666666666 -1611 trim other 0.9166666666666666 -1612 trim other 0.9166666666666666 -1613 trim other 0.9166666666666666 -1614 trim other 0.9166666666666666 -1615 trim other 0.9166666666666666 -1616 trim other 0.9166666666666666 -1617 trim other 0.9166666666666666 -1618 trim other 0.9166666666666666 -1619 trim other 0.9166666666666666 -1620 trim other 0.9166666666666666 -1621 trim other 0.9166666666666666 -1622 trim other 0.9166666666666666 -1623 trim other 0.9166666666666666 -1624 trim other 0.9166666666666666 -1625 trim other 0.9166666666666666 -1626 trim other 0.9166666666666666 -1627 trim other 0.9166666666666666 -1628 trim other 0.9166666666666666 -1629 trim other 0.9166666666666666 -1630 trim other 0.9166666666666666 -1631 trim other 0.9166666666666666 -1632 trim other 0.9166666666666666 -1633 trim other 0.9166666666666666 -1634 trim other 0.9166666666666666 -1635 trim other 0.9166666666666666 -1636 trim other 0.9166666666666666 -1637 trim other 0.9166666666666666 -1638 trim other 0.9166666666666666 -1639 trim other 0.9166666666666666 -1640 trim other 0.9166666666666666 -1641 trim other 0.9166666666666666 +1531 keep parsimony-informative 0.3333 +1532 keep parsimony-informative 0.3333 +1533 keep singleton 0.3333 +1534 keep parsimony-informative 0.3333 +1535 keep singleton 0.3333 +1536 keep parsimony-informative 0.3333 +1537 keep parsimony-informative 0.3333 +1538 keep singleton 0.3333 +1539 keep parsimony-informative 0.3333 +1540 keep parsimony-informative 0.5833 +1541 keep parsimony-informative 0.5833 +1542 keep singleton 0.5833 +1543 keep parsimony-informative 0.5833 +1544 keep singleton 0.5833 +1545 keep singleton 0.5833 +1546 keep constant 0.8333 +1547 keep other 0.8333 +1548 keep other 0.8333 +1549 keep other 0.8333 +1550 keep other 0.8333 +1551 keep other 0.8333 +1552 keep constant 0.8333 +1553 keep other 0.8333 +1554 keep other 0.8333 +1555 keep other 0.8333 +1556 keep constant 0.8333 +1557 keep other 0.8333 +1558 keep other 0.8333 +1559 keep constant 0.8333 +1560 keep other 0.8333 +1561 keep other 0.8333 +1562 keep other 0.8333 +1563 keep other 0.8333 +1564 keep other 0.8333 +1565 keep other 0.8333 +1566 keep constant 0.8333 +1567 keep other 0.8333 +1568 keep constant 0.8333 +1569 keep constant 0.8333 +1570 trim other 0.9167 +1571 trim other 0.9167 +1572 trim other 0.9167 +1573 trim other 0.9167 +1574 trim other 0.9167 +1575 trim other 0.9167 +1576 trim other 0.9167 +1577 trim other 0.9167 +1578 trim other 0.9167 +1579 trim other 0.9167 +1580 trim other 0.9167 +1581 trim other 0.9167 +1582 trim other 0.9167 +1583 trim other 0.9167 +1584 trim other 0.9167 +1585 trim other 0.9167 +1586 trim other 0.9167 +1587 trim other 0.9167 +1588 trim other 0.9167 +1589 trim other 0.9167 +1590 trim other 0.9167 +1591 trim other 0.9167 +1592 trim other 0.9167 +1593 trim other 0.9167 +1594 trim other 0.9167 +1595 trim other 0.9167 +1596 trim other 0.9167 +1597 trim other 0.9167 +1598 trim other 0.9167 +1599 trim other 0.9167 +1600 trim other 0.9167 +1601 trim other 0.9167 +1602 trim other 0.9167 +1603 trim other 0.9167 +1604 trim other 0.9167 +1605 trim other 0.9167 +1606 trim other 0.9167 +1607 trim other 0.9167 +1608 trim other 0.9167 +1609 trim other 0.9167 +1610 trim other 0.9167 +1611 trim other 0.9167 +1612 trim other 0.9167 +1613 trim other 0.9167 +1614 trim other 0.9167 +1615 trim other 0.9167 +1616 trim other 0.9167 +1617 trim other 0.9167 +1618 trim other 0.9167 +1619 trim other 0.9167 +1620 trim other 0.9167 +1621 trim other 0.9167 +1622 trim other 0.9167 +1623 trim other 0.9167 +1624 trim other 0.9167 +1625 trim other 0.9167 +1626 trim other 0.9167 +1627 trim other 0.9167 +1628 trim other 0.9167 +1629 trim other 0.9167 +1630 trim other 0.9167 +1631 trim other 0.9167 +1632 trim other 0.9167 +1633 trim other 0.9167 +1634 trim other 0.9167 +1635 trim other 0.9167 +1636 trim other 0.9167 +1637 trim other 0.9167 +1638 trim other 0.9167 +1639 trim other 0.9167 +1640 trim other 0.9167 +1641 trim other 0.9167 1642 keep other 0.75 1643 keep other 0.75 1644 keep singleton 0.75 @@ -1648,75 +1648,75 @@ 1648 keep parsimony-informative 0.25 1649 keep parsimony-informative 0.25 1650 keep parsimony-informative 0.25 -1651 keep parsimony-informative 0.08333333333333333 -1652 keep parsimony-informative 0.08333333333333333 -1653 keep parsimony-informative 0.08333333333333333 -1654 keep parsimony-informative 0.08333333333333333 -1655 keep parsimony-informative 0.08333333333333333 -1656 keep parsimony-informative 0.08333333333333333 -1657 keep parsimony-informative 0.08333333333333333 -1658 keep singleton 0.08333333333333333 -1659 keep parsimony-informative 0.08333333333333333 -1660 keep singleton 0.08333333333333333 -1661 keep parsimony-informative 0.08333333333333333 -1662 keep parsimony-informative 0.08333333333333333 -1663 keep singleton 0.08333333333333333 -1664 keep parsimony-informative 0.08333333333333333 -1665 keep parsimony-informative 0.08333333333333333 -1666 keep parsimony-informative 0.08333333333333333 -1667 keep parsimony-informative 0.08333333333333333 -1668 keep parsimony-informative 0.08333333333333333 -1669 keep parsimony-informative 0.08333333333333333 -1670 keep parsimony-informative 0.08333333333333333 -1671 keep parsimony-informative 0.08333333333333333 -1672 keep parsimony-informative 0.08333333333333333 -1673 keep parsimony-informative 0.08333333333333333 -1674 keep parsimony-informative 0.08333333333333333 -1675 keep parsimony-informative 0.08333333333333333 -1676 keep parsimony-informative 0.08333333333333333 -1677 keep parsimony-informative 0.08333333333333333 -1678 keep parsimony-informative 0.08333333333333333 -1679 keep parsimony-informative 0.08333333333333333 -1680 keep parsimony-informative 0.08333333333333333 -1681 keep parsimony-informative 0.08333333333333333 -1682 keep parsimony-informative 0.08333333333333333 -1683 keep parsimony-informative 0.08333333333333333 -1684 keep parsimony-informative 0.08333333333333333 -1685 keep parsimony-informative 0.08333333333333333 -1686 keep parsimony-informative 0.08333333333333333 -1687 keep singleton 0.5833333333333334 -1688 keep parsimony-informative 0.5833333333333334 -1689 keep parsimony-informative 0.5833333333333334 -1690 keep parsimony-informative 0.5833333333333334 -1691 keep parsimony-informative 0.5833333333333334 -1692 keep singleton 0.5833333333333334 -1693 keep singleton 0.5833333333333334 -1694 keep constant 0.5833333333333334 -1695 keep singleton 0.5833333333333334 -1696 keep singleton 0.5833333333333334 -1697 keep parsimony-informative 0.5833333333333334 -1698 keep parsimony-informative 0.5833333333333334 -1699 keep singleton 0.6666666666666666 -1700 keep singleton 0.6666666666666666 -1701 keep singleton 0.6666666666666666 -1702 keep parsimony-informative 0.6666666666666666 -1703 keep singleton 0.6666666666666666 -1704 keep singleton 0.6666666666666666 +1651 keep parsimony-informative 0.0833 +1652 keep parsimony-informative 0.0833 +1653 keep parsimony-informative 0.0833 +1654 keep parsimony-informative 0.0833 +1655 keep parsimony-informative 0.0833 +1656 keep parsimony-informative 0.0833 +1657 keep parsimony-informative 0.0833 +1658 keep singleton 0.0833 +1659 keep parsimony-informative 0.0833 +1660 keep singleton 0.0833 +1661 keep parsimony-informative 0.0833 +1662 keep parsimony-informative 0.0833 +1663 keep singleton 0.0833 +1664 keep parsimony-informative 0.0833 +1665 keep parsimony-informative 0.0833 +1666 keep parsimony-informative 0.0833 +1667 keep parsimony-informative 0.0833 +1668 keep parsimony-informative 0.0833 +1669 keep parsimony-informative 0.0833 +1670 keep parsimony-informative 0.0833 +1671 keep parsimony-informative 0.0833 +1672 keep parsimony-informative 0.0833 +1673 keep parsimony-informative 0.0833 +1674 keep parsimony-informative 0.0833 +1675 keep parsimony-informative 0.0833 +1676 keep parsimony-informative 0.0833 +1677 keep parsimony-informative 0.0833 +1678 keep parsimony-informative 0.0833 +1679 keep parsimony-informative 0.0833 +1680 keep parsimony-informative 0.0833 +1681 keep parsimony-informative 0.0833 +1682 keep parsimony-informative 0.0833 +1683 keep parsimony-informative 0.0833 +1684 keep parsimony-informative 0.0833 +1685 keep parsimony-informative 0.0833 +1686 keep parsimony-informative 0.0833 +1687 keep singleton 0.5833 +1688 keep parsimony-informative 0.5833 +1689 keep parsimony-informative 0.5833 +1690 keep parsimony-informative 0.5833 +1691 keep parsimony-informative 0.5833 +1692 keep singleton 0.5833 +1693 keep singleton 0.5833 +1694 keep constant 0.5833 +1695 keep singleton 0.5833 +1696 keep singleton 0.5833 +1697 keep parsimony-informative 0.5833 +1698 keep parsimony-informative 0.5833 +1699 keep singleton 0.6667 +1700 keep singleton 0.6667 +1701 keep singleton 0.6667 +1702 keep parsimony-informative 0.6667 +1703 keep singleton 0.6667 +1704 keep singleton 0.6667 1705 keep singleton 0.75 1706 keep other 0.75 1707 keep singleton 0.75 -1708 trim other 0.9166666666666666 -1709 trim other 0.9166666666666666 -1710 trim other 0.9166666666666666 -1711 trim other 0.9166666666666666 -1712 trim other 0.9166666666666666 -1713 trim other 0.9166666666666666 -1714 keep other 0.8333333333333334 -1715 keep other 0.8333333333333334 -1716 keep constant 0.8333333333333334 -1717 keep singleton 0.5833333333333334 -1718 keep parsimony-informative 0.5833333333333334 -1719 keep parsimony-informative 0.5833333333333334 +1708 trim other 0.9167 +1709 trim other 0.9167 +1710 trim other 0.9167 +1711 trim other 0.9167 +1712 trim other 0.9167 +1713 trim other 0.9167 +1714 keep other 0.8333 +1715 keep other 0.8333 +1716 keep constant 0.8333 +1717 keep singleton 0.5833 +1718 keep parsimony-informative 0.5833 +1719 keep parsimony-informative 0.5833 1720 keep parsimony-informative 0.25 1721 keep parsimony-informative 0.25 1722 keep parsimony-informative 0.25 @@ -1735,42 +1735,42 @@ 1735 keep parsimony-informative 0.25 1736 keep parsimony-informative 0.25 1737 keep parsimony-informative 0.25 -1738 keep constant 0.5833333333333334 -1739 keep singleton 0.5833333333333334 -1740 keep singleton 0.5833333333333334 -1741 keep singleton 0.5833333333333334 -1742 keep singleton 0.5833333333333334 -1743 keep parsimony-informative 0.5833333333333334 -1744 keep singleton 0.5833333333333334 -1745 keep parsimony-informative 0.5833333333333334 -1746 keep singleton 0.5833333333333334 -1747 keep constant 0.8333333333333334 -1748 keep constant 0.8333333333333334 -1749 keep other 0.8333333333333334 -1750 trim other 0.9166666666666666 -1751 trim other 0.9166666666666666 -1752 trim other 0.9166666666666666 -1753 trim other 0.9166666666666666 -1754 trim other 0.9166666666666666 -1755 trim other 0.9166666666666666 -1756 trim other 0.9166666666666666 -1757 trim other 0.9166666666666666 -1758 trim other 0.9166666666666666 -1759 trim other 0.9166666666666666 -1760 trim other 0.9166666666666666 -1761 trim other 0.9166666666666666 -1762 keep other 0.8333333333333334 -1763 keep constant 0.8333333333333334 -1764 keep constant 0.8333333333333334 -1765 keep parsimony-informative 0.08333333333333333 -1766 keep parsimony-informative 0.08333333333333333 -1767 keep parsimony-informative 0.08333333333333333 -1768 keep parsimony-informative 0.08333333333333333 -1769 keep parsimony-informative 0.08333333333333333 -1770 keep parsimony-informative 0.08333333333333333 -1771 keep parsimony-informative 0.08333333333333333 -1772 keep parsimony-informative 0.08333333333333333 -1773 keep parsimony-informative 0.08333333333333333 +1738 keep constant 0.5833 +1739 keep singleton 0.5833 +1740 keep singleton 0.5833 +1741 keep singleton 0.5833 +1742 keep singleton 0.5833 +1743 keep parsimony-informative 0.5833 +1744 keep singleton 0.5833 +1745 keep parsimony-informative 0.5833 +1746 keep singleton 0.5833 +1747 keep constant 0.8333 +1748 keep constant 0.8333 +1749 keep other 0.8333 +1750 trim other 0.9167 +1751 trim other 0.9167 +1752 trim other 0.9167 +1753 trim other 0.9167 +1754 trim other 0.9167 +1755 trim other 0.9167 +1756 trim other 0.9167 +1757 trim other 0.9167 +1758 trim other 0.9167 +1759 trim other 0.9167 +1760 trim other 0.9167 +1761 trim other 0.9167 +1762 keep other 0.8333 +1763 keep constant 0.8333 +1764 keep constant 0.8333 +1765 keep parsimony-informative 0.0833 +1766 keep parsimony-informative 0.0833 +1767 keep parsimony-informative 0.0833 +1768 keep parsimony-informative 0.0833 +1769 keep parsimony-informative 0.0833 +1770 keep parsimony-informative 0.0833 +1771 keep parsimony-informative 0.0833 +1772 keep parsimony-informative 0.0833 +1773 keep parsimony-informative 0.0833 1774 keep parsimony-informative 0.0 1775 keep parsimony-informative 0.0 1776 keep parsimony-informative 0.0 @@ -1783,24 +1783,24 @@ 1783 keep parsimony-informative 0.0 1784 keep parsimony-informative 0.0 1785 keep parsimony-informative 0.0 -1786 keep other 0.8333333333333334 -1787 keep other 0.8333333333333334 -1788 keep other 0.8333333333333334 -1789 trim other 0.9166666666666666 -1790 trim other 0.9166666666666666 -1791 trim other 0.9166666666666666 -1792 keep parsimony-informative 0.08333333333333333 -1793 keep parsimony-informative 0.08333333333333333 -1794 keep parsimony-informative 0.08333333333333333 -1795 keep parsimony-informative 0.08333333333333333 -1796 keep parsimony-informative 0.08333333333333333 -1797 keep parsimony-informative 0.08333333333333333 -1798 keep singleton 0.08333333333333333 -1799 keep parsimony-informative 0.08333333333333333 -1800 keep parsimony-informative 0.08333333333333333 -1801 keep parsimony-informative 0.08333333333333333 -1802 keep parsimony-informative 0.08333333333333333 -1803 keep parsimony-informative 0.08333333333333333 +1786 keep other 0.8333 +1787 keep other 0.8333 +1788 keep other 0.8333 +1789 trim other 0.9167 +1790 trim other 0.9167 +1791 trim other 0.9167 +1792 keep parsimony-informative 0.0833 +1793 keep parsimony-informative 0.0833 +1794 keep parsimony-informative 0.0833 +1795 keep parsimony-informative 0.0833 +1796 keep parsimony-informative 0.0833 +1797 keep parsimony-informative 0.0833 +1798 keep singleton 0.0833 +1799 keep parsimony-informative 0.0833 +1800 keep parsimony-informative 0.0833 +1801 keep parsimony-informative 0.0833 +1802 keep parsimony-informative 0.0833 +1803 keep parsimony-informative 0.0833 1804 keep parsimony-informative 0.0 1805 keep constant 0.0 1806 keep parsimony-informative 0.0 @@ -1843,9 +1843,9 @@ 1843 keep parsimony-informative 0.0 1844 keep parsimony-informative 0.0 1845 keep parsimony-informative 0.0 -1846 keep constant 0.8333333333333334 -1847 keep other 0.8333333333333334 -1848 keep other 0.8333333333333334 +1846 keep constant 0.8333 +1847 keep other 0.8333 +1848 keep other 0.8333 1849 keep singleton 0.5 1850 keep constant 0.5 1851 keep parsimony-informative 0.5 @@ -1855,96 +1855,96 @@ 1855 keep singleton 0.5 1856 keep singleton 0.5 1857 keep parsimony-informative 0.5 -1858 keep other 0.8333333333333334 -1859 keep other 0.8333333333333334 -1860 keep other 0.8333333333333334 -1861 trim other 0.9166666666666666 -1862 trim other 0.9166666666666666 -1863 trim other 0.9166666666666666 -1864 trim other 0.9166666666666666 -1865 trim other 0.9166666666666666 -1866 trim other 0.9166666666666666 -1867 trim other 0.9166666666666666 -1868 trim other 0.9166666666666666 -1869 trim other 0.9166666666666666 -1870 keep singleton 0.4166666666666667 -1871 keep singleton 0.4166666666666667 -1872 keep parsimony-informative 0.4166666666666667 -1873 keep singleton 0.4166666666666667 -1874 keep singleton 0.4166666666666667 -1875 keep singleton 0.4166666666666667 +1858 keep other 0.8333 +1859 keep other 0.8333 +1860 keep other 0.8333 +1861 trim other 0.9167 +1862 trim other 0.9167 +1863 trim other 0.9167 +1864 trim other 0.9167 +1865 trim other 0.9167 +1866 trim other 0.9167 +1867 trim other 0.9167 +1868 trim other 0.9167 +1869 trim other 0.9167 +1870 keep singleton 0.4167 +1871 keep singleton 0.4167 +1872 keep parsimony-informative 0.4167 +1873 keep singleton 0.4167 +1874 keep singleton 0.4167 +1875 keep singleton 0.4167 1876 keep parsimony-informative 0.25 1877 keep parsimony-informative 0.25 1878 keep singleton 0.25 -1879 keep parsimony-informative 0.16666666666666666 -1880 keep parsimony-informative 0.16666666666666666 -1881 keep singleton 0.16666666666666666 -1882 keep parsimony-informative 0.16666666666666666 -1883 keep parsimony-informative 0.16666666666666666 -1884 keep parsimony-informative 0.16666666666666666 -1885 keep parsimony-informative 0.16666666666666666 -1886 keep parsimony-informative 0.16666666666666666 -1887 keep parsimony-informative 0.16666666666666666 -1888 keep parsimony-informative 0.16666666666666666 -1889 keep parsimony-informative 0.16666666666666666 -1890 keep parsimony-informative 0.16666666666666666 -1891 keep parsimony-informative 0.16666666666666666 -1892 keep parsimony-informative 0.16666666666666666 -1893 keep parsimony-informative 0.16666666666666666 -1894 keep singleton 0.16666666666666666 -1895 keep singleton 0.16666666666666666 -1896 keep parsimony-informative 0.16666666666666666 -1897 keep parsimony-informative 0.08333333333333333 -1898 keep parsimony-informative 0.08333333333333333 -1899 keep parsimony-informative 0.08333333333333333 -1900 keep parsimony-informative 0.08333333333333333 -1901 keep constant 0.08333333333333333 -1902 keep parsimony-informative 0.08333333333333333 -1903 keep parsimony-informative 0.08333333333333333 -1904 keep parsimony-informative 0.08333333333333333 -1905 keep parsimony-informative 0.08333333333333333 -1906 keep singleton 0.08333333333333333 -1907 keep parsimony-informative 0.08333333333333333 -1908 keep parsimony-informative 0.08333333333333333 -1909 keep singleton 0.4166666666666667 -1910 keep constant 0.4166666666666667 -1911 keep singleton 0.4166666666666667 -1912 keep parsimony-informative 0.4166666666666667 -1913 keep singleton 0.4166666666666667 -1914 keep singleton 0.4166666666666667 -1915 keep singleton 0.4166666666666667 -1916 keep parsimony-informative 0.4166666666666667 -1917 keep parsimony-informative 0.4166666666666667 -1918 keep parsimony-informative 0.4166666666666667 -1919 keep singleton 0.4166666666666667 -1920 keep parsimony-informative 0.4166666666666667 -1921 keep parsimony-informative 0.4166666666666667 -1922 keep constant 0.4166666666666667 -1923 keep parsimony-informative 0.4166666666666667 -1924 keep singleton 0.4166666666666667 -1925 keep parsimony-informative 0.4166666666666667 -1926 keep parsimony-informative 0.4166666666666667 -1927 keep parsimony-informative 0.4166666666666667 -1928 keep singleton 0.4166666666666667 -1929 keep parsimony-informative 0.4166666666666667 -1930 keep singleton 0.4166666666666667 -1931 keep singleton 0.4166666666666667 -1932 keep parsimony-informative 0.4166666666666667 +1879 keep parsimony-informative 0.1667 +1880 keep parsimony-informative 0.1667 +1881 keep singleton 0.1667 +1882 keep parsimony-informative 0.1667 +1883 keep parsimony-informative 0.1667 +1884 keep parsimony-informative 0.1667 +1885 keep parsimony-informative 0.1667 +1886 keep parsimony-informative 0.1667 +1887 keep parsimony-informative 0.1667 +1888 keep parsimony-informative 0.1667 +1889 keep parsimony-informative 0.1667 +1890 keep parsimony-informative 0.1667 +1891 keep parsimony-informative 0.1667 +1892 keep parsimony-informative 0.1667 +1893 keep parsimony-informative 0.1667 +1894 keep singleton 0.1667 +1895 keep singleton 0.1667 +1896 keep parsimony-informative 0.1667 +1897 keep parsimony-informative 0.0833 +1898 keep parsimony-informative 0.0833 +1899 keep parsimony-informative 0.0833 +1900 keep parsimony-informative 0.0833 +1901 keep constant 0.0833 +1902 keep parsimony-informative 0.0833 +1903 keep parsimony-informative 0.0833 +1904 keep parsimony-informative 0.0833 +1905 keep parsimony-informative 0.0833 +1906 keep singleton 0.0833 +1907 keep parsimony-informative 0.0833 +1908 keep parsimony-informative 0.0833 +1909 keep singleton 0.4167 +1910 keep constant 0.4167 +1911 keep singleton 0.4167 +1912 keep parsimony-informative 0.4167 +1913 keep singleton 0.4167 +1914 keep singleton 0.4167 +1915 keep singleton 0.4167 +1916 keep parsimony-informative 0.4167 +1917 keep parsimony-informative 0.4167 +1918 keep parsimony-informative 0.4167 +1919 keep singleton 0.4167 +1920 keep parsimony-informative 0.4167 +1921 keep parsimony-informative 0.4167 +1922 keep constant 0.4167 +1923 keep parsimony-informative 0.4167 +1924 keep singleton 0.4167 +1925 keep parsimony-informative 0.4167 +1926 keep parsimony-informative 0.4167 +1927 keep parsimony-informative 0.4167 +1928 keep singleton 0.4167 +1929 keep parsimony-informative 0.4167 +1930 keep singleton 0.4167 +1931 keep singleton 0.4167 +1932 keep parsimony-informative 0.4167 1933 keep singleton 0.5 1934 keep singleton 0.5 1935 keep singleton 0.5 1936 keep singleton 0.5 1937 keep parsimony-informative 0.5 1938 keep parsimony-informative 0.5 -1939 keep singleton 0.08333333333333333 -1940 keep parsimony-informative 0.08333333333333333 -1941 keep parsimony-informative 0.08333333333333333 -1942 keep parsimony-informative 0.08333333333333333 -1943 keep parsimony-informative 0.08333333333333333 -1944 keep parsimony-informative 0.08333333333333333 -1945 keep parsimony-informative 0.08333333333333333 -1946 keep parsimony-informative 0.08333333333333333 -1947 keep singleton 0.08333333333333333 +1939 keep singleton 0.0833 +1940 keep parsimony-informative 0.0833 +1941 keep parsimony-informative 0.0833 +1942 keep parsimony-informative 0.0833 +1943 keep parsimony-informative 0.0833 +1944 keep parsimony-informative 0.0833 +1945 keep parsimony-informative 0.0833 +1946 keep parsimony-informative 0.0833 +1947 keep singleton 0.0833 1948 keep constant 0.0 1949 keep constant 0.0 1950 keep parsimony-informative 0.0 @@ -1981,63 +1981,63 @@ 1981 keep singleton 0.75 1982 keep other 0.75 1983 keep singleton 0.75 -1984 trim other 0.9166666666666666 -1985 trim other 0.9166666666666666 -1986 trim other 0.9166666666666666 -1987 trim other 0.9166666666666666 -1988 trim other 0.9166666666666666 -1989 trim other 0.9166666666666666 -1990 trim other 0.9166666666666666 -1991 trim other 0.9166666666666666 -1992 trim other 0.9166666666666666 -1993 trim other 0.9166666666666666 -1994 trim other 0.9166666666666666 -1995 trim other 0.9166666666666666 -1996 trim other 0.9166666666666666 -1997 trim other 0.9166666666666666 -1998 trim other 0.9166666666666666 -1999 trim other 0.9166666666666666 -2000 trim other 0.9166666666666666 -2001 trim other 0.9166666666666666 +1984 trim other 0.9167 +1985 trim other 0.9167 +1986 trim other 0.9167 +1987 trim other 0.9167 +1988 trim other 0.9167 +1989 trim other 0.9167 +1990 trim other 0.9167 +1991 trim other 0.9167 +1992 trim other 0.9167 +1993 trim other 0.9167 +1994 trim other 0.9167 +1995 trim other 0.9167 +1996 trim other 0.9167 +1997 trim other 0.9167 +1998 trim other 0.9167 +1999 trim other 0.9167 +2000 trim other 0.9167 +2001 trim other 0.9167 2002 keep parsimony-informative 0.25 2003 keep parsimony-informative 0.25 2004 keep singleton 0.25 2005 keep singleton 0.25 2006 keep singleton 0.25 2007 keep parsimony-informative 0.25 -2008 trim other 0.9166666666666666 -2009 trim other 0.9166666666666666 -2010 trim other 0.9166666666666666 -2011 trim other 0.9166666666666666 -2012 trim other 0.9166666666666666 -2013 trim other 0.9166666666666666 -2014 keep other 0.8333333333333334 -2015 keep other 0.8333333333333334 -2016 keep other 0.8333333333333334 -2017 keep constant 0.8333333333333334 -2018 keep other 0.8333333333333334 -2019 keep other 0.8333333333333334 -2020 keep other 0.8333333333333334 -2021 keep constant 0.8333333333333334 -2022 keep other 0.8333333333333334 -2023 keep other 0.8333333333333334 -2024 keep constant 0.8333333333333334 -2025 keep other 0.8333333333333334 -2026 keep constant 0.8333333333333334 -2027 keep constant 0.8333333333333334 -2028 keep constant 0.8333333333333334 -2029 keep other 0.8333333333333334 -2030 keep constant 0.8333333333333334 -2031 keep constant 0.8333333333333334 -2032 keep constant 0.8333333333333334 -2033 keep constant 0.8333333333333334 -2034 keep other 0.8333333333333334 -2035 keep other 0.8333333333333334 -2036 keep other 0.8333333333333334 -2037 keep other 0.8333333333333334 -2038 keep other 0.8333333333333334 -2039 keep constant 0.8333333333333334 -2040 keep other 0.8333333333333334 +2008 trim other 0.9167 +2009 trim other 0.9167 +2010 trim other 0.9167 +2011 trim other 0.9167 +2012 trim other 0.9167 +2013 trim other 0.9167 +2014 keep other 0.8333 +2015 keep other 0.8333 +2016 keep other 0.8333 +2017 keep constant 0.8333 +2018 keep other 0.8333 +2019 keep other 0.8333 +2020 keep other 0.8333 +2021 keep constant 0.8333 +2022 keep other 0.8333 +2023 keep other 0.8333 +2024 keep constant 0.8333 +2025 keep other 0.8333 +2026 keep constant 0.8333 +2027 keep constant 0.8333 +2028 keep constant 0.8333 +2029 keep other 0.8333 +2030 keep constant 0.8333 +2031 keep constant 0.8333 +2032 keep constant 0.8333 +2033 keep constant 0.8333 +2034 keep other 0.8333 +2035 keep other 0.8333 +2036 keep other 0.8333 +2037 keep other 0.8333 +2038 keep other 0.8333 +2039 keep constant 0.8333 +2040 keep other 0.8333 2041 keep singleton 0.75 2042 keep singleton 0.75 2043 keep singleton 0.75 @@ -2053,144 +2053,144 @@ 2053 keep constant 0.75 2054 keep singleton 0.75 2055 keep singleton 0.75 -2056 trim other 0.9166666666666666 -2057 trim other 0.9166666666666666 -2058 trim other 0.9166666666666666 -2059 trim other 0.9166666666666666 -2060 trim other 0.9166666666666666 -2061 trim other 0.9166666666666666 -2062 trim other 0.9166666666666666 -2063 trim other 0.9166666666666666 -2064 trim other 0.9166666666666666 -2065 trim other 0.9166666666666666 -2066 trim other 0.9166666666666666 -2067 trim other 0.9166666666666666 -2068 trim other 0.9166666666666666 -2069 trim other 0.9166666666666666 -2070 trim other 0.9166666666666666 -2071 trim other 0.9166666666666666 -2072 trim other 0.9166666666666666 -2073 trim other 0.9166666666666666 +2056 trim other 0.9167 +2057 trim other 0.9167 +2058 trim other 0.9167 +2059 trim other 0.9167 +2060 trim other 0.9167 +2061 trim other 0.9167 +2062 trim other 0.9167 +2063 trim other 0.9167 +2064 trim other 0.9167 +2065 trim other 0.9167 +2066 trim other 0.9167 +2067 trim other 0.9167 +2068 trim other 0.9167 +2069 trim other 0.9167 +2070 trim other 0.9167 +2071 trim other 0.9167 +2072 trim other 0.9167 +2073 trim other 0.9167 2074 keep singleton 0.75 2075 keep singleton 0.75 2076 keep singleton 0.75 -2077 keep parsimony-informative 0.4166666666666667 -2078 keep singleton 0.4166666666666667 -2079 keep parsimony-informative 0.4166666666666667 -2080 keep parsimony-informative 0.4166666666666667 -2081 keep singleton 0.4166666666666667 -2082 keep parsimony-informative 0.4166666666666667 -2083 keep parsimony-informative 0.4166666666666667 -2084 keep singleton 0.4166666666666667 -2085 keep parsimony-informative 0.4166666666666667 -2086 keep singleton 0.5833333333333334 -2087 keep singleton 0.5833333333333334 -2088 keep singleton 0.5833333333333334 -2089 keep singleton 0.5833333333333334 -2090 keep singleton 0.5833333333333334 -2091 keep parsimony-informative 0.5833333333333334 -2092 keep constant 0.5833333333333334 -2093 keep constant 0.5833333333333334 -2094 keep parsimony-informative 0.5833333333333334 -2095 keep constant 0.5833333333333334 -2096 keep constant 0.5833333333333334 -2097 keep singleton 0.5833333333333334 -2098 keep constant 0.5833333333333334 -2099 keep singleton 0.5833333333333334 -2100 keep singleton 0.5833333333333334 -2101 keep singleton 0.08333333333333333 -2102 keep parsimony-informative 0.08333333333333333 -2103 keep parsimony-informative 0.08333333333333333 -2104 keep parsimony-informative 0.08333333333333333 -2105 keep constant 0.08333333333333333 -2106 keep parsimony-informative 0.08333333333333333 -2107 keep parsimony-informative 0.08333333333333333 -2108 keep singleton 0.08333333333333333 -2109 keep parsimony-informative 0.08333333333333333 -2110 keep constant 0.08333333333333333 -2111 keep constant 0.08333333333333333 -2112 keep parsimony-informative 0.08333333333333333 -2113 keep singleton 0.08333333333333333 -2114 keep singleton 0.08333333333333333 -2115 keep parsimony-informative 0.08333333333333333 -2116 keep parsimony-informative 0.08333333333333333 -2117 keep parsimony-informative 0.08333333333333333 -2118 keep parsimony-informative 0.08333333333333333 -2119 keep parsimony-informative 0.16666666666666666 -2120 keep singleton 0.16666666666666666 -2121 keep parsimony-informative 0.16666666666666666 -2122 keep parsimony-informative 0.16666666666666666 -2123 keep singleton 0.16666666666666666 -2124 keep parsimony-informative 0.16666666666666666 -2125 keep singleton 0.16666666666666666 -2126 keep singleton 0.16666666666666666 -2127 keep parsimony-informative 0.16666666666666666 -2128 keep constant 0.16666666666666666 -2129 keep singleton 0.16666666666666666 -2130 keep parsimony-informative 0.16666666666666666 -2131 keep parsimony-informative 0.16666666666666666 -2132 keep parsimony-informative 0.16666666666666666 -2133 keep parsimony-informative 0.16666666666666666 -2134 keep parsimony-informative 0.16666666666666666 -2135 keep parsimony-informative 0.16666666666666666 -2136 keep parsimony-informative 0.16666666666666666 -2137 keep parsimony-informative 0.16666666666666666 -2138 keep parsimony-informative 0.16666666666666666 -2139 keep parsimony-informative 0.16666666666666666 -2140 keep parsimony-informative 0.08333333333333333 -2141 keep parsimony-informative 0.08333333333333333 -2142 keep parsimony-informative 0.08333333333333333 -2143 keep singleton 0.4166666666666667 -2144 keep singleton 0.4166666666666667 -2145 keep parsimony-informative 0.4166666666666667 -2146 keep parsimony-informative 0.4166666666666667 -2147 keep parsimony-informative 0.4166666666666667 -2148 keep parsimony-informative 0.4166666666666667 -2149 keep parsimony-informative 0.3333333333333333 -2150 keep constant 0.3333333333333333 -2151 keep parsimony-informative 0.3333333333333333 -2152 keep parsimony-informative 0.3333333333333333 -2153 keep parsimony-informative 0.3333333333333333 -2154 keep parsimony-informative 0.3333333333333333 -2155 keep parsimony-informative 0.3333333333333333 -2156 keep singleton 0.3333333333333333 -2157 keep parsimony-informative 0.3333333333333333 -2158 keep parsimony-informative 0.3333333333333333 -2159 keep parsimony-informative 0.3333333333333333 -2160 keep parsimony-informative 0.3333333333333333 -2161 keep singleton 0.3333333333333333 -2162 keep singleton 0.3333333333333333 -2163 keep parsimony-informative 0.3333333333333333 -2164 keep constant 0.8333333333333334 -2165 keep other 0.8333333333333334 -2166 keep other 0.8333333333333334 -2167 keep other 0.8333333333333334 -2168 keep constant 0.8333333333333334 -2169 keep other 0.8333333333333334 -2170 trim other 0.9166666666666666 -2171 trim other 0.9166666666666666 -2172 trim other 0.9166666666666666 -2173 trim other 0.9166666666666666 -2174 trim other 0.9166666666666666 -2175 trim other 0.9166666666666666 -2176 trim other 0.9166666666666666 -2177 trim other 0.9166666666666666 -2178 trim other 0.9166666666666666 -2179 trim other 0.9166666666666666 -2180 trim other 0.9166666666666666 -2181 trim other 0.9166666666666666 -2182 trim other 0.9166666666666666 -2183 trim other 0.9166666666666666 -2184 trim other 0.9166666666666666 -2185 trim other 0.9166666666666666 -2186 trim other 0.9166666666666666 -2187 trim other 0.9166666666666666 -2188 trim other 0.9166666666666666 -2189 trim other 0.9166666666666666 -2190 trim other 0.9166666666666666 -2191 trim other 0.9166666666666666 -2192 trim other 0.9166666666666666 -2193 trim other 0.9166666666666666 +2077 keep parsimony-informative 0.4167 +2078 keep singleton 0.4167 +2079 keep parsimony-informative 0.4167 +2080 keep parsimony-informative 0.4167 +2081 keep singleton 0.4167 +2082 keep parsimony-informative 0.4167 +2083 keep parsimony-informative 0.4167 +2084 keep singleton 0.4167 +2085 keep parsimony-informative 0.4167 +2086 keep singleton 0.5833 +2087 keep singleton 0.5833 +2088 keep singleton 0.5833 +2089 keep singleton 0.5833 +2090 keep singleton 0.5833 +2091 keep parsimony-informative 0.5833 +2092 keep constant 0.5833 +2093 keep constant 0.5833 +2094 keep parsimony-informative 0.5833 +2095 keep constant 0.5833 +2096 keep constant 0.5833 +2097 keep singleton 0.5833 +2098 keep constant 0.5833 +2099 keep singleton 0.5833 +2100 keep singleton 0.5833 +2101 keep singleton 0.0833 +2102 keep parsimony-informative 0.0833 +2103 keep parsimony-informative 0.0833 +2104 keep parsimony-informative 0.0833 +2105 keep constant 0.0833 +2106 keep parsimony-informative 0.0833 +2107 keep parsimony-informative 0.0833 +2108 keep singleton 0.0833 +2109 keep parsimony-informative 0.0833 +2110 keep constant 0.0833 +2111 keep constant 0.0833 +2112 keep parsimony-informative 0.0833 +2113 keep singleton 0.0833 +2114 keep singleton 0.0833 +2115 keep parsimony-informative 0.0833 +2116 keep parsimony-informative 0.0833 +2117 keep parsimony-informative 0.0833 +2118 keep parsimony-informative 0.0833 +2119 keep parsimony-informative 0.1667 +2120 keep singleton 0.1667 +2121 keep parsimony-informative 0.1667 +2122 keep parsimony-informative 0.1667 +2123 keep singleton 0.1667 +2124 keep parsimony-informative 0.1667 +2125 keep singleton 0.1667 +2126 keep singleton 0.1667 +2127 keep parsimony-informative 0.1667 +2128 keep constant 0.1667 +2129 keep singleton 0.1667 +2130 keep parsimony-informative 0.1667 +2131 keep parsimony-informative 0.1667 +2132 keep parsimony-informative 0.1667 +2133 keep parsimony-informative 0.1667 +2134 keep parsimony-informative 0.1667 +2135 keep parsimony-informative 0.1667 +2136 keep parsimony-informative 0.1667 +2137 keep parsimony-informative 0.1667 +2138 keep parsimony-informative 0.1667 +2139 keep parsimony-informative 0.1667 +2140 keep parsimony-informative 0.0833 +2141 keep parsimony-informative 0.0833 +2142 keep parsimony-informative 0.0833 +2143 keep singleton 0.4167 +2144 keep singleton 0.4167 +2145 keep parsimony-informative 0.4167 +2146 keep parsimony-informative 0.4167 +2147 keep parsimony-informative 0.4167 +2148 keep parsimony-informative 0.4167 +2149 keep parsimony-informative 0.3333 +2150 keep constant 0.3333 +2151 keep parsimony-informative 0.3333 +2152 keep parsimony-informative 0.3333 +2153 keep parsimony-informative 0.3333 +2154 keep parsimony-informative 0.3333 +2155 keep parsimony-informative 0.3333 +2156 keep singleton 0.3333 +2157 keep parsimony-informative 0.3333 +2158 keep parsimony-informative 0.3333 +2159 keep parsimony-informative 0.3333 +2160 keep parsimony-informative 0.3333 +2161 keep singleton 0.3333 +2162 keep singleton 0.3333 +2163 keep parsimony-informative 0.3333 +2164 keep constant 0.8333 +2165 keep other 0.8333 +2166 keep other 0.8333 +2167 keep other 0.8333 +2168 keep constant 0.8333 +2169 keep other 0.8333 +2170 trim other 0.9167 +2171 trim other 0.9167 +2172 trim other 0.9167 +2173 trim other 0.9167 +2174 trim other 0.9167 +2175 trim other 0.9167 +2176 trim other 0.9167 +2177 trim other 0.9167 +2178 trim other 0.9167 +2179 trim other 0.9167 +2180 trim other 0.9167 +2181 trim other 0.9167 +2182 trim other 0.9167 +2183 trim other 0.9167 +2184 trim other 0.9167 +2185 trim other 0.9167 +2186 trim other 0.9167 +2187 trim other 0.9167 +2188 trim other 0.9167 +2189 trim other 0.9167 +2190 trim other 0.9167 +2191 trim other 0.9167 +2192 trim other 0.9167 +2193 trim other 0.9167 2194 keep singleton 0.75 2195 keep singleton 0.75 2196 keep singleton 0.75 @@ -2209,33 +2209,33 @@ 2209 keep constant 0.0 2210 keep constant 0.0 2211 keep parsimony-informative 0.0 -2212 keep constant 0.8333333333333334 -2213 keep other 0.8333333333333334 -2214 keep constant 0.8333333333333334 -2215 trim other 0.9166666666666666 -2216 trim other 0.9166666666666666 -2217 trim other 0.9166666666666666 -2218 trim other 0.9166666666666666 -2219 trim other 0.9166666666666666 -2220 trim other 0.9166666666666666 -2221 trim other 0.9166666666666666 -2222 trim other 0.9166666666666666 -2223 trim other 0.9166666666666666 -2224 trim other 0.9166666666666666 -2225 trim other 0.9166666666666666 -2226 trim other 0.9166666666666666 -2227 trim other 0.9166666666666666 -2228 trim other 0.9166666666666666 -2229 trim other 0.9166666666666666 -2230 trim other 0.9166666666666666 -2231 trim other 0.9166666666666666 -2232 trim other 0.9166666666666666 -2233 trim other 0.9166666666666666 -2234 trim other 0.9166666666666666 -2235 trim other 0.9166666666666666 -2236 trim other 0.9166666666666666 -2237 trim other 0.9166666666666666 -2238 trim other 0.9166666666666666 +2212 keep constant 0.8333 +2213 keep other 0.8333 +2214 keep constant 0.8333 +2215 trim other 0.9167 +2216 trim other 0.9167 +2217 trim other 0.9167 +2218 trim other 0.9167 +2219 trim other 0.9167 +2220 trim other 0.9167 +2221 trim other 0.9167 +2222 trim other 0.9167 +2223 trim other 0.9167 +2224 trim other 0.9167 +2225 trim other 0.9167 +2226 trim other 0.9167 +2227 trim other 0.9167 +2228 trim other 0.9167 +2229 trim other 0.9167 +2230 trim other 0.9167 +2231 trim other 0.9167 +2232 trim other 0.9167 +2233 trim other 0.9167 +2234 trim other 0.9167 +2235 trim other 0.9167 +2236 trim other 0.9167 +2237 trim other 0.9167 +2238 trim other 0.9167 2239 keep singleton 0.0 2240 keep parsimony-informative 0.0 2241 keep parsimony-informative 0.0 @@ -2266,39 +2266,39 @@ 2266 keep parsimony-informative 0.0 2267 keep singleton 0.0 2268 keep parsimony-informative 0.0 -2269 keep parsimony-informative 0.08333333333333333 -2270 keep singleton 0.08333333333333333 -2271 keep parsimony-informative 0.08333333333333333 -2272 keep parsimony-informative 0.16666666666666666 -2273 keep parsimony-informative 0.16666666666666666 -2274 keep parsimony-informative 0.16666666666666666 -2275 keep parsimony-informative 0.16666666666666666 -2276 keep parsimony-informative 0.16666666666666666 -2277 keep parsimony-informative 0.16666666666666666 -2278 keep parsimony-informative 0.16666666666666666 -2279 keep singleton 0.16666666666666666 -2280 keep parsimony-informative 0.16666666666666666 +2269 keep parsimony-informative 0.0833 +2270 keep singleton 0.0833 +2271 keep parsimony-informative 0.0833 +2272 keep parsimony-informative 0.1667 +2273 keep parsimony-informative 0.1667 +2274 keep parsimony-informative 0.1667 +2275 keep parsimony-informative 0.1667 +2276 keep parsimony-informative 0.1667 +2277 keep parsimony-informative 0.1667 +2278 keep parsimony-informative 0.1667 +2279 keep singleton 0.1667 +2280 keep parsimony-informative 0.1667 2281 keep parsimony-informative 0.5 2282 keep singleton 0.5 2283 keep singleton 0.5 -2284 trim other 0.9166666666666666 -2285 trim other 0.9166666666666666 -2286 trim other 0.9166666666666666 -2287 trim other 0.9166666666666666 -2288 trim other 0.9166666666666666 -2289 trim other 0.9166666666666666 -2290 trim other 0.9166666666666666 -2291 trim other 0.9166666666666666 -2292 trim other 0.9166666666666666 -2293 trim other 0.9166666666666666 -2294 trim other 0.9166666666666666 -2295 trim other 0.9166666666666666 -2296 trim other 0.9166666666666666 -2297 trim other 0.9166666666666666 -2298 trim other 0.9166666666666666 -2299 trim other 0.9166666666666666 -2300 trim other 0.9166666666666666 -2301 trim other 0.9166666666666666 +2284 trim other 0.9167 +2285 trim other 0.9167 +2286 trim other 0.9167 +2287 trim other 0.9167 +2288 trim other 0.9167 +2289 trim other 0.9167 +2290 trim other 0.9167 +2291 trim other 0.9167 +2292 trim other 0.9167 +2293 trim other 0.9167 +2294 trim other 0.9167 +2295 trim other 0.9167 +2296 trim other 0.9167 +2297 trim other 0.9167 +2298 trim other 0.9167 +2299 trim other 0.9167 +2300 trim other 0.9167 +2301 trim other 0.9167 2302 keep parsimony-informative 0.5 2303 keep singleton 0.5 2304 keep singleton 0.5 @@ -2332,75 +2332,75 @@ 2332 keep constant 0.0 2333 keep singleton 0.0 2334 keep parsimony-informative 0.0 -2335 keep singleton 0.5833333333333334 -2336 keep singleton 0.5833333333333334 -2337 keep parsimony-informative 0.5833333333333334 -2338 keep constant 0.5833333333333334 -2339 keep constant 0.5833333333333334 -2340 keep singleton 0.5833333333333334 -2341 keep singleton 0.5833333333333334 -2342 keep parsimony-informative 0.5833333333333334 -2343 keep singleton 0.5833333333333334 -2344 keep singleton 0.5833333333333334 -2345 keep singleton 0.5833333333333334 -2346 keep parsimony-informative 0.5833333333333334 +2335 keep singleton 0.5833 +2336 keep singleton 0.5833 +2337 keep parsimony-informative 0.5833 +2338 keep constant 0.5833 +2339 keep constant 0.5833 +2340 keep singleton 0.5833 +2341 keep singleton 0.5833 +2342 keep parsimony-informative 0.5833 +2343 keep singleton 0.5833 +2344 keep singleton 0.5833 +2345 keep singleton 0.5833 +2346 keep parsimony-informative 0.5833 2347 keep other 0.75 2348 keep singleton 0.75 2349 keep constant 0.75 -2350 keep other 0.8333333333333334 -2351 keep other 0.8333333333333334 -2352 keep other 0.8333333333333334 -2353 trim other 0.9166666666666666 -2354 trim other 0.9166666666666666 -2355 trim other 0.9166666666666666 -2356 trim other 0.9166666666666666 -2357 trim other 0.9166666666666666 -2358 trim other 0.9166666666666666 -2359 trim other 0.9166666666666666 -2360 trim other 0.9166666666666666 -2361 trim other 0.9166666666666666 -2362 trim other 0.9166666666666666 -2363 trim other 0.9166666666666666 -2364 trim other 0.9166666666666666 -2365 trim other 0.9166666666666666 -2366 trim other 0.9166666666666666 -2367 trim other 0.9166666666666666 -2368 trim other 0.9166666666666666 -2369 trim other 0.9166666666666666 -2370 trim other 0.9166666666666666 -2371 trim other 0.9166666666666666 -2372 trim other 0.9166666666666666 -2373 trim other 0.9166666666666666 -2374 trim other 0.9166666666666666 -2375 trim other 0.9166666666666666 -2376 trim other 0.9166666666666666 -2377 trim other 0.9166666666666666 -2378 trim other 0.9166666666666666 -2379 trim other 0.9166666666666666 -2380 trim other 0.9166666666666666 -2381 trim other 0.9166666666666666 -2382 trim other 0.9166666666666666 -2383 trim other 0.9166666666666666 -2384 trim other 0.9166666666666666 -2385 trim other 0.9166666666666666 -2386 trim other 0.9166666666666666 -2387 trim other 0.9166666666666666 -2388 trim other 0.9166666666666666 -2389 trim other 0.9166666666666666 -2390 trim other 0.9166666666666666 -2391 trim other 0.9166666666666666 -2392 trim other 0.9166666666666666 -2393 trim other 0.9166666666666666 -2394 trim other 0.9166666666666666 -2395 trim other 0.9166666666666666 -2396 trim other 0.9166666666666666 -2397 trim other 0.9166666666666666 -2398 trim other 0.9166666666666666 -2399 trim other 0.9166666666666666 -2400 trim other 0.9166666666666666 -2401 keep other 0.8333333333333334 -2402 keep constant 0.8333333333333334 -2403 keep other 0.8333333333333334 +2350 keep other 0.8333 +2351 keep other 0.8333 +2352 keep other 0.8333 +2353 trim other 0.9167 +2354 trim other 0.9167 +2355 trim other 0.9167 +2356 trim other 0.9167 +2357 trim other 0.9167 +2358 trim other 0.9167 +2359 trim other 0.9167 +2360 trim other 0.9167 +2361 trim other 0.9167 +2362 trim other 0.9167 +2363 trim other 0.9167 +2364 trim other 0.9167 +2365 trim other 0.9167 +2366 trim other 0.9167 +2367 trim other 0.9167 +2368 trim other 0.9167 +2369 trim other 0.9167 +2370 trim other 0.9167 +2371 trim other 0.9167 +2372 trim other 0.9167 +2373 trim other 0.9167 +2374 trim other 0.9167 +2375 trim other 0.9167 +2376 trim other 0.9167 +2377 trim other 0.9167 +2378 trim other 0.9167 +2379 trim other 0.9167 +2380 trim other 0.9167 +2381 trim other 0.9167 +2382 trim other 0.9167 +2383 trim other 0.9167 +2384 trim other 0.9167 +2385 trim other 0.9167 +2386 trim other 0.9167 +2387 trim other 0.9167 +2388 trim other 0.9167 +2389 trim other 0.9167 +2390 trim other 0.9167 +2391 trim other 0.9167 +2392 trim other 0.9167 +2393 trim other 0.9167 +2394 trim other 0.9167 +2395 trim other 0.9167 +2396 trim other 0.9167 +2397 trim other 0.9167 +2398 trim other 0.9167 +2399 trim other 0.9167 +2400 trim other 0.9167 +2401 keep other 0.8333 +2402 keep constant 0.8333 +2403 keep other 0.8333 2404 keep singleton 0.75 2405 keep singleton 0.75 2406 keep singleton 0.75 @@ -2425,78 +2425,78 @@ 2425 keep singleton 0.0 2426 keep parsimony-informative 0.0 2427 keep parsimony-informative 0.0 -2428 keep constant 0.8333333333333334 -2429 keep constant 0.8333333333333334 -2430 keep constant 0.8333333333333334 -2431 keep constant 0.8333333333333334 -2432 keep constant 0.8333333333333334 -2433 keep other 0.8333333333333334 -2434 keep constant 0.8333333333333334 -2435 keep constant 0.8333333333333334 -2436 keep constant 0.8333333333333334 -2437 keep constant 0.8333333333333334 -2438 keep constant 0.8333333333333334 -2439 keep other 0.8333333333333334 -2440 keep constant 0.8333333333333334 -2441 keep constant 0.8333333333333334 -2442 keep other 0.8333333333333334 -2443 keep constant 0.8333333333333334 -2444 keep constant 0.8333333333333334 -2445 keep other 0.8333333333333334 -2446 keep other 0.8333333333333334 -2447 keep constant 0.8333333333333334 -2448 keep other 0.8333333333333334 -2449 keep constant 0.8333333333333334 -2450 keep constant 0.8333333333333334 -2451 keep constant 0.8333333333333334 -2452 keep constant 0.8333333333333334 -2453 keep other 0.8333333333333334 -2454 keep other 0.8333333333333334 -2455 trim other 0.9166666666666666 -2456 trim other 0.9166666666666666 -2457 trim other 0.9166666666666666 -2458 trim other 0.9166666666666666 -2459 trim other 0.9166666666666666 -2460 trim other 0.9166666666666666 -2461 trim other 0.9166666666666666 -2462 trim other 0.9166666666666666 -2463 trim other 0.9166666666666666 -2464 trim other 0.9166666666666666 -2465 trim other 0.9166666666666666 -2466 trim other 0.9166666666666666 -2467 trim other 0.9166666666666666 -2468 trim other 0.9166666666666666 -2469 trim other 0.9166666666666666 -2470 trim other 0.9166666666666666 -2471 trim other 0.9166666666666666 -2472 trim other 0.9166666666666666 -2473 trim other 0.9166666666666666 -2474 trim other 0.9166666666666666 -2475 trim other 0.9166666666666666 -2476 trim other 0.9166666666666666 -2477 trim other 0.9166666666666666 -2478 trim other 0.9166666666666666 -2479 trim other 0.9166666666666666 -2480 trim other 0.9166666666666666 -2481 trim other 0.9166666666666666 -2482 trim other 0.9166666666666666 -2483 trim other 0.9166666666666666 -2484 trim other 0.9166666666666666 -2485 keep other 0.8333333333333334 -2486 keep constant 0.8333333333333334 -2487 keep other 0.8333333333333334 -2488 keep other 0.8333333333333334 -2489 keep constant 0.8333333333333334 -2490 keep constant 0.8333333333333334 -2491 keep other 0.8333333333333334 -2492 keep constant 0.8333333333333334 -2493 keep other 0.8333333333333334 -2494 keep constant 0.8333333333333334 -2495 keep constant 0.8333333333333334 -2496 keep other 0.8333333333333334 -2497 keep constant 0.8333333333333334 -2498 keep other 0.8333333333333334 -2499 keep other 0.8333333333333334 +2428 keep constant 0.8333 +2429 keep constant 0.8333 +2430 keep constant 0.8333 +2431 keep constant 0.8333 +2432 keep constant 0.8333 +2433 keep other 0.8333 +2434 keep constant 0.8333 +2435 keep constant 0.8333 +2436 keep constant 0.8333 +2437 keep constant 0.8333 +2438 keep constant 0.8333 +2439 keep other 0.8333 +2440 keep constant 0.8333 +2441 keep constant 0.8333 +2442 keep other 0.8333 +2443 keep constant 0.8333 +2444 keep constant 0.8333 +2445 keep other 0.8333 +2446 keep other 0.8333 +2447 keep constant 0.8333 +2448 keep other 0.8333 +2449 keep constant 0.8333 +2450 keep constant 0.8333 +2451 keep constant 0.8333 +2452 keep constant 0.8333 +2453 keep other 0.8333 +2454 keep other 0.8333 +2455 trim other 0.9167 +2456 trim other 0.9167 +2457 trim other 0.9167 +2458 trim other 0.9167 +2459 trim other 0.9167 +2460 trim other 0.9167 +2461 trim other 0.9167 +2462 trim other 0.9167 +2463 trim other 0.9167 +2464 trim other 0.9167 +2465 trim other 0.9167 +2466 trim other 0.9167 +2467 trim other 0.9167 +2468 trim other 0.9167 +2469 trim other 0.9167 +2470 trim other 0.9167 +2471 trim other 0.9167 +2472 trim other 0.9167 +2473 trim other 0.9167 +2474 trim other 0.9167 +2475 trim other 0.9167 +2476 trim other 0.9167 +2477 trim other 0.9167 +2478 trim other 0.9167 +2479 trim other 0.9167 +2480 trim other 0.9167 +2481 trim other 0.9167 +2482 trim other 0.9167 +2483 trim other 0.9167 +2484 trim other 0.9167 +2485 keep other 0.8333 +2486 keep constant 0.8333 +2487 keep other 0.8333 +2488 keep other 0.8333 +2489 keep constant 0.8333 +2490 keep constant 0.8333 +2491 keep other 0.8333 +2492 keep constant 0.8333 +2493 keep other 0.8333 +2494 keep constant 0.8333 +2495 keep constant 0.8333 +2496 keep other 0.8333 +2497 keep constant 0.8333 +2498 keep other 0.8333 +2499 keep other 0.8333 2500 keep parsimony-informative 0.0 2501 keep singleton 0.0 2502 keep parsimony-informative 0.0 @@ -2512,15 +2512,15 @@ 2512 keep parsimony-informative 0.0 2513 keep parsimony-informative 0.0 2514 keep parsimony-informative 0.0 -2515 trim other 0.9166666666666666 -2516 trim other 0.9166666666666666 -2517 trim other 0.9166666666666666 -2518 trim other 0.9166666666666666 -2519 trim other 0.9166666666666666 -2520 trim other 0.9166666666666666 -2521 trim other 0.9166666666666666 -2522 trim other 0.9166666666666666 -2523 trim other 0.9166666666666666 +2515 trim other 0.9167 +2516 trim other 0.9167 +2517 trim other 0.9167 +2518 trim other 0.9167 +2519 trim other 0.9167 +2520 trim other 0.9167 +2521 trim other 0.9167 +2522 trim other 0.9167 +2523 trim other 0.9167 2524 keep parsimony-informative 0.25 2525 keep parsimony-informative 0.25 2526 keep parsimony-informative 0.25 @@ -2533,51 +2533,51 @@ 2533 keep parsimony-informative 0.25 2534 keep parsimony-informative 0.25 2535 keep parsimony-informative 0.25 -2536 trim other 0.9166666666666666 -2537 trim other 0.9166666666666666 -2538 trim other 0.9166666666666666 -2539 trim other 0.9166666666666666 -2540 trim other 0.9166666666666666 -2541 trim other 0.9166666666666666 -2542 trim other 0.9166666666666666 -2543 trim other 0.9166666666666666 -2544 trim other 0.9166666666666666 -2545 trim other 0.9166666666666666 -2546 trim other 0.9166666666666666 -2547 trim other 0.9166666666666666 -2548 trim other 0.9166666666666666 -2549 trim other 0.9166666666666666 -2550 trim other 0.9166666666666666 -2551 keep constant 0.8333333333333334 -2552 keep other 0.8333333333333334 -2553 keep other 0.8333333333333334 -2554 keep other 0.8333333333333334 -2555 keep constant 0.8333333333333334 -2556 keep constant 0.8333333333333334 -2557 keep singleton 0.3333333333333333 -2558 keep constant 0.3333333333333333 -2559 keep parsimony-informative 0.3333333333333333 +2536 trim other 0.9167 +2537 trim other 0.9167 +2538 trim other 0.9167 +2539 trim other 0.9167 +2540 trim other 0.9167 +2541 trim other 0.9167 +2542 trim other 0.9167 +2543 trim other 0.9167 +2544 trim other 0.9167 +2545 trim other 0.9167 +2546 trim other 0.9167 +2547 trim other 0.9167 +2548 trim other 0.9167 +2549 trim other 0.9167 +2550 trim other 0.9167 +2551 keep constant 0.8333 +2552 keep other 0.8333 +2553 keep other 0.8333 +2554 keep other 0.8333 +2555 keep constant 0.8333 +2556 keep constant 0.8333 +2557 keep singleton 0.3333 +2558 keep constant 0.3333 +2559 keep parsimony-informative 0.3333 2560 keep singleton 0.5 2561 keep singleton 0.5 2562 keep singleton 0.5 -2563 keep parsimony-informative 0.16666666666666666 -2564 keep parsimony-informative 0.16666666666666666 -2565 keep parsimony-informative 0.16666666666666666 -2566 keep parsimony-informative 0.16666666666666666 -2567 keep parsimony-informative 0.16666666666666666 -2568 keep parsimony-informative 0.16666666666666666 -2569 keep parsimony-informative 0.16666666666666666 -2570 keep singleton 0.16666666666666666 -2571 keep parsimony-informative 0.16666666666666666 -2572 keep parsimony-informative 0.08333333333333333 -2573 keep parsimony-informative 0.08333333333333333 -2574 keep parsimony-informative 0.08333333333333333 -2575 keep parsimony-informative 0.08333333333333333 -2576 keep parsimony-informative 0.08333333333333333 -2577 keep parsimony-informative 0.08333333333333333 -2578 keep parsimony-informative 0.08333333333333333 -2579 keep singleton 0.08333333333333333 -2580 keep parsimony-informative 0.08333333333333333 +2563 keep parsimony-informative 0.1667 +2564 keep parsimony-informative 0.1667 +2565 keep parsimony-informative 0.1667 +2566 keep parsimony-informative 0.1667 +2567 keep parsimony-informative 0.1667 +2568 keep parsimony-informative 0.1667 +2569 keep parsimony-informative 0.1667 +2570 keep singleton 0.1667 +2571 keep parsimony-informative 0.1667 +2572 keep parsimony-informative 0.0833 +2573 keep parsimony-informative 0.0833 +2574 keep parsimony-informative 0.0833 +2575 keep parsimony-informative 0.0833 +2576 keep parsimony-informative 0.0833 +2577 keep parsimony-informative 0.0833 +2578 keep parsimony-informative 0.0833 +2579 keep singleton 0.0833 +2580 keep parsimony-informative 0.0833 2581 keep parsimony-informative 0.0 2582 keep singleton 0.0 2583 keep parsimony-informative 0.0 @@ -2608,9 +2608,9 @@ 2608 keep parsimony-informative 0.0 2609 keep singleton 0.0 2610 keep parsimony-informative 0.0 -2611 keep parsimony-informative 0.08333333333333333 -2612 keep parsimony-informative 0.08333333333333333 -2613 keep parsimony-informative 0.08333333333333333 +2611 keep parsimony-informative 0.0833 +2612 keep parsimony-informative 0.0833 +2613 keep parsimony-informative 0.0833 2614 keep singleton 0.0 2615 keep singleton 0.0 2616 keep parsimony-informative 0.0 @@ -2641,36 +2641,36 @@ 2641 keep singleton 0.75 2642 keep singleton 0.75 2643 keep singleton 0.75 -2644 keep other 0.8333333333333334 -2645 keep other 0.8333333333333334 -2646 keep other 0.8333333333333334 -2647 keep other 0.8333333333333334 -2648 keep other 0.8333333333333334 -2649 keep other 0.8333333333333334 -2650 keep other 0.8333333333333334 -2651 keep other 0.8333333333333334 -2652 keep other 0.8333333333333334 -2653 keep other 0.8333333333333334 -2654 keep other 0.8333333333333334 -2655 keep constant 0.8333333333333334 -2656 keep other 0.8333333333333334 -2657 keep constant 0.8333333333333334 -2658 keep other 0.8333333333333334 -2659 keep other 0.8333333333333334 -2660 keep constant 0.8333333333333334 -2661 keep other 0.8333333333333334 -2662 keep other 0.8333333333333334 -2663 keep other 0.8333333333333334 -2664 keep constant 0.8333333333333334 -2665 keep other 0.8333333333333334 -2666 keep other 0.8333333333333334 -2667 keep other 0.8333333333333334 +2644 keep other 0.8333 +2645 keep other 0.8333 +2646 keep other 0.8333 +2647 keep other 0.8333 +2648 keep other 0.8333 +2649 keep other 0.8333 +2650 keep other 0.8333 +2651 keep other 0.8333 +2652 keep other 0.8333 +2653 keep other 0.8333 +2654 keep other 0.8333 +2655 keep constant 0.8333 +2656 keep other 0.8333 +2657 keep constant 0.8333 +2658 keep other 0.8333 +2659 keep other 0.8333 +2660 keep constant 0.8333 +2661 keep other 0.8333 +2662 keep other 0.8333 +2663 keep other 0.8333 +2664 keep constant 0.8333 +2665 keep other 0.8333 +2666 keep other 0.8333 +2667 keep other 0.8333 2668 keep parsimony-informative 0.5 2669 keep singleton 0.5 2670 keep parsimony-informative 0.5 -2671 keep singleton 0.4166666666666667 -2672 keep singleton 0.4166666666666667 -2673 keep parsimony-informative 0.4166666666666667 +2671 keep singleton 0.4167 +2672 keep singleton 0.4167 +2673 keep parsimony-informative 0.4167 2674 keep parsimony-informative 0.0 2675 keep parsimony-informative 0.0 2676 keep parsimony-informative 0.0 @@ -2695,18 +2695,18 @@ 2695 keep constant 0.0 2696 keep singleton 0.0 2697 keep parsimony-informative 0.0 -2698 trim other 0.9166666666666666 -2699 trim other 0.9166666666666666 -2700 trim other 0.9166666666666666 -2701 trim other 0.9166666666666666 -2702 trim other 0.9166666666666666 -2703 trim other 0.9166666666666666 -2704 trim other 0.9166666666666666 -2705 trim other 0.9166666666666666 -2706 trim other 0.9166666666666666 -2707 trim other 0.9166666666666666 -2708 trim other 0.9166666666666666 -2709 trim other 0.9166666666666666 +2698 trim other 0.9167 +2699 trim other 0.9167 +2700 trim other 0.9167 +2701 trim other 0.9167 +2702 trim other 0.9167 +2703 trim other 0.9167 +2704 trim other 0.9167 +2705 trim other 0.9167 +2706 trim other 0.9167 +2707 trim other 0.9167 +2708 trim other 0.9167 +2709 trim other 0.9167 2710 keep singleton 0.0 2711 keep parsimony-informative 0.0 2712 keep parsimony-informative 0.0 @@ -2725,147 +2725,147 @@ 2725 keep parsimony-informative 0.0 2726 keep parsimony-informative 0.0 2727 keep parsimony-informative 0.0 -2728 keep parsimony-informative 0.08333333333333333 -2729 keep parsimony-informative 0.08333333333333333 -2730 keep parsimony-informative 0.08333333333333333 +2728 keep parsimony-informative 0.0833 +2729 keep parsimony-informative 0.0833 +2730 keep parsimony-informative 0.0833 2731 keep parsimony-informative 0.25 2732 keep singleton 0.25 2733 keep parsimony-informative 0.25 -2734 keep parsimony-informative 0.16666666666666666 -2735 keep constant 0.16666666666666666 -2736 keep parsimony-informative 0.16666666666666666 -2737 keep constant 0.16666666666666666 -2738 keep parsimony-informative 0.16666666666666666 -2739 keep parsimony-informative 0.16666666666666666 -2740 keep parsimony-informative 0.3333333333333333 -2741 keep parsimony-informative 0.3333333333333333 -2742 keep parsimony-informative 0.3333333333333333 -2743 keep parsimony-informative 0.3333333333333333 -2744 keep parsimony-informative 0.3333333333333333 -2745 keep parsimony-informative 0.3333333333333333 -2746 keep parsimony-informative 0.3333333333333333 -2747 keep parsimony-informative 0.3333333333333333 -2748 keep parsimony-informative 0.3333333333333333 -2749 keep parsimony-informative 0.4166666666666667 -2750 keep parsimony-informative 0.4166666666666667 -2751 keep parsimony-informative 0.4166666666666667 -2752 keep parsimony-informative 0.4166666666666667 -2753 keep parsimony-informative 0.4166666666666667 -2754 keep parsimony-informative 0.4166666666666667 +2734 keep parsimony-informative 0.1667 +2735 keep constant 0.1667 +2736 keep parsimony-informative 0.1667 +2737 keep constant 0.1667 +2738 keep parsimony-informative 0.1667 +2739 keep parsimony-informative 0.1667 +2740 keep parsimony-informative 0.3333 +2741 keep parsimony-informative 0.3333 +2742 keep parsimony-informative 0.3333 +2743 keep parsimony-informative 0.3333 +2744 keep parsimony-informative 0.3333 +2745 keep parsimony-informative 0.3333 +2746 keep parsimony-informative 0.3333 +2747 keep parsimony-informative 0.3333 +2748 keep parsimony-informative 0.3333 +2749 keep parsimony-informative 0.4167 +2750 keep parsimony-informative 0.4167 +2751 keep parsimony-informative 0.4167 +2752 keep parsimony-informative 0.4167 +2753 keep parsimony-informative 0.4167 +2754 keep parsimony-informative 0.4167 2755 keep singleton 0.5 2756 keep parsimony-informative 0.5 2757 keep parsimony-informative 0.5 -2758 keep constant 0.8333333333333334 -2759 keep constant 0.8333333333333334 -2760 keep constant 0.8333333333333334 -2761 trim other 0.9166666666666666 -2762 trim other 0.9166666666666666 -2763 trim other 0.9166666666666666 -2764 trim other 0.9166666666666666 -2765 trim other 0.9166666666666666 -2766 trim other 0.9166666666666666 -2767 trim other 0.9166666666666666 -2768 trim other 0.9166666666666666 -2769 trim other 0.9166666666666666 -2770 trim other 0.9166666666666666 -2771 trim other 0.9166666666666666 -2772 trim other 0.9166666666666666 -2773 trim other 0.9166666666666666 -2774 trim other 0.9166666666666666 -2775 trim other 0.9166666666666666 -2776 trim other 0.9166666666666666 -2777 trim other 0.9166666666666666 -2778 trim other 0.9166666666666666 -2779 trim other 0.9166666666666666 -2780 trim other 0.9166666666666666 -2781 trim other 0.9166666666666666 -2782 keep constant 0.6666666666666666 -2783 keep constant 0.6666666666666666 -2784 keep singleton 0.6666666666666666 -2785 keep constant 0.6666666666666666 -2786 keep parsimony-informative 0.6666666666666666 -2787 keep singleton 0.6666666666666666 -2788 keep singleton 0.5833333333333334 -2789 keep constant 0.5833333333333334 -2790 keep parsimony-informative 0.5833333333333334 -2791 keep singleton 0.5833333333333334 -2792 keep parsimony-informative 0.5833333333333334 -2793 keep parsimony-informative 0.5833333333333334 -2794 keep singleton 0.5833333333333334 -2795 keep singleton 0.5833333333333334 -2796 keep singleton 0.5833333333333334 -2797 keep singleton 0.5833333333333334 -2798 keep constant 0.5833333333333334 -2799 keep singleton 0.5833333333333334 -2800 keep singleton 0.5833333333333334 -2801 keep singleton 0.5833333333333334 -2802 keep singleton 0.5833333333333334 +2758 keep constant 0.8333 +2759 keep constant 0.8333 +2760 keep constant 0.8333 +2761 trim other 0.9167 +2762 trim other 0.9167 +2763 trim other 0.9167 +2764 trim other 0.9167 +2765 trim other 0.9167 +2766 trim other 0.9167 +2767 trim other 0.9167 +2768 trim other 0.9167 +2769 trim other 0.9167 +2770 trim other 0.9167 +2771 trim other 0.9167 +2772 trim other 0.9167 +2773 trim other 0.9167 +2774 trim other 0.9167 +2775 trim other 0.9167 +2776 trim other 0.9167 +2777 trim other 0.9167 +2778 trim other 0.9167 +2779 trim other 0.9167 +2780 trim other 0.9167 +2781 trim other 0.9167 +2782 keep constant 0.6667 +2783 keep constant 0.6667 +2784 keep singleton 0.6667 +2785 keep constant 0.6667 +2786 keep parsimony-informative 0.6667 +2787 keep singleton 0.6667 +2788 keep singleton 0.5833 +2789 keep constant 0.5833 +2790 keep parsimony-informative 0.5833 +2791 keep singleton 0.5833 +2792 keep parsimony-informative 0.5833 +2793 keep parsimony-informative 0.5833 +2794 keep singleton 0.5833 +2795 keep singleton 0.5833 +2796 keep singleton 0.5833 +2797 keep singleton 0.5833 +2798 keep constant 0.5833 +2799 keep singleton 0.5833 +2800 keep singleton 0.5833 +2801 keep singleton 0.5833 +2802 keep singleton 0.5833 2803 keep parsimony-informative 0.5 2804 keep singleton 0.5 2805 keep singleton 0.5 2806 keep constant 0.5 2807 keep singleton 0.5 2808 keep parsimony-informative 0.5 -2809 keep singleton 0.4166666666666667 -2810 keep singleton 0.4166666666666667 -2811 keep singleton 0.4166666666666667 -2812 keep parsimony-informative 0.4166666666666667 -2813 keep parsimony-informative 0.4166666666666667 -2814 keep singleton 0.4166666666666667 +2809 keep singleton 0.4167 +2810 keep singleton 0.4167 +2811 keep singleton 0.4167 +2812 keep parsimony-informative 0.4167 +2813 keep parsimony-informative 0.4167 +2814 keep singleton 0.4167 2815 keep singleton 0.5 2816 keep constant 0.5 2817 keep singleton 0.5 2818 keep singleton 0.5 2819 keep singleton 0.5 2820 keep parsimony-informative 0.5 -2821 keep parsimony-informative 0.5833333333333334 -2822 keep parsimony-informative 0.5833333333333334 -2823 keep singleton 0.5833333333333334 -2824 keep other 0.8333333333333334 -2825 keep other 0.8333333333333334 -2826 keep constant 0.8333333333333334 -2827 keep other 0.8333333333333334 -2828 keep other 0.8333333333333334 -2829 keep other 0.8333333333333334 -2830 trim other 0.9166666666666666 -2831 trim other 0.9166666666666666 -2832 trim other 0.9166666666666666 -2833 trim other 0.9166666666666666 -2834 trim other 0.9166666666666666 -2835 trim other 0.9166666666666666 -2836 trim other 0.9166666666666666 -2837 trim other 0.9166666666666666 -2838 trim other 0.9166666666666666 -2839 trim other 0.9166666666666666 -2840 trim other 0.9166666666666666 -2841 trim other 0.9166666666666666 -2842 trim other 0.9166666666666666 -2843 trim other 0.9166666666666666 -2844 trim other 0.9166666666666666 -2845 trim other 0.9166666666666666 -2846 trim other 0.9166666666666666 -2847 trim other 0.9166666666666666 -2848 trim other 0.9166666666666666 -2849 trim other 0.9166666666666666 -2850 trim other 0.9166666666666666 -2851 trim other 0.9166666666666666 -2852 trim other 0.9166666666666666 -2853 trim other 0.9166666666666666 -2854 keep parsimony-informative 0.5833333333333334 -2855 keep parsimony-informative 0.5833333333333334 -2856 keep singleton 0.5833333333333334 -2857 keep parsimony-informative 0.08333333333333333 -2858 keep parsimony-informative 0.08333333333333333 -2859 keep parsimony-informative 0.08333333333333333 -2860 keep parsimony-informative 0.08333333333333333 -2861 keep parsimony-informative 0.08333333333333333 -2862 keep parsimony-informative 0.08333333333333333 -2863 keep parsimony-informative 0.08333333333333333 -2864 keep parsimony-informative 0.08333333333333333 -2865 keep parsimony-informative 0.08333333333333333 -2866 keep parsimony-informative 0.08333333333333333 -2867 keep parsimony-informative 0.08333333333333333 -2868 keep parsimony-informative 0.08333333333333333 +2821 keep parsimony-informative 0.5833 +2822 keep parsimony-informative 0.5833 +2823 keep singleton 0.5833 +2824 keep other 0.8333 +2825 keep other 0.8333 +2826 keep constant 0.8333 +2827 keep other 0.8333 +2828 keep other 0.8333 +2829 keep other 0.8333 +2830 trim other 0.9167 +2831 trim other 0.9167 +2832 trim other 0.9167 +2833 trim other 0.9167 +2834 trim other 0.9167 +2835 trim other 0.9167 +2836 trim other 0.9167 +2837 trim other 0.9167 +2838 trim other 0.9167 +2839 trim other 0.9167 +2840 trim other 0.9167 +2841 trim other 0.9167 +2842 trim other 0.9167 +2843 trim other 0.9167 +2844 trim other 0.9167 +2845 trim other 0.9167 +2846 trim other 0.9167 +2847 trim other 0.9167 +2848 trim other 0.9167 +2849 trim other 0.9167 +2850 trim other 0.9167 +2851 trim other 0.9167 +2852 trim other 0.9167 +2853 trim other 0.9167 +2854 keep parsimony-informative 0.5833 +2855 keep parsimony-informative 0.5833 +2856 keep singleton 0.5833 +2857 keep parsimony-informative 0.0833 +2858 keep parsimony-informative 0.0833 +2859 keep parsimony-informative 0.0833 +2860 keep parsimony-informative 0.0833 +2861 keep parsimony-informative 0.0833 +2862 keep parsimony-informative 0.0833 +2863 keep parsimony-informative 0.0833 +2864 keep parsimony-informative 0.0833 +2865 keep parsimony-informative 0.0833 +2866 keep parsimony-informative 0.0833 +2867 keep parsimony-informative 0.0833 +2868 keep parsimony-informative 0.0833 2869 keep parsimony-informative 0.0 2870 keep parsimony-informative 0.0 2871 keep parsimony-informative 0.0 @@ -2887,195 +2887,195 @@ 2887 keep parsimony-informative 0.0 2888 keep parsimony-informative 0.0 2889 keep parsimony-informative 0.0 -2890 keep parsimony-informative 0.08333333333333333 -2891 keep parsimony-informative 0.08333333333333333 -2892 keep parsimony-informative 0.08333333333333333 -2893 keep parsimony-informative 0.08333333333333333 -2894 keep parsimony-informative 0.08333333333333333 -2895 keep parsimony-informative 0.08333333333333333 -2896 keep parsimony-informative 0.08333333333333333 -2897 keep parsimony-informative 0.08333333333333333 -2898 keep parsimony-informative 0.08333333333333333 -2899 keep parsimony-informative 0.08333333333333333 -2900 keep singleton 0.08333333333333333 -2901 keep parsimony-informative 0.08333333333333333 -2902 keep parsimony-informative 0.08333333333333333 -2903 keep parsimony-informative 0.08333333333333333 -2904 keep parsimony-informative 0.08333333333333333 -2905 keep parsimony-informative 0.08333333333333333 -2906 keep parsimony-informative 0.08333333333333333 -2907 keep parsimony-informative 0.08333333333333333 -2908 keep parsimony-informative 0.08333333333333333 -2909 keep parsimony-informative 0.08333333333333333 -2910 keep parsimony-informative 0.08333333333333333 -2911 keep parsimony-informative 0.4166666666666667 -2912 keep parsimony-informative 0.4166666666666667 -2913 keep parsimony-informative 0.4166666666666667 -2914 keep parsimony-informative 0.4166666666666667 -2915 keep parsimony-informative 0.4166666666666667 -2916 keep parsimony-informative 0.4166666666666667 +2890 keep parsimony-informative 0.0833 +2891 keep parsimony-informative 0.0833 +2892 keep parsimony-informative 0.0833 +2893 keep parsimony-informative 0.0833 +2894 keep parsimony-informative 0.0833 +2895 keep parsimony-informative 0.0833 +2896 keep parsimony-informative 0.0833 +2897 keep parsimony-informative 0.0833 +2898 keep parsimony-informative 0.0833 +2899 keep parsimony-informative 0.0833 +2900 keep singleton 0.0833 +2901 keep parsimony-informative 0.0833 +2902 keep parsimony-informative 0.0833 +2903 keep parsimony-informative 0.0833 +2904 keep parsimony-informative 0.0833 +2905 keep parsimony-informative 0.0833 +2906 keep parsimony-informative 0.0833 +2907 keep parsimony-informative 0.0833 +2908 keep parsimony-informative 0.0833 +2909 keep parsimony-informative 0.0833 +2910 keep parsimony-informative 0.0833 +2911 keep parsimony-informative 0.4167 +2912 keep parsimony-informative 0.4167 +2913 keep parsimony-informative 0.4167 +2914 keep parsimony-informative 0.4167 +2915 keep parsimony-informative 0.4167 +2916 keep parsimony-informative 0.4167 2917 keep singleton 0.5 2918 keep parsimony-informative 0.5 2919 keep singleton 0.5 -2920 trim other 0.9166666666666666 -2921 trim other 0.9166666666666666 -2922 trim other 0.9166666666666666 -2923 trim other 0.9166666666666666 -2924 trim other 0.9166666666666666 -2925 trim other 0.9166666666666666 -2926 trim other 0.9166666666666666 -2927 trim other 0.9166666666666666 -2928 trim other 0.9166666666666666 -2929 keep parsimony-informative 0.4166666666666667 -2930 keep parsimony-informative 0.4166666666666667 -2931 keep parsimony-informative 0.4166666666666667 -2932 keep parsimony-informative 0.4166666666666667 -2933 keep singleton 0.4166666666666667 -2934 keep singleton 0.4166666666666667 -2935 keep parsimony-informative 0.3333333333333333 -2936 keep parsimony-informative 0.3333333333333333 -2937 keep parsimony-informative 0.3333333333333333 -2938 keep parsimony-informative 0.3333333333333333 -2939 keep parsimony-informative 0.3333333333333333 -2940 keep parsimony-informative 0.3333333333333333 -2941 keep singleton 0.08333333333333333 -2942 keep parsimony-informative 0.08333333333333333 -2943 keep singleton 0.08333333333333333 -2944 keep parsimony-informative 0.08333333333333333 -2945 keep parsimony-informative 0.08333333333333333 -2946 keep parsimony-informative 0.08333333333333333 -2947 keep parsimony-informative 0.08333333333333333 -2948 keep parsimony-informative 0.08333333333333333 -2949 keep parsimony-informative 0.08333333333333333 -2950 keep parsimony-informative 0.08333333333333333 -2951 keep parsimony-informative 0.08333333333333333 -2952 keep parsimony-informative 0.08333333333333333 +2920 trim other 0.9167 +2921 trim other 0.9167 +2922 trim other 0.9167 +2923 trim other 0.9167 +2924 trim other 0.9167 +2925 trim other 0.9167 +2926 trim other 0.9167 +2927 trim other 0.9167 +2928 trim other 0.9167 +2929 keep parsimony-informative 0.4167 +2930 keep parsimony-informative 0.4167 +2931 keep parsimony-informative 0.4167 +2932 keep parsimony-informative 0.4167 +2933 keep singleton 0.4167 +2934 keep singleton 0.4167 +2935 keep parsimony-informative 0.3333 +2936 keep parsimony-informative 0.3333 +2937 keep parsimony-informative 0.3333 +2938 keep parsimony-informative 0.3333 +2939 keep parsimony-informative 0.3333 +2940 keep parsimony-informative 0.3333 +2941 keep singleton 0.0833 +2942 keep parsimony-informative 0.0833 +2943 keep singleton 0.0833 +2944 keep parsimony-informative 0.0833 +2945 keep parsimony-informative 0.0833 +2946 keep parsimony-informative 0.0833 +2947 keep parsimony-informative 0.0833 +2948 keep parsimony-informative 0.0833 +2949 keep parsimony-informative 0.0833 +2950 keep parsimony-informative 0.0833 +2951 keep parsimony-informative 0.0833 +2952 keep parsimony-informative 0.0833 2953 keep parsimony-informative 0.5 2954 keep parsimony-informative 0.5 2955 keep parsimony-informative 0.5 2956 keep parsimony-informative 0.5 2957 keep singleton 0.5 2958 keep singleton 0.5 -2959 keep parsimony-informative 0.16666666666666666 -2960 keep parsimony-informative 0.16666666666666666 -2961 keep parsimony-informative 0.16666666666666666 -2962 keep parsimony-informative 0.16666666666666666 -2963 keep parsimony-informative 0.16666666666666666 -2964 keep parsimony-informative 0.16666666666666666 -2965 keep parsimony-informative 0.16666666666666666 -2966 keep constant 0.16666666666666666 -2967 keep parsimony-informative 0.16666666666666666 -2968 keep parsimony-informative 0.16666666666666666 -2969 keep parsimony-informative 0.16666666666666666 -2970 keep parsimony-informative 0.16666666666666666 -2971 keep singleton 0.16666666666666666 -2972 keep singleton 0.16666666666666666 -2973 keep parsimony-informative 0.16666666666666666 -2974 keep parsimony-informative 0.16666666666666666 -2975 keep parsimony-informative 0.16666666666666666 -2976 keep parsimony-informative 0.16666666666666666 -2977 keep parsimony-informative 0.16666666666666666 -2978 keep parsimony-informative 0.16666666666666666 -2979 keep parsimony-informative 0.16666666666666666 -2980 keep parsimony-informative 0.5833333333333334 -2981 keep parsimony-informative 0.5833333333333334 -2982 keep parsimony-informative 0.5833333333333334 -2983 keep singleton 0.5833333333333334 -2984 keep parsimony-informative 0.5833333333333334 -2985 keep parsimony-informative 0.5833333333333334 -2986 keep parsimony-informative 0.5833333333333334 -2987 keep singleton 0.5833333333333334 -2988 keep singleton 0.5833333333333334 -2989 keep parsimony-informative 0.5833333333333334 -2990 keep singleton 0.5833333333333334 -2991 keep parsimony-informative 0.5833333333333334 -2992 keep singleton 0.5833333333333334 -2993 keep parsimony-informative 0.5833333333333334 -2994 keep parsimony-informative 0.5833333333333334 +2959 keep parsimony-informative 0.1667 +2960 keep parsimony-informative 0.1667 +2961 keep parsimony-informative 0.1667 +2962 keep parsimony-informative 0.1667 +2963 keep parsimony-informative 0.1667 +2964 keep parsimony-informative 0.1667 +2965 keep parsimony-informative 0.1667 +2966 keep constant 0.1667 +2967 keep parsimony-informative 0.1667 +2968 keep parsimony-informative 0.1667 +2969 keep parsimony-informative 0.1667 +2970 keep parsimony-informative 0.1667 +2971 keep singleton 0.1667 +2972 keep singleton 0.1667 +2973 keep parsimony-informative 0.1667 +2974 keep parsimony-informative 0.1667 +2975 keep parsimony-informative 0.1667 +2976 keep parsimony-informative 0.1667 +2977 keep parsimony-informative 0.1667 +2978 keep parsimony-informative 0.1667 +2979 keep parsimony-informative 0.1667 +2980 keep parsimony-informative 0.5833 +2981 keep parsimony-informative 0.5833 +2982 keep parsimony-informative 0.5833 +2983 keep singleton 0.5833 +2984 keep parsimony-informative 0.5833 +2985 keep parsimony-informative 0.5833 +2986 keep parsimony-informative 0.5833 +2987 keep singleton 0.5833 +2988 keep singleton 0.5833 +2989 keep parsimony-informative 0.5833 +2990 keep singleton 0.5833 +2991 keep parsimony-informative 0.5833 +2992 keep singleton 0.5833 +2993 keep parsimony-informative 0.5833 +2994 keep parsimony-informative 0.5833 2995 keep constant 0.75 2996 keep singleton 0.75 2997 keep constant 0.75 -2998 trim other 0.9166666666666666 -2999 trim other 0.9166666666666666 -3000 trim other 0.9166666666666666 -3001 keep parsimony-informative 0.4166666666666667 -3002 keep parsimony-informative 0.4166666666666667 -3003 keep singleton 0.4166666666666667 -3004 keep parsimony-informative 0.4166666666666667 -3005 keep constant 0.4166666666666667 -3006 keep singleton 0.4166666666666667 -3007 keep parsimony-informative 0.16666666666666666 -3008 keep parsimony-informative 0.16666666666666666 -3009 keep parsimony-informative 0.16666666666666666 -3010 keep parsimony-informative 0.16666666666666666 -3011 keep parsimony-informative 0.16666666666666666 -3012 keep parsimony-informative 0.16666666666666666 -3013 keep parsimony-informative 0.16666666666666666 -3014 keep singleton 0.16666666666666666 -3015 keep parsimony-informative 0.16666666666666666 -3016 keep singleton 0.16666666666666666 -3017 keep singleton 0.16666666666666666 -3018 keep parsimony-informative 0.16666666666666666 -3019 keep parsimony-informative 0.16666666666666666 -3020 keep parsimony-informative 0.16666666666666666 -3021 keep parsimony-informative 0.16666666666666666 -3022 keep parsimony-informative 0.16666666666666666 -3023 keep parsimony-informative 0.16666666666666666 -3024 keep parsimony-informative 0.16666666666666666 -3025 keep parsimony-informative 0.08333333333333333 -3026 keep parsimony-informative 0.08333333333333333 -3027 keep parsimony-informative 0.08333333333333333 -3028 keep parsimony-informative 0.08333333333333333 -3029 keep parsimony-informative 0.08333333333333333 -3030 keep parsimony-informative 0.08333333333333333 -3031 keep parsimony-informative 0.08333333333333333 -3032 keep parsimony-informative 0.08333333333333333 -3033 keep parsimony-informative 0.08333333333333333 -3034 keep parsimony-informative 0.08333333333333333 -3035 keep parsimony-informative 0.08333333333333333 -3036 keep parsimony-informative 0.08333333333333333 -3037 keep parsimony-informative 0.08333333333333333 -3038 keep singleton 0.08333333333333333 -3039 keep parsimony-informative 0.08333333333333333 -3040 keep parsimony-informative 0.08333333333333333 -3041 keep parsimony-informative 0.08333333333333333 -3042 keep parsimony-informative 0.08333333333333333 -3043 keep singleton 0.16666666666666666 -3044 keep singleton 0.16666666666666666 -3045 keep parsimony-informative 0.16666666666666666 -3046 keep singleton 0.16666666666666666 -3047 keep parsimony-informative 0.16666666666666666 -3048 keep singleton 0.16666666666666666 -3049 keep parsimony-informative 0.3333333333333333 -3050 keep parsimony-informative 0.3333333333333333 -3051 keep parsimony-informative 0.3333333333333333 +2998 trim other 0.9167 +2999 trim other 0.9167 +3000 trim other 0.9167 +3001 keep parsimony-informative 0.4167 +3002 keep parsimony-informative 0.4167 +3003 keep singleton 0.4167 +3004 keep parsimony-informative 0.4167 +3005 keep constant 0.4167 +3006 keep singleton 0.4167 +3007 keep parsimony-informative 0.1667 +3008 keep parsimony-informative 0.1667 +3009 keep parsimony-informative 0.1667 +3010 keep parsimony-informative 0.1667 +3011 keep parsimony-informative 0.1667 +3012 keep parsimony-informative 0.1667 +3013 keep parsimony-informative 0.1667 +3014 keep singleton 0.1667 +3015 keep parsimony-informative 0.1667 +3016 keep singleton 0.1667 +3017 keep singleton 0.1667 +3018 keep parsimony-informative 0.1667 +3019 keep parsimony-informative 0.1667 +3020 keep parsimony-informative 0.1667 +3021 keep parsimony-informative 0.1667 +3022 keep parsimony-informative 0.1667 +3023 keep parsimony-informative 0.1667 +3024 keep parsimony-informative 0.1667 +3025 keep parsimony-informative 0.0833 +3026 keep parsimony-informative 0.0833 +3027 keep parsimony-informative 0.0833 +3028 keep parsimony-informative 0.0833 +3029 keep parsimony-informative 0.0833 +3030 keep parsimony-informative 0.0833 +3031 keep parsimony-informative 0.0833 +3032 keep parsimony-informative 0.0833 +3033 keep parsimony-informative 0.0833 +3034 keep parsimony-informative 0.0833 +3035 keep parsimony-informative 0.0833 +3036 keep parsimony-informative 0.0833 +3037 keep parsimony-informative 0.0833 +3038 keep singleton 0.0833 +3039 keep parsimony-informative 0.0833 +3040 keep parsimony-informative 0.0833 +3041 keep parsimony-informative 0.0833 +3042 keep parsimony-informative 0.0833 +3043 keep singleton 0.1667 +3044 keep singleton 0.1667 +3045 keep parsimony-informative 0.1667 +3046 keep singleton 0.1667 +3047 keep parsimony-informative 0.1667 +3048 keep singleton 0.1667 +3049 keep parsimony-informative 0.3333 +3050 keep parsimony-informative 0.3333 +3051 keep parsimony-informative 0.3333 3052 keep constant 0.75 3053 keep constant 0.75 3054 keep singleton 0.75 -3055 keep constant 0.8333333333333334 -3056 keep constant 0.8333333333333334 -3057 keep constant 0.8333333333333334 -3058 keep other 0.8333333333333334 -3059 keep constant 0.8333333333333334 -3060 keep other 0.8333333333333334 -3061 keep other 0.8333333333333334 -3062 keep constant 0.8333333333333334 -3063 keep constant 0.8333333333333334 -3064 keep parsimony-informative 0.5833333333333334 -3065 keep parsimony-informative 0.5833333333333334 -3066 keep singleton 0.5833333333333334 -3067 keep parsimony-informative 0.5833333333333334 -3068 keep parsimony-informative 0.5833333333333334 -3069 keep singleton 0.5833333333333334 -3070 keep singleton 0.5833333333333334 -3071 keep parsimony-informative 0.5833333333333334 -3072 keep singleton 0.5833333333333334 -3073 keep parsimony-informative 0.5833333333333334 -3074 keep parsimony-informative 0.5833333333333334 -3075 keep singleton 0.5833333333333334 -3076 keep singleton 0.5833333333333334 -3077 keep singleton 0.5833333333333334 -3078 keep singleton 0.5833333333333334 +3055 keep constant 0.8333 +3056 keep constant 0.8333 +3057 keep constant 0.8333 +3058 keep other 0.8333 +3059 keep constant 0.8333 +3060 keep other 0.8333 +3061 keep other 0.8333 +3062 keep constant 0.8333 +3063 keep constant 0.8333 +3064 keep parsimony-informative 0.5833 +3065 keep parsimony-informative 0.5833 +3066 keep singleton 0.5833 +3067 keep parsimony-informative 0.5833 +3068 keep parsimony-informative 0.5833 +3069 keep singleton 0.5833 +3070 keep singleton 0.5833 +3071 keep parsimony-informative 0.5833 +3072 keep singleton 0.5833 +3073 keep parsimony-informative 0.5833 +3074 keep parsimony-informative 0.5833 +3075 keep singleton 0.5833 +3076 keep singleton 0.5833 +3077 keep singleton 0.5833 +3078 keep singleton 0.5833 3079 keep parsimony-informative 0.25 3080 keep parsimony-informative 0.25 3081 keep singleton 0.25 @@ -3100,117 +3100,117 @@ 3100 keep parsimony-informative 0.25 3101 keep parsimony-informative 0.25 3102 keep parsimony-informative 0.25 -3103 keep parsimony-informative 0.3333333333333333 -3104 keep parsimony-informative 0.3333333333333333 -3105 keep parsimony-informative 0.3333333333333333 -3106 keep parsimony-informative 0.3333333333333333 -3107 keep parsimony-informative 0.3333333333333333 -3108 keep parsimony-informative 0.3333333333333333 -3109 keep singleton 0.3333333333333333 -3110 keep singleton 0.3333333333333333 -3111 keep parsimony-informative 0.3333333333333333 -3112 keep parsimony-informative 0.4166666666666667 -3113 keep parsimony-informative 0.4166666666666667 -3114 keep parsimony-informative 0.4166666666666667 -3115 keep singleton 0.6666666666666666 -3116 keep constant 0.6666666666666666 -3117 keep singleton 0.6666666666666666 -3118 keep singleton 0.6666666666666666 -3119 keep singleton 0.6666666666666666 -3120 keep parsimony-informative 0.6666666666666666 -3121 keep parsimony-informative 0.6666666666666666 -3122 keep singleton 0.6666666666666666 -3123 keep constant 0.6666666666666666 -3124 keep singleton 0.6666666666666666 -3125 keep singleton 0.6666666666666666 -3126 keep singleton 0.6666666666666666 -3127 trim other 0.9166666666666666 -3128 trim other 0.9166666666666666 -3129 trim other 0.9166666666666666 -3130 keep singleton 0.6666666666666666 -3131 keep constant 0.6666666666666666 -3132 keep parsimony-informative 0.6666666666666666 -3133 keep singleton 0.6666666666666666 -3134 keep other 0.6666666666666666 -3135 keep singleton 0.6666666666666666 -3136 keep singleton 0.6666666666666666 -3137 keep singleton 0.6666666666666666 -3138 keep singleton 0.6666666666666666 +3103 keep parsimony-informative 0.3333 +3104 keep parsimony-informative 0.3333 +3105 keep parsimony-informative 0.3333 +3106 keep parsimony-informative 0.3333 +3107 keep parsimony-informative 0.3333 +3108 keep parsimony-informative 0.3333 +3109 keep singleton 0.3333 +3110 keep singleton 0.3333 +3111 keep parsimony-informative 0.3333 +3112 keep parsimony-informative 0.4167 +3113 keep parsimony-informative 0.4167 +3114 keep parsimony-informative 0.4167 +3115 keep singleton 0.6667 +3116 keep constant 0.6667 +3117 keep singleton 0.6667 +3118 keep singleton 0.6667 +3119 keep singleton 0.6667 +3120 keep parsimony-informative 0.6667 +3121 keep parsimony-informative 0.6667 +3122 keep singleton 0.6667 +3123 keep constant 0.6667 +3124 keep singleton 0.6667 +3125 keep singleton 0.6667 +3126 keep singleton 0.6667 +3127 trim other 0.9167 +3128 trim other 0.9167 +3129 trim other 0.9167 +3130 keep singleton 0.6667 +3131 keep constant 0.6667 +3132 keep parsimony-informative 0.6667 +3133 keep singleton 0.6667 +3134 keep other 0.6667 +3135 keep singleton 0.6667 +3136 keep singleton 0.6667 +3137 keep singleton 0.6667 +3138 keep singleton 0.6667 3139 keep singleton 0.75 3140 keep singleton 0.75 3141 keep other 0.75 -3142 keep constant 0.8333333333333334 -3143 keep constant 0.8333333333333334 -3144 keep other 0.8333333333333334 -3145 keep constant 0.8333333333333334 -3146 keep other 0.8333333333333334 -3147 keep constant 0.8333333333333334 -3148 keep other 0.8333333333333334 -3149 keep constant 0.8333333333333334 -3150 keep other 0.8333333333333334 -3151 keep constant 0.8333333333333334 -3152 keep other 0.8333333333333334 -3153 keep other 0.8333333333333334 -3154 keep constant 0.8333333333333334 -3155 keep constant 0.8333333333333334 -3156 keep other 0.8333333333333334 -3157 keep other 0.8333333333333334 -3158 keep other 0.8333333333333334 -3159 keep other 0.8333333333333334 -3160 keep other 0.8333333333333334 -3161 keep other 0.8333333333333334 -3162 keep other 0.8333333333333334 -3163 keep other 0.8333333333333334 -3164 keep other 0.8333333333333334 -3165 keep other 0.8333333333333334 -3166 keep constant 0.8333333333333334 -3167 keep other 0.8333333333333334 -3168 keep other 0.8333333333333334 -3169 keep other 0.8333333333333334 -3170 keep other 0.8333333333333334 -3171 keep other 0.8333333333333334 -3172 keep constant 0.8333333333333334 -3173 keep constant 0.8333333333333334 -3174 keep constant 0.8333333333333334 -3175 keep constant 0.8333333333333334 -3176 keep other 0.8333333333333334 -3177 keep constant 0.8333333333333334 -3178 keep other 0.8333333333333334 -3179 keep other 0.8333333333333334 -3180 keep other 0.8333333333333334 -3181 keep constant 0.8333333333333334 -3182 keep constant 0.8333333333333334 -3183 keep constant 0.8333333333333334 -3184 keep constant 0.8333333333333334 -3185 keep constant 0.8333333333333334 -3186 keep constant 0.8333333333333334 -3187 keep other 0.8333333333333334 -3188 keep other 0.8333333333333334 -3189 keep other 0.8333333333333334 -3190 keep constant 0.8333333333333334 -3191 keep constant 0.8333333333333334 -3192 keep other 0.8333333333333334 -3193 keep constant 0.8333333333333334 -3194 keep other 0.8333333333333334 -3195 keep other 0.8333333333333334 -3196 trim other 0.9166666666666666 -3197 trim other 0.9166666666666666 -3198 trim other 0.9166666666666666 -3199 trim other 0.9166666666666666 -3200 trim other 0.9166666666666666 -3201 trim other 0.9166666666666666 -3202 trim other 0.9166666666666666 -3203 trim other 0.9166666666666666 -3204 trim other 0.9166666666666666 -3205 trim other 0.9166666666666666 -3206 trim other 0.9166666666666666 -3207 trim other 0.9166666666666666 -3208 trim other 0.9166666666666666 -3209 trim other 0.9166666666666666 -3210 trim other 0.9166666666666666 -3211 trim other 0.9166666666666666 -3212 trim other 0.9166666666666666 -3213 trim other 0.9166666666666666 +3142 keep constant 0.8333 +3143 keep constant 0.8333 +3144 keep other 0.8333 +3145 keep constant 0.8333 +3146 keep other 0.8333 +3147 keep constant 0.8333 +3148 keep other 0.8333 +3149 keep constant 0.8333 +3150 keep other 0.8333 +3151 keep constant 0.8333 +3152 keep other 0.8333 +3153 keep other 0.8333 +3154 keep constant 0.8333 +3155 keep constant 0.8333 +3156 keep other 0.8333 +3157 keep other 0.8333 +3158 keep other 0.8333 +3159 keep other 0.8333 +3160 keep other 0.8333 +3161 keep other 0.8333 +3162 keep other 0.8333 +3163 keep other 0.8333 +3164 keep other 0.8333 +3165 keep other 0.8333 +3166 keep constant 0.8333 +3167 keep other 0.8333 +3168 keep other 0.8333 +3169 keep other 0.8333 +3170 keep other 0.8333 +3171 keep other 0.8333 +3172 keep constant 0.8333 +3173 keep constant 0.8333 +3174 keep constant 0.8333 +3175 keep constant 0.8333 +3176 keep other 0.8333 +3177 keep constant 0.8333 +3178 keep other 0.8333 +3179 keep other 0.8333 +3180 keep other 0.8333 +3181 keep constant 0.8333 +3182 keep constant 0.8333 +3183 keep constant 0.8333 +3184 keep constant 0.8333 +3185 keep constant 0.8333 +3186 keep constant 0.8333 +3187 keep other 0.8333 +3188 keep other 0.8333 +3189 keep other 0.8333 +3190 keep constant 0.8333 +3191 keep constant 0.8333 +3192 keep other 0.8333 +3193 keep constant 0.8333 +3194 keep other 0.8333 +3195 keep other 0.8333 +3196 trim other 0.9167 +3197 trim other 0.9167 +3198 trim other 0.9167 +3199 trim other 0.9167 +3200 trim other 0.9167 +3201 trim other 0.9167 +3202 trim other 0.9167 +3203 trim other 0.9167 +3204 trim other 0.9167 +3205 trim other 0.9167 +3206 trim other 0.9167 +3207 trim other 0.9167 +3208 trim other 0.9167 +3209 trim other 0.9167 +3210 trim other 0.9167 +3211 trim other 0.9167 +3212 trim other 0.9167 +3213 trim other 0.9167 3214 keep singleton 0.75 3215 keep singleton 0.75 3216 keep singleton 0.75 @@ -3226,24 +3226,24 @@ 3226 keep singleton 0.5 3227 keep singleton 0.5 3228 keep parsimony-informative 0.5 -3229 keep parsimony-informative 0.4166666666666667 -3230 keep singleton 0.4166666666666667 -3231 keep parsimony-informative 0.4166666666666667 -3232 keep parsimony-informative 0.3333333333333333 -3233 keep parsimony-informative 0.3333333333333333 -3234 keep parsimony-informative 0.3333333333333333 -3235 keep parsimony-informative 0.3333333333333333 -3236 keep parsimony-informative 0.3333333333333333 -3237 keep parsimony-informative 0.3333333333333333 -3238 keep singleton 0.3333333333333333 -3239 keep parsimony-informative 0.3333333333333333 -3240 keep parsimony-informative 0.3333333333333333 -3241 keep parsimony-informative 0.3333333333333333 -3242 keep singleton 0.3333333333333333 -3243 keep parsimony-informative 0.3333333333333333 -3244 keep parsimony-informative 0.3333333333333333 -3245 keep parsimony-informative 0.3333333333333333 -3246 keep parsimony-informative 0.3333333333333333 +3229 keep parsimony-informative 0.4167 +3230 keep singleton 0.4167 +3231 keep parsimony-informative 0.4167 +3232 keep parsimony-informative 0.3333 +3233 keep parsimony-informative 0.3333 +3234 keep parsimony-informative 0.3333 +3235 keep parsimony-informative 0.3333 +3236 keep parsimony-informative 0.3333 +3237 keep parsimony-informative 0.3333 +3238 keep singleton 0.3333 +3239 keep parsimony-informative 0.3333 +3240 keep parsimony-informative 0.3333 +3241 keep parsimony-informative 0.3333 +3242 keep singleton 0.3333 +3243 keep parsimony-informative 0.3333 +3244 keep parsimony-informative 0.3333 +3245 keep parsimony-informative 0.3333 +3246 keep parsimony-informative 0.3333 3247 keep parsimony-informative 0.25 3248 keep singleton 0.25 3249 keep parsimony-informative 0.25 @@ -3256,111 +3256,111 @@ 3256 keep parsimony-informative 0.25 3257 keep parsimony-informative 0.25 3258 keep parsimony-informative 0.25 -3259 keep parsimony-informative 0.16666666666666666 -3260 keep parsimony-informative 0.16666666666666666 -3261 keep parsimony-informative 0.16666666666666666 -3262 keep parsimony-informative 0.16666666666666666 -3263 keep parsimony-informative 0.16666666666666666 -3264 keep parsimony-informative 0.16666666666666666 -3265 trim other 0.9166666666666666 -3266 trim other 0.9166666666666666 -3267 trim other 0.9166666666666666 -3268 trim other 0.9166666666666666 -3269 trim other 0.9166666666666666 -3270 trim other 0.9166666666666666 -3271 trim other 0.9166666666666666 -3272 trim other 0.9166666666666666 -3273 trim other 0.9166666666666666 -3274 trim other 0.9166666666666666 -3275 trim other 0.9166666666666666 -3276 trim other 0.9166666666666666 -3277 trim other 0.9166666666666666 -3278 trim other 0.9166666666666666 -3279 trim other 0.9166666666666666 -3280 trim other 0.9166666666666666 -3281 trim other 0.9166666666666666 -3282 trim other 0.9166666666666666 -3283 trim other 0.9166666666666666 -3284 trim other 0.9166666666666666 -3285 trim other 0.9166666666666666 -3286 keep other 0.8333333333333334 -3287 keep other 0.8333333333333334 -3288 keep other 0.8333333333333334 -3289 keep constant 0.8333333333333334 -3290 keep constant 0.8333333333333334 -3291 keep other 0.8333333333333334 -3292 keep other 0.8333333333333334 -3293 keep other 0.8333333333333334 -3294 keep other 0.8333333333333334 -3295 keep constant 0.8333333333333334 -3296 keep other 0.8333333333333334 -3297 keep other 0.8333333333333334 -3298 trim other 0.9166666666666666 -3299 trim other 0.9166666666666666 -3300 trim other 0.9166666666666666 -3301 keep constant 0.8333333333333334 -3302 keep other 0.8333333333333334 -3303 keep constant 0.8333333333333334 -3304 keep other 0.8333333333333334 -3305 keep constant 0.8333333333333334 -3306 keep other 0.8333333333333334 -3307 keep other 0.8333333333333334 -3308 keep constant 0.8333333333333334 -3309 keep other 0.8333333333333334 -3310 keep parsimony-informative 0.08333333333333333 -3311 keep parsimony-informative 0.08333333333333333 -3312 keep parsimony-informative 0.08333333333333333 -3313 keep parsimony-informative 0.08333333333333333 -3314 keep parsimony-informative 0.08333333333333333 -3315 keep parsimony-informative 0.08333333333333333 -3316 keep singleton 0.08333333333333333 -3317 keep parsimony-informative 0.08333333333333333 -3318 keep parsimony-informative 0.08333333333333333 -3319 keep parsimony-informative 0.08333333333333333 -3320 keep singleton 0.08333333333333333 -3321 keep singleton 0.08333333333333333 -3322 keep singleton 0.08333333333333333 -3323 keep singleton 0.08333333333333333 -3324 keep parsimony-informative 0.08333333333333333 -3325 keep singleton 0.08333333333333333 -3326 keep constant 0.08333333333333333 -3327 keep parsimony-informative 0.08333333333333333 -3328 keep singleton 0.08333333333333333 -3329 keep singleton 0.08333333333333333 -3330 keep parsimony-informative 0.08333333333333333 -3331 keep parsimony-informative 0.08333333333333333 -3332 keep parsimony-informative 0.08333333333333333 -3333 keep parsimony-informative 0.08333333333333333 -3334 keep parsimony-informative 0.08333333333333333 -3335 keep parsimony-informative 0.08333333333333333 -3336 keep parsimony-informative 0.08333333333333333 -3337 keep parsimony-informative 0.08333333333333333 -3338 keep singleton 0.08333333333333333 -3339 keep parsimony-informative 0.08333333333333333 +3259 keep parsimony-informative 0.1667 +3260 keep parsimony-informative 0.1667 +3261 keep parsimony-informative 0.1667 +3262 keep parsimony-informative 0.1667 +3263 keep parsimony-informative 0.1667 +3264 keep parsimony-informative 0.1667 +3265 trim other 0.9167 +3266 trim other 0.9167 +3267 trim other 0.9167 +3268 trim other 0.9167 +3269 trim other 0.9167 +3270 trim other 0.9167 +3271 trim other 0.9167 +3272 trim other 0.9167 +3273 trim other 0.9167 +3274 trim other 0.9167 +3275 trim other 0.9167 +3276 trim other 0.9167 +3277 trim other 0.9167 +3278 trim other 0.9167 +3279 trim other 0.9167 +3280 trim other 0.9167 +3281 trim other 0.9167 +3282 trim other 0.9167 +3283 trim other 0.9167 +3284 trim other 0.9167 +3285 trim other 0.9167 +3286 keep other 0.8333 +3287 keep other 0.8333 +3288 keep other 0.8333 +3289 keep constant 0.8333 +3290 keep constant 0.8333 +3291 keep other 0.8333 +3292 keep other 0.8333 +3293 keep other 0.8333 +3294 keep other 0.8333 +3295 keep constant 0.8333 +3296 keep other 0.8333 +3297 keep other 0.8333 +3298 trim other 0.9167 +3299 trim other 0.9167 +3300 trim other 0.9167 +3301 keep constant 0.8333 +3302 keep other 0.8333 +3303 keep constant 0.8333 +3304 keep other 0.8333 +3305 keep constant 0.8333 +3306 keep other 0.8333 +3307 keep other 0.8333 +3308 keep constant 0.8333 +3309 keep other 0.8333 +3310 keep parsimony-informative 0.0833 +3311 keep parsimony-informative 0.0833 +3312 keep parsimony-informative 0.0833 +3313 keep parsimony-informative 0.0833 +3314 keep parsimony-informative 0.0833 +3315 keep parsimony-informative 0.0833 +3316 keep singleton 0.0833 +3317 keep parsimony-informative 0.0833 +3318 keep parsimony-informative 0.0833 +3319 keep parsimony-informative 0.0833 +3320 keep singleton 0.0833 +3321 keep singleton 0.0833 +3322 keep singleton 0.0833 +3323 keep singleton 0.0833 +3324 keep parsimony-informative 0.0833 +3325 keep singleton 0.0833 +3326 keep constant 0.0833 +3327 keep parsimony-informative 0.0833 +3328 keep singleton 0.0833 +3329 keep singleton 0.0833 +3330 keep parsimony-informative 0.0833 +3331 keep parsimony-informative 0.0833 +3332 keep parsimony-informative 0.0833 +3333 keep parsimony-informative 0.0833 +3334 keep parsimony-informative 0.0833 +3335 keep parsimony-informative 0.0833 +3336 keep parsimony-informative 0.0833 +3337 keep parsimony-informative 0.0833 +3338 keep singleton 0.0833 +3339 keep parsimony-informative 0.0833 3340 keep parsimony-informative 0.25 3341 keep parsimony-informative 0.25 3342 keep parsimony-informative 0.25 -3343 keep parsimony-informative 0.3333333333333333 -3344 keep singleton 0.3333333333333333 -3345 keep parsimony-informative 0.3333333333333333 -3346 keep parsimony-informative 0.3333333333333333 -3347 keep singleton 0.3333333333333333 -3348 keep parsimony-informative 0.3333333333333333 -3349 keep parsimony-informative 0.4166666666666667 -3350 keep singleton 0.4166666666666667 -3351 keep parsimony-informative 0.4166666666666667 -3352 keep singleton 0.4166666666666667 -3353 keep parsimony-informative 0.4166666666666667 -3354 keep singleton 0.4166666666666667 -3355 keep parsimony-informative 0.4166666666666667 -3356 keep constant 0.4166666666666667 -3357 keep parsimony-informative 0.4166666666666667 -3358 trim other 0.9166666666666666 -3359 trim other 0.9166666666666666 -3360 trim other 0.9166666666666666 -3361 keep other 0.8333333333333334 -3362 keep constant 0.8333333333333334 -3363 keep other 0.8333333333333334 +3343 keep parsimony-informative 0.3333 +3344 keep singleton 0.3333 +3345 keep parsimony-informative 0.3333 +3346 keep parsimony-informative 0.3333 +3347 keep singleton 0.3333 +3348 keep parsimony-informative 0.3333 +3349 keep parsimony-informative 0.4167 +3350 keep singleton 0.4167 +3351 keep parsimony-informative 0.4167 +3352 keep singleton 0.4167 +3353 keep parsimony-informative 0.4167 +3354 keep singleton 0.4167 +3355 keep parsimony-informative 0.4167 +3356 keep constant 0.4167 +3357 keep parsimony-informative 0.4167 +3358 trim other 0.9167 +3359 trim other 0.9167 +3360 trim other 0.9167 +3361 keep other 0.8333 +3362 keep constant 0.8333 +3363 keep other 0.8333 3364 keep parsimony-informative 0.25 3365 keep parsimony-informative 0.25 3366 keep parsimony-informative 0.25 @@ -3379,30 +3379,30 @@ 3379 keep parsimony-informative 0.25 3380 keep singleton 0.25 3381 keep parsimony-informative 0.25 -3382 keep singleton 0.08333333333333333 -3383 keep parsimony-informative 0.08333333333333333 -3384 keep parsimony-informative 0.08333333333333333 -3385 keep parsimony-informative 0.08333333333333333 -3386 keep parsimony-informative 0.08333333333333333 -3387 keep parsimony-informative 0.08333333333333333 -3388 keep parsimony-informative 0.08333333333333333 -3389 keep parsimony-informative 0.08333333333333333 -3390 keep parsimony-informative 0.08333333333333333 -3391 keep singleton 0.16666666666666666 -3392 keep parsimony-informative 0.16666666666666666 -3393 keep parsimony-informative 0.16666666666666666 -3394 keep constant 0.16666666666666666 -3395 keep constant 0.16666666666666666 -3396 keep parsimony-informative 0.16666666666666666 -3397 keep parsimony-informative 0.16666666666666666 -3398 keep parsimony-informative 0.16666666666666666 -3399 keep parsimony-informative 0.16666666666666666 -3400 keep parsimony-informative 0.16666666666666666 -3401 keep parsimony-informative 0.16666666666666666 -3402 keep parsimony-informative 0.16666666666666666 -3403 trim other 0.9166666666666666 -3404 trim other 0.9166666666666666 -3405 trim other 0.9166666666666666 +3382 keep singleton 0.0833 +3383 keep parsimony-informative 0.0833 +3384 keep parsimony-informative 0.0833 +3385 keep parsimony-informative 0.0833 +3386 keep parsimony-informative 0.0833 +3387 keep parsimony-informative 0.0833 +3388 keep parsimony-informative 0.0833 +3389 keep parsimony-informative 0.0833 +3390 keep parsimony-informative 0.0833 +3391 keep singleton 0.1667 +3392 keep parsimony-informative 0.1667 +3393 keep parsimony-informative 0.1667 +3394 keep constant 0.1667 +3395 keep constant 0.1667 +3396 keep parsimony-informative 0.1667 +3397 keep parsimony-informative 0.1667 +3398 keep parsimony-informative 0.1667 +3399 keep parsimony-informative 0.1667 +3400 keep parsimony-informative 0.1667 +3401 keep parsimony-informative 0.1667 +3402 keep parsimony-informative 0.1667 +3403 trim other 0.9167 +3404 trim other 0.9167 +3405 trim other 0.9167 3406 keep parsimony-informative 0.0 3407 keep singleton 0.0 3408 keep parsimony-informative 0.0 @@ -3430,45 +3430,45 @@ 3430 keep parsimony-informative 0.0 3431 keep parsimony-informative 0.0 3432 keep parsimony-informative 0.0 -3433 keep parsimony-informative 0.3333333333333333 -3434 keep parsimony-informative 0.3333333333333333 -3435 keep parsimony-informative 0.3333333333333333 -3436 keep parsimony-informative 0.4166666666666667 -3437 keep parsimony-informative 0.4166666666666667 -3438 keep parsimony-informative 0.4166666666666667 +3433 keep parsimony-informative 0.3333 +3434 keep parsimony-informative 0.3333 +3435 keep parsimony-informative 0.3333 +3436 keep parsimony-informative 0.4167 +3437 keep parsimony-informative 0.4167 +3438 keep parsimony-informative 0.4167 3439 keep singleton 0.5 3440 keep singleton 0.5 3441 keep singleton 0.5 3442 keep singleton 0.5 3443 keep singleton 0.5 3444 keep singleton 0.5 -3445 keep other 0.8333333333333334 -3446 keep other 0.8333333333333334 -3447 keep other 0.8333333333333334 -3448 keep constant 0.8333333333333334 -3449 keep constant 0.8333333333333334 -3450 keep other 0.8333333333333334 -3451 keep constant 0.8333333333333334 -3452 keep constant 0.8333333333333334 -3453 keep constant 0.8333333333333334 -3454 keep other 0.8333333333333334 -3455 keep constant 0.8333333333333334 -3456 keep other 0.8333333333333334 -3457 keep other 0.8333333333333334 -3458 keep other 0.8333333333333334 -3459 keep other 0.8333333333333334 -3460 trim other 0.9166666666666666 -3461 trim other 0.9166666666666666 -3462 trim other 0.9166666666666666 -3463 trim other 0.9166666666666666 -3464 trim other 0.9166666666666666 -3465 trim other 0.9166666666666666 -3466 keep constant 0.8333333333333334 -3467 keep constant 0.8333333333333334 -3468 keep constant 0.8333333333333334 -3469 keep other 0.8333333333333334 -3470 keep constant 0.8333333333333334 -3471 keep constant 0.8333333333333334 +3445 keep other 0.8333 +3446 keep other 0.8333 +3447 keep other 0.8333 +3448 keep constant 0.8333 +3449 keep constant 0.8333 +3450 keep other 0.8333 +3451 keep constant 0.8333 +3452 keep constant 0.8333 +3453 keep constant 0.8333 +3454 keep other 0.8333 +3455 keep constant 0.8333 +3456 keep other 0.8333 +3457 keep other 0.8333 +3458 keep other 0.8333 +3459 keep other 0.8333 +3460 trim other 0.9167 +3461 trim other 0.9167 +3462 trim other 0.9167 +3463 trim other 0.9167 +3464 trim other 0.9167 +3465 trim other 0.9167 +3466 keep constant 0.8333 +3467 keep constant 0.8333 +3468 keep constant 0.8333 +3469 keep other 0.8333 +3470 keep constant 0.8333 +3471 keep constant 0.8333 3472 keep parsimony-informative 0.0 3473 keep parsimony-informative 0.0 3474 keep parsimony-informative 0.0 @@ -3511,9 +3511,9 @@ 3511 keep parsimony-informative 0.0 3512 keep parsimony-informative 0.0 3513 keep parsimony-informative 0.0 -3514 keep parsimony-informative 0.08333333333333333 -3515 keep parsimony-informative 0.08333333333333333 -3516 keep parsimony-informative 0.08333333333333333 +3514 keep parsimony-informative 0.0833 +3515 keep parsimony-informative 0.0833 +3516 keep parsimony-informative 0.0833 3517 keep parsimony-informative 0.0 3518 keep parsimony-informative 0.0 3519 keep parsimony-informative 0.0 @@ -3529,324 +3529,324 @@ 3529 keep parsimony-informative 0.0 3530 keep parsimony-informative 0.0 3531 keep parsimony-informative 0.0 -3532 keep parsimony-informative 0.08333333333333333 -3533 keep parsimony-informative 0.08333333333333333 -3534 keep parsimony-informative 0.08333333333333333 -3535 keep parsimony-informative 0.08333333333333333 -3536 keep parsimony-informative 0.08333333333333333 -3537 keep parsimony-informative 0.08333333333333333 +3532 keep parsimony-informative 0.0833 +3533 keep parsimony-informative 0.0833 +3534 keep parsimony-informative 0.0833 +3535 keep parsimony-informative 0.0833 +3536 keep parsimony-informative 0.0833 +3537 keep parsimony-informative 0.0833 3538 keep constant 0.75 3539 keep constant 0.75 3540 keep constant 0.75 -3541 trim other 0.9166666666666666 -3542 trim other 0.9166666666666666 -3543 trim other 0.9166666666666666 -3544 trim other 0.9166666666666666 -3545 trim other 0.9166666666666666 -3546 trim other 0.9166666666666666 -3547 trim other 0.9166666666666666 -3548 trim other 0.9166666666666666 -3549 trim other 0.9166666666666666 -3550 trim other 0.9166666666666666 -3551 trim other 0.9166666666666666 -3552 trim other 0.9166666666666666 -3553 trim other 0.9166666666666666 -3554 trim other 0.9166666666666666 -3555 trim other 0.9166666666666666 -3556 trim other 0.9166666666666666 -3557 trim other 0.9166666666666666 -3558 trim other 0.9166666666666666 -3559 trim other 0.9166666666666666 -3560 trim other 0.9166666666666666 -3561 trim other 0.9166666666666666 -3562 keep constant 0.8333333333333334 -3563 keep constant 0.8333333333333334 -3564 keep other 0.8333333333333334 -3565 keep constant 0.8333333333333334 -3566 keep constant 0.8333333333333334 -3567 keep constant 0.8333333333333334 -3568 keep constant 0.8333333333333334 -3569 keep other 0.8333333333333334 -3570 keep constant 0.8333333333333334 -3571 keep other 0.8333333333333334 -3572 keep other 0.8333333333333334 -3573 keep other 0.8333333333333334 -3574 keep constant 0.8333333333333334 -3575 keep constant 0.8333333333333334 -3576 keep other 0.8333333333333334 -3577 keep constant 0.8333333333333334 -3578 keep other 0.8333333333333334 -3579 keep constant 0.8333333333333334 -3580 keep other 0.8333333333333334 -3581 keep other 0.8333333333333334 -3582 keep other 0.8333333333333334 -3583 keep constant 0.8333333333333334 -3584 keep constant 0.8333333333333334 -3585 keep other 0.8333333333333334 -3586 keep other 0.8333333333333334 -3587 keep constant 0.8333333333333334 -3588 keep constant 0.8333333333333334 -3589 keep other 0.8333333333333334 -3590 keep constant 0.8333333333333334 -3591 keep other 0.8333333333333334 -3592 keep constant 0.8333333333333334 -3593 keep constant 0.8333333333333334 -3594 keep constant 0.8333333333333334 -3595 trim other 0.9166666666666666 -3596 trim other 0.9166666666666666 -3597 trim other 0.9166666666666666 -3598 trim other 0.9166666666666666 -3599 trim other 0.9166666666666666 -3600 trim other 0.9166666666666666 -3601 trim other 0.9166666666666666 -3602 trim other 0.9166666666666666 -3603 trim other 0.9166666666666666 -3604 trim other 0.9166666666666666 -3605 trim other 0.9166666666666666 -3606 trim other 0.9166666666666666 -3607 trim other 0.9166666666666666 -3608 trim other 0.9166666666666666 -3609 trim other 0.9166666666666666 -3610 trim other 0.9166666666666666 -3611 trim other 0.9166666666666666 -3612 trim other 0.9166666666666666 -3613 keep constant 0.8333333333333334 -3614 keep constant 0.8333333333333334 -3615 keep constant 0.8333333333333334 -3616 keep other 0.8333333333333334 -3617 keep other 0.8333333333333334 -3618 keep constant 0.8333333333333334 -3619 keep constant 0.8333333333333334 -3620 keep constant 0.8333333333333334 -3621 keep other 0.8333333333333334 -3622 keep other 0.8333333333333334 -3623 keep constant 0.8333333333333334 -3624 keep other 0.8333333333333334 -3625 keep other 0.8333333333333334 -3626 keep other 0.8333333333333334 -3627 keep other 0.8333333333333334 -3628 keep constant 0.8333333333333334 -3629 keep other 0.8333333333333334 -3630 keep constant 0.8333333333333334 -3631 keep other 0.8333333333333334 -3632 keep constant 0.8333333333333334 -3633 keep other 0.8333333333333334 -3634 keep other 0.8333333333333334 -3635 keep other 0.8333333333333334 -3636 keep other 0.8333333333333334 -3637 keep constant 0.8333333333333334 -3638 keep other 0.8333333333333334 -3639 keep other 0.8333333333333334 -3640 keep other 0.8333333333333334 -3641 keep other 0.8333333333333334 -3642 keep other 0.8333333333333334 -3643 keep other 0.8333333333333334 -3644 keep other 0.8333333333333334 -3645 keep constant 0.8333333333333334 -3646 keep other 0.8333333333333334 -3647 keep constant 0.8333333333333334 -3648 keep other 0.8333333333333334 -3649 trim other 0.9166666666666666 -3650 trim other 0.9166666666666666 -3651 trim other 0.9166666666666666 -3652 trim other 0.9166666666666666 -3653 trim other 0.9166666666666666 -3654 trim other 0.9166666666666666 -3655 trim other 0.9166666666666666 -3656 trim other 0.9166666666666666 -3657 trim other 0.9166666666666666 -3658 trim other 0.9166666666666666 -3659 trim other 0.9166666666666666 -3660 trim other 0.9166666666666666 -3661 trim other 0.9166666666666666 -3662 trim other 0.9166666666666666 -3663 trim other 0.9166666666666666 -3664 trim other 0.9166666666666666 -3665 trim other 0.9166666666666666 -3666 trim other 0.9166666666666666 -3667 trim other 0.9166666666666666 -3668 trim other 0.9166666666666666 -3669 trim other 0.9166666666666666 -3670 trim other 0.9166666666666666 -3671 trim other 0.9166666666666666 -3672 trim other 0.9166666666666666 -3673 trim other 0.9166666666666666 -3674 trim other 0.9166666666666666 -3675 trim other 0.9166666666666666 -3676 trim other 0.9166666666666666 -3677 trim other 0.9166666666666666 -3678 trim other 0.9166666666666666 -3679 trim other 0.9166666666666666 -3680 trim other 0.9166666666666666 -3681 trim other 0.9166666666666666 -3682 trim other 0.9166666666666666 -3683 trim other 0.9166666666666666 -3684 trim other 0.9166666666666666 -3685 trim other 0.9166666666666666 -3686 trim other 0.9166666666666666 -3687 trim other 0.9166666666666666 -3688 trim other 0.9166666666666666 -3689 trim other 0.9166666666666666 -3690 trim other 0.9166666666666666 -3691 trim other 0.9166666666666666 -3692 trim other 0.9166666666666666 -3693 trim other 0.9166666666666666 -3694 trim other 0.9166666666666666 -3695 trim other 0.9166666666666666 -3696 trim other 0.9166666666666666 -3697 trim other 0.9166666666666666 -3698 trim other 0.9166666666666666 -3699 trim other 0.9166666666666666 -3700 trim other 0.9166666666666666 -3701 trim other 0.9166666666666666 -3702 trim other 0.9166666666666666 -3703 trim other 0.9166666666666666 -3704 trim other 0.9166666666666666 -3705 trim other 0.9166666666666666 -3706 trim other 0.9166666666666666 -3707 trim other 0.9166666666666666 -3708 trim other 0.9166666666666666 -3709 trim other 0.9166666666666666 -3710 trim other 0.9166666666666666 -3711 trim other 0.9166666666666666 -3712 trim other 0.9166666666666666 -3713 trim other 0.9166666666666666 -3714 trim other 0.9166666666666666 -3715 trim other 0.9166666666666666 -3716 trim other 0.9166666666666666 -3717 trim other 0.9166666666666666 -3718 trim other 0.9166666666666666 -3719 trim other 0.9166666666666666 -3720 trim other 0.9166666666666666 -3721 trim other 0.9166666666666666 -3722 trim other 0.9166666666666666 -3723 trim other 0.9166666666666666 -3724 trim other 0.9166666666666666 -3725 trim other 0.9166666666666666 -3726 trim other 0.9166666666666666 -3727 trim other 0.9166666666666666 -3728 trim other 0.9166666666666666 -3729 trim other 0.9166666666666666 -3730 trim other 0.9166666666666666 -3731 trim other 0.9166666666666666 -3732 trim other 0.9166666666666666 -3733 trim other 0.9166666666666666 -3734 trim other 0.9166666666666666 -3735 trim other 0.9166666666666666 -3736 trim other 0.9166666666666666 -3737 trim other 0.9166666666666666 -3738 trim other 0.9166666666666666 -3739 trim other 0.9166666666666666 -3740 trim other 0.9166666666666666 -3741 trim other 0.9166666666666666 -3742 trim other 0.9166666666666666 -3743 trim other 0.9166666666666666 -3744 trim other 0.9166666666666666 -3745 trim other 0.9166666666666666 -3746 trim other 0.9166666666666666 -3747 trim other 0.9166666666666666 -3748 trim other 0.9166666666666666 -3749 trim other 0.9166666666666666 -3750 trim other 0.9166666666666666 -3751 trim other 0.9166666666666666 -3752 trim other 0.9166666666666666 -3753 trim other 0.9166666666666666 -3754 trim other 0.9166666666666666 -3755 trim other 0.9166666666666666 -3756 trim other 0.9166666666666666 -3757 trim other 0.9166666666666666 -3758 trim other 0.9166666666666666 -3759 trim other 0.9166666666666666 -3760 trim other 0.9166666666666666 -3761 trim other 0.9166666666666666 -3762 trim other 0.9166666666666666 -3763 trim other 0.9166666666666666 -3764 trim other 0.9166666666666666 -3765 trim other 0.9166666666666666 -3766 trim other 0.9166666666666666 -3767 trim other 0.9166666666666666 -3768 trim other 0.9166666666666666 -3769 keep constant 0.8333333333333334 -3770 keep constant 0.8333333333333334 -3771 keep other 0.8333333333333334 -3772 keep constant 0.8333333333333334 -3773 keep constant 0.8333333333333334 -3774 keep constant 0.8333333333333334 -3775 keep other 0.8333333333333334 -3776 keep constant 0.8333333333333334 -3777 keep constant 0.8333333333333334 -3778 keep constant 0.8333333333333334 -3779 keep other 0.8333333333333334 -3780 keep other 0.8333333333333334 -3781 trim other 0.9166666666666666 -3782 trim other 0.9166666666666666 -3783 trim other 0.9166666666666666 -3784 trim other 0.9166666666666666 -3785 trim other 0.9166666666666666 -3786 trim other 0.9166666666666666 -3787 trim other 0.9166666666666666 -3788 trim other 0.9166666666666666 -3789 trim other 0.9166666666666666 -3790 trim other 0.9166666666666666 -3791 trim other 0.9166666666666666 -3792 trim other 0.9166666666666666 -3793 trim other 0.9166666666666666 -3794 trim other 0.9166666666666666 -3795 trim other 0.9166666666666666 -3796 trim other 0.9166666666666666 -3797 trim other 0.9166666666666666 -3798 trim other 0.9166666666666666 -3799 trim other 0.9166666666666666 -3800 trim other 0.9166666666666666 -3801 trim other 0.9166666666666666 -3802 trim other 0.9166666666666666 -3803 trim other 0.9166666666666666 -3804 trim other 0.9166666666666666 -3805 trim other 0.9166666666666666 -3806 trim other 0.9166666666666666 -3807 trim other 0.9166666666666666 -3808 trim other 0.9166666666666666 -3809 trim other 0.9166666666666666 -3810 trim other 0.9166666666666666 -3811 trim other 0.9166666666666666 -3812 trim other 0.9166666666666666 -3813 trim other 0.9166666666666666 -3814 trim other 0.9166666666666666 -3815 trim other 0.9166666666666666 -3816 trim other 0.9166666666666666 -3817 trim other 0.9166666666666666 -3818 trim other 0.9166666666666666 -3819 trim other 0.9166666666666666 -3820 trim other 0.9166666666666666 -3821 trim other 0.9166666666666666 -3822 trim other 0.9166666666666666 -3823 trim other 0.9166666666666666 -3824 trim other 0.9166666666666666 -3825 trim other 0.9166666666666666 -3826 trim other 0.9166666666666666 -3827 trim other 0.9166666666666666 -3828 trim other 0.9166666666666666 -3829 trim other 0.9166666666666666 -3830 trim other 0.9166666666666666 -3831 trim other 0.9166666666666666 -3832 trim other 0.9166666666666666 -3833 trim other 0.9166666666666666 -3834 trim other 0.9166666666666666 -3835 keep other 0.8333333333333334 -3836 keep constant 0.8333333333333334 -3837 keep constant 0.8333333333333334 -3838 keep other 0.8333333333333334 -3839 keep constant 0.8333333333333334 -3840 keep constant 0.8333333333333334 -3841 keep constant 0.8333333333333334 -3842 keep constant 0.8333333333333334 -3843 keep constant 0.8333333333333334 -3844 keep constant 0.8333333333333334 -3845 keep other 0.8333333333333334 -3846 keep constant 0.8333333333333334 -3847 keep singleton 0.6666666666666666 -3848 keep singleton 0.6666666666666666 -3849 keep parsimony-informative 0.6666666666666666 +3541 trim other 0.9167 +3542 trim other 0.9167 +3543 trim other 0.9167 +3544 trim other 0.9167 +3545 trim other 0.9167 +3546 trim other 0.9167 +3547 trim other 0.9167 +3548 trim other 0.9167 +3549 trim other 0.9167 +3550 trim other 0.9167 +3551 trim other 0.9167 +3552 trim other 0.9167 +3553 trim other 0.9167 +3554 trim other 0.9167 +3555 trim other 0.9167 +3556 trim other 0.9167 +3557 trim other 0.9167 +3558 trim other 0.9167 +3559 trim other 0.9167 +3560 trim other 0.9167 +3561 trim other 0.9167 +3562 keep constant 0.8333 +3563 keep constant 0.8333 +3564 keep other 0.8333 +3565 keep constant 0.8333 +3566 keep constant 0.8333 +3567 keep constant 0.8333 +3568 keep constant 0.8333 +3569 keep other 0.8333 +3570 keep constant 0.8333 +3571 keep other 0.8333 +3572 keep other 0.8333 +3573 keep other 0.8333 +3574 keep constant 0.8333 +3575 keep constant 0.8333 +3576 keep other 0.8333 +3577 keep constant 0.8333 +3578 keep other 0.8333 +3579 keep constant 0.8333 +3580 keep other 0.8333 +3581 keep other 0.8333 +3582 keep other 0.8333 +3583 keep constant 0.8333 +3584 keep constant 0.8333 +3585 keep other 0.8333 +3586 keep other 0.8333 +3587 keep constant 0.8333 +3588 keep constant 0.8333 +3589 keep other 0.8333 +3590 keep constant 0.8333 +3591 keep other 0.8333 +3592 keep constant 0.8333 +3593 keep constant 0.8333 +3594 keep constant 0.8333 +3595 trim other 0.9167 +3596 trim other 0.9167 +3597 trim other 0.9167 +3598 trim other 0.9167 +3599 trim other 0.9167 +3600 trim other 0.9167 +3601 trim other 0.9167 +3602 trim other 0.9167 +3603 trim other 0.9167 +3604 trim other 0.9167 +3605 trim other 0.9167 +3606 trim other 0.9167 +3607 trim other 0.9167 +3608 trim other 0.9167 +3609 trim other 0.9167 +3610 trim other 0.9167 +3611 trim other 0.9167 +3612 trim other 0.9167 +3613 keep constant 0.8333 +3614 keep constant 0.8333 +3615 keep constant 0.8333 +3616 keep other 0.8333 +3617 keep other 0.8333 +3618 keep constant 0.8333 +3619 keep constant 0.8333 +3620 keep constant 0.8333 +3621 keep other 0.8333 +3622 keep other 0.8333 +3623 keep constant 0.8333 +3624 keep other 0.8333 +3625 keep other 0.8333 +3626 keep other 0.8333 +3627 keep other 0.8333 +3628 keep constant 0.8333 +3629 keep other 0.8333 +3630 keep constant 0.8333 +3631 keep other 0.8333 +3632 keep constant 0.8333 +3633 keep other 0.8333 +3634 keep other 0.8333 +3635 keep other 0.8333 +3636 keep other 0.8333 +3637 keep constant 0.8333 +3638 keep other 0.8333 +3639 keep other 0.8333 +3640 keep other 0.8333 +3641 keep other 0.8333 +3642 keep other 0.8333 +3643 keep other 0.8333 +3644 keep other 0.8333 +3645 keep constant 0.8333 +3646 keep other 0.8333 +3647 keep constant 0.8333 +3648 keep other 0.8333 +3649 trim other 0.9167 +3650 trim other 0.9167 +3651 trim other 0.9167 +3652 trim other 0.9167 +3653 trim other 0.9167 +3654 trim other 0.9167 +3655 trim other 0.9167 +3656 trim other 0.9167 +3657 trim other 0.9167 +3658 trim other 0.9167 +3659 trim other 0.9167 +3660 trim other 0.9167 +3661 trim other 0.9167 +3662 trim other 0.9167 +3663 trim other 0.9167 +3664 trim other 0.9167 +3665 trim other 0.9167 +3666 trim other 0.9167 +3667 trim other 0.9167 +3668 trim other 0.9167 +3669 trim other 0.9167 +3670 trim other 0.9167 +3671 trim other 0.9167 +3672 trim other 0.9167 +3673 trim other 0.9167 +3674 trim other 0.9167 +3675 trim other 0.9167 +3676 trim other 0.9167 +3677 trim other 0.9167 +3678 trim other 0.9167 +3679 trim other 0.9167 +3680 trim other 0.9167 +3681 trim other 0.9167 +3682 trim other 0.9167 +3683 trim other 0.9167 +3684 trim other 0.9167 +3685 trim other 0.9167 +3686 trim other 0.9167 +3687 trim other 0.9167 +3688 trim other 0.9167 +3689 trim other 0.9167 +3690 trim other 0.9167 +3691 trim other 0.9167 +3692 trim other 0.9167 +3693 trim other 0.9167 +3694 trim other 0.9167 +3695 trim other 0.9167 +3696 trim other 0.9167 +3697 trim other 0.9167 +3698 trim other 0.9167 +3699 trim other 0.9167 +3700 trim other 0.9167 +3701 trim other 0.9167 +3702 trim other 0.9167 +3703 trim other 0.9167 +3704 trim other 0.9167 +3705 trim other 0.9167 +3706 trim other 0.9167 +3707 trim other 0.9167 +3708 trim other 0.9167 +3709 trim other 0.9167 +3710 trim other 0.9167 +3711 trim other 0.9167 +3712 trim other 0.9167 +3713 trim other 0.9167 +3714 trim other 0.9167 +3715 trim other 0.9167 +3716 trim other 0.9167 +3717 trim other 0.9167 +3718 trim other 0.9167 +3719 trim other 0.9167 +3720 trim other 0.9167 +3721 trim other 0.9167 +3722 trim other 0.9167 +3723 trim other 0.9167 +3724 trim other 0.9167 +3725 trim other 0.9167 +3726 trim other 0.9167 +3727 trim other 0.9167 +3728 trim other 0.9167 +3729 trim other 0.9167 +3730 trim other 0.9167 +3731 trim other 0.9167 +3732 trim other 0.9167 +3733 trim other 0.9167 +3734 trim other 0.9167 +3735 trim other 0.9167 +3736 trim other 0.9167 +3737 trim other 0.9167 +3738 trim other 0.9167 +3739 trim other 0.9167 +3740 trim other 0.9167 +3741 trim other 0.9167 +3742 trim other 0.9167 +3743 trim other 0.9167 +3744 trim other 0.9167 +3745 trim other 0.9167 +3746 trim other 0.9167 +3747 trim other 0.9167 +3748 trim other 0.9167 +3749 trim other 0.9167 +3750 trim other 0.9167 +3751 trim other 0.9167 +3752 trim other 0.9167 +3753 trim other 0.9167 +3754 trim other 0.9167 +3755 trim other 0.9167 +3756 trim other 0.9167 +3757 trim other 0.9167 +3758 trim other 0.9167 +3759 trim other 0.9167 +3760 trim other 0.9167 +3761 trim other 0.9167 +3762 trim other 0.9167 +3763 trim other 0.9167 +3764 trim other 0.9167 +3765 trim other 0.9167 +3766 trim other 0.9167 +3767 trim other 0.9167 +3768 trim other 0.9167 +3769 keep constant 0.8333 +3770 keep constant 0.8333 +3771 keep other 0.8333 +3772 keep constant 0.8333 +3773 keep constant 0.8333 +3774 keep constant 0.8333 +3775 keep other 0.8333 +3776 keep constant 0.8333 +3777 keep constant 0.8333 +3778 keep constant 0.8333 +3779 keep other 0.8333 +3780 keep other 0.8333 +3781 trim other 0.9167 +3782 trim other 0.9167 +3783 trim other 0.9167 +3784 trim other 0.9167 +3785 trim other 0.9167 +3786 trim other 0.9167 +3787 trim other 0.9167 +3788 trim other 0.9167 +3789 trim other 0.9167 +3790 trim other 0.9167 +3791 trim other 0.9167 +3792 trim other 0.9167 +3793 trim other 0.9167 +3794 trim other 0.9167 +3795 trim other 0.9167 +3796 trim other 0.9167 +3797 trim other 0.9167 +3798 trim other 0.9167 +3799 trim other 0.9167 +3800 trim other 0.9167 +3801 trim other 0.9167 +3802 trim other 0.9167 +3803 trim other 0.9167 +3804 trim other 0.9167 +3805 trim other 0.9167 +3806 trim other 0.9167 +3807 trim other 0.9167 +3808 trim other 0.9167 +3809 trim other 0.9167 +3810 trim other 0.9167 +3811 trim other 0.9167 +3812 trim other 0.9167 +3813 trim other 0.9167 +3814 trim other 0.9167 +3815 trim other 0.9167 +3816 trim other 0.9167 +3817 trim other 0.9167 +3818 trim other 0.9167 +3819 trim other 0.9167 +3820 trim other 0.9167 +3821 trim other 0.9167 +3822 trim other 0.9167 +3823 trim other 0.9167 +3824 trim other 0.9167 +3825 trim other 0.9167 +3826 trim other 0.9167 +3827 trim other 0.9167 +3828 trim other 0.9167 +3829 trim other 0.9167 +3830 trim other 0.9167 +3831 trim other 0.9167 +3832 trim other 0.9167 +3833 trim other 0.9167 +3834 trim other 0.9167 +3835 keep other 0.8333 +3836 keep constant 0.8333 +3837 keep constant 0.8333 +3838 keep other 0.8333 +3839 keep constant 0.8333 +3840 keep constant 0.8333 +3841 keep constant 0.8333 +3842 keep constant 0.8333 +3843 keep constant 0.8333 +3844 keep constant 0.8333 +3845 keep other 0.8333 +3846 keep constant 0.8333 +3847 keep singleton 0.6667 +3848 keep singleton 0.6667 +3849 keep parsimony-informative 0.6667 3850 keep parsimony-informative 0.25 3851 keep constant 0.25 3852 keep parsimony-informative 0.25 @@ -3874,15 +3874,15 @@ 3874 keep parsimony-informative 0.25 3875 keep singleton 0.25 3876 keep parsimony-informative 0.25 -3877 keep other 0.8333333333333334 -3878 keep other 0.8333333333333334 -3879 keep other 0.8333333333333334 -3880 trim other 0.9166666666666666 -3881 trim other 0.9166666666666666 -3882 trim other 0.9166666666666666 -3883 keep other 0.8333333333333334 -3884 keep other 0.8333333333333334 -3885 keep other 0.8333333333333334 +3877 keep other 0.8333 +3878 keep other 0.8333 +3879 keep other 0.8333 +3880 trim other 0.9167 +3881 trim other 0.9167 +3882 trim other 0.9167 +3883 keep other 0.8333 +3884 keep other 0.8333 +3885 keep other 0.8333 3886 keep parsimony-informative 0.0 3887 keep constant 0.0 3888 keep parsimony-informative 0.0 @@ -3901,69 +3901,69 @@ 3901 keep parsimony-informative 0.0 3902 keep parsimony-informative 0.0 3903 keep parsimony-informative 0.0 -3904 trim other 0.9166666666666666 -3905 trim other 0.9166666666666666 -3906 trim other 0.9166666666666666 -3907 trim other 0.9166666666666666 -3908 trim other 0.9166666666666666 -3909 trim other 0.9166666666666666 -3910 trim other 0.9166666666666666 -3911 trim other 0.9166666666666666 -3912 trim other 0.9166666666666666 -3913 trim other 0.9166666666666666 -3914 trim other 0.9166666666666666 -3915 trim other 0.9166666666666666 -3916 trim other 0.9166666666666666 -3917 trim other 0.9166666666666666 -3918 trim other 0.9166666666666666 -3919 trim other 0.9166666666666666 -3920 trim other 0.9166666666666666 -3921 trim other 0.9166666666666666 -3922 trim other 0.9166666666666666 -3923 trim other 0.9166666666666666 -3924 trim other 0.9166666666666666 -3925 trim other 0.9166666666666666 -3926 trim other 0.9166666666666666 -3927 trim other 0.9166666666666666 -3928 trim other 0.9166666666666666 -3929 trim other 0.9166666666666666 -3930 trim other 0.9166666666666666 -3931 trim other 0.9166666666666666 -3932 trim other 0.9166666666666666 -3933 trim other 0.9166666666666666 -3934 trim other 0.9166666666666666 -3935 trim other 0.9166666666666666 -3936 trim other 0.9166666666666666 -3937 trim other 0.9166666666666666 -3938 trim other 0.9166666666666666 -3939 trim other 0.9166666666666666 -3940 trim other 0.9166666666666666 -3941 trim other 0.9166666666666666 -3942 trim other 0.9166666666666666 -3943 trim other 0.9166666666666666 -3944 trim other 0.9166666666666666 -3945 trim other 0.9166666666666666 -3946 trim other 0.9166666666666666 -3947 trim other 0.9166666666666666 -3948 trim other 0.9166666666666666 -3949 trim other 0.9166666666666666 -3950 trim other 0.9166666666666666 -3951 trim other 0.9166666666666666 -3952 trim other 0.9166666666666666 -3953 trim other 0.9166666666666666 -3954 trim other 0.9166666666666666 -3955 trim other 0.9166666666666666 -3956 trim other 0.9166666666666666 -3957 trim other 0.9166666666666666 -3958 trim other 0.9166666666666666 -3959 trim other 0.9166666666666666 -3960 trim other 0.9166666666666666 -3961 trim other 0.9166666666666666 -3962 trim other 0.9166666666666666 -3963 trim other 0.9166666666666666 -3964 keep other 0.8333333333333334 -3965 keep other 0.8333333333333334 -3966 keep constant 0.8333333333333334 +3904 trim other 0.9167 +3905 trim other 0.9167 +3906 trim other 0.9167 +3907 trim other 0.9167 +3908 trim other 0.9167 +3909 trim other 0.9167 +3910 trim other 0.9167 +3911 trim other 0.9167 +3912 trim other 0.9167 +3913 trim other 0.9167 +3914 trim other 0.9167 +3915 trim other 0.9167 +3916 trim other 0.9167 +3917 trim other 0.9167 +3918 trim other 0.9167 +3919 trim other 0.9167 +3920 trim other 0.9167 +3921 trim other 0.9167 +3922 trim other 0.9167 +3923 trim other 0.9167 +3924 trim other 0.9167 +3925 trim other 0.9167 +3926 trim other 0.9167 +3927 trim other 0.9167 +3928 trim other 0.9167 +3929 trim other 0.9167 +3930 trim other 0.9167 +3931 trim other 0.9167 +3932 trim other 0.9167 +3933 trim other 0.9167 +3934 trim other 0.9167 +3935 trim other 0.9167 +3936 trim other 0.9167 +3937 trim other 0.9167 +3938 trim other 0.9167 +3939 trim other 0.9167 +3940 trim other 0.9167 +3941 trim other 0.9167 +3942 trim other 0.9167 +3943 trim other 0.9167 +3944 trim other 0.9167 +3945 trim other 0.9167 +3946 trim other 0.9167 +3947 trim other 0.9167 +3948 trim other 0.9167 +3949 trim other 0.9167 +3950 trim other 0.9167 +3951 trim other 0.9167 +3952 trim other 0.9167 +3953 trim other 0.9167 +3954 trim other 0.9167 +3955 trim other 0.9167 +3956 trim other 0.9167 +3957 trim other 0.9167 +3958 trim other 0.9167 +3959 trim other 0.9167 +3960 trim other 0.9167 +3961 trim other 0.9167 +3962 trim other 0.9167 +3963 trim other 0.9167 +3964 keep other 0.8333 +3965 keep other 0.8333 +3966 keep constant 0.8333 3967 keep singleton 0.75 3968 keep singleton 0.75 3969 keep singleton 0.75 @@ -4009,15 +4009,15 @@ 4009 keep singleton 0.0 4010 keep singleton 0.0 4011 keep parsimony-informative 0.0 -4012 trim other 0.9166666666666666 -4013 trim other 0.9166666666666666 -4014 trim other 0.9166666666666666 -4015 trim other 0.9166666666666666 -4016 trim other 0.9166666666666666 -4017 trim other 0.9166666666666666 -4018 trim other 0.9166666666666666 -4019 trim other 0.9166666666666666 -4020 trim other 0.9166666666666666 +4012 trim other 0.9167 +4013 trim other 0.9167 +4014 trim other 0.9167 +4015 trim other 0.9167 +4016 trim other 0.9167 +4017 trim other 0.9167 +4018 trim other 0.9167 +4019 trim other 0.9167 +4020 trim other 0.9167 4021 keep singleton 0.0 4022 keep singleton 0.0 4023 keep parsimony-informative 0.0 @@ -4057,15 +4057,15 @@ 4057 keep parsimony-informative 0.5 4058 keep singleton 0.5 4059 keep parsimony-informative 0.5 -4060 keep parsimony-informative 0.5833333333333334 -4061 keep singleton 0.5833333333333334 -4062 keep singleton 0.5833333333333334 -4063 keep singleton 0.5833333333333334 -4064 keep singleton 0.5833333333333334 -4065 keep singleton 0.5833333333333334 -4066 keep other 0.8333333333333334 -4067 keep other 0.8333333333333334 -4068 keep constant 0.8333333333333334 +4060 keep parsimony-informative 0.5833 +4061 keep singleton 0.5833 +4062 keep singleton 0.5833 +4063 keep singleton 0.5833 +4064 keep singleton 0.5833 +4065 keep singleton 0.5833 +4066 keep other 0.8333 +4067 keep other 0.8333 +4068 keep constant 0.8333 4069 keep parsimony-informative 0.0 4070 keep parsimony-informative 0.0 4071 keep parsimony-informative 0.0 @@ -4129,9 +4129,9 @@ 4129 keep parsimony-informative 0.0 4130 keep constant 0.0 4131 keep parsimony-informative 0.0 -4132 trim other 0.9166666666666666 -4133 trim other 0.9166666666666666 -4134 trim other 0.9166666666666666 +4132 trim other 0.9167 +4133 trim other 0.9167 +4134 trim other 0.9167 4135 keep parsimony-informative 0.0 4136 keep singleton 0.0 4137 keep parsimony-informative 0.0 @@ -4147,12 +4147,12 @@ 4147 keep parsimony-informative 0.0 4148 keep singleton 0.0 4149 keep parsimony-informative 0.0 -4150 keep constant 0.5833333333333334 -4151 keep constant 0.5833333333333334 -4152 keep singleton 0.5833333333333334 -4153 keep singleton 0.5833333333333334 -4154 keep singleton 0.5833333333333334 -4155 keep singleton 0.5833333333333334 +4150 keep constant 0.5833 +4151 keep constant 0.5833 +4152 keep singleton 0.5833 +4153 keep singleton 0.5833 +4154 keep singleton 0.5833 +4155 keep singleton 0.5833 4156 keep constant 0.0 4157 keep constant 0.0 4158 keep singleton 0.0 @@ -4162,24 +4162,24 @@ 4162 keep parsimony-informative 0.0 4163 keep constant 0.0 4164 keep parsimony-informative 0.0 -4165 keep parsimony-informative 0.08333333333333333 -4166 keep parsimony-informative 0.08333333333333333 -4167 keep parsimony-informative 0.08333333333333333 -4168 keep singleton 0.08333333333333333 -4169 keep parsimony-informative 0.08333333333333333 -4170 keep parsimony-informative 0.08333333333333333 -4171 keep parsimony-informative 0.16666666666666666 -4172 keep parsimony-informative 0.16666666666666666 -4173 keep parsimony-informative 0.16666666666666666 -4174 keep other 0.8333333333333334 -4175 keep constant 0.8333333333333334 -4176 keep other 0.8333333333333334 -4177 keep constant 0.8333333333333334 -4178 keep constant 0.8333333333333334 -4179 keep other 0.8333333333333334 -4180 trim other 0.9166666666666666 -4181 trim other 0.9166666666666666 -4182 trim other 0.9166666666666666 +4165 keep parsimony-informative 0.0833 +4166 keep parsimony-informative 0.0833 +4167 keep parsimony-informative 0.0833 +4168 keep singleton 0.0833 +4169 keep parsimony-informative 0.0833 +4170 keep parsimony-informative 0.0833 +4171 keep parsimony-informative 0.1667 +4172 keep parsimony-informative 0.1667 +4173 keep parsimony-informative 0.1667 +4174 keep other 0.8333 +4175 keep constant 0.8333 +4176 keep other 0.8333 +4177 keep constant 0.8333 +4178 keep constant 0.8333 +4179 keep other 0.8333 +4180 trim other 0.9167 +4181 trim other 0.9167 +4182 trim other 0.9167 4183 keep singleton 0.0 4184 keep parsimony-informative 0.0 4185 keep parsimony-informative 0.0 @@ -4189,42 +4189,42 @@ 4189 keep parsimony-informative 0.0 4190 keep parsimony-informative 0.0 4191 keep parsimony-informative 0.0 -4192 keep parsimony-informative 0.08333333333333333 -4193 keep parsimony-informative 0.08333333333333333 -4194 keep parsimony-informative 0.08333333333333333 -4195 keep parsimony-informative 0.08333333333333333 -4196 keep parsimony-informative 0.08333333333333333 -4197 keep parsimony-informative 0.08333333333333333 -4198 keep parsimony-informative 0.08333333333333333 -4199 keep parsimony-informative 0.08333333333333333 -4200 keep parsimony-informative 0.08333333333333333 -4201 keep parsimony-informative 0.08333333333333333 -4202 keep parsimony-informative 0.08333333333333333 -4203 keep parsimony-informative 0.08333333333333333 +4192 keep parsimony-informative 0.0833 +4193 keep parsimony-informative 0.0833 +4194 keep parsimony-informative 0.0833 +4195 keep parsimony-informative 0.0833 +4196 keep parsimony-informative 0.0833 +4197 keep parsimony-informative 0.0833 +4198 keep parsimony-informative 0.0833 +4199 keep parsimony-informative 0.0833 +4200 keep parsimony-informative 0.0833 +4201 keep parsimony-informative 0.0833 +4202 keep parsimony-informative 0.0833 +4203 keep parsimony-informative 0.0833 4204 keep parsimony-informative 0.25 4205 keep parsimony-informative 0.25 4206 keep parsimony-informative 0.25 -4207 trim other 0.9166666666666666 -4208 trim other 0.9166666666666666 -4209 trim other 0.9166666666666666 -4210 trim other 0.9166666666666666 -4211 trim other 0.9166666666666666 -4212 trim other 0.9166666666666666 -4213 trim other 0.9166666666666666 -4214 trim other 0.9166666666666666 -4215 trim other 0.9166666666666666 -4216 trim other 0.9166666666666666 -4217 trim other 0.9166666666666666 -4218 trim other 0.9166666666666666 -4219 trim other 0.9166666666666666 -4220 trim other 0.9166666666666666 -4221 trim other 0.9166666666666666 -4222 trim other 0.9166666666666666 -4223 trim other 0.9166666666666666 -4224 trim other 0.9166666666666666 -4225 trim other 0.9166666666666666 -4226 trim other 0.9166666666666666 -4227 trim other 0.9166666666666666 +4207 trim other 0.9167 +4208 trim other 0.9167 +4209 trim other 0.9167 +4210 trim other 0.9167 +4211 trim other 0.9167 +4212 trim other 0.9167 +4213 trim other 0.9167 +4214 trim other 0.9167 +4215 trim other 0.9167 +4216 trim other 0.9167 +4217 trim other 0.9167 +4218 trim other 0.9167 +4219 trim other 0.9167 +4220 trim other 0.9167 +4221 trim other 0.9167 +4222 trim other 0.9167 +4223 trim other 0.9167 +4224 trim other 0.9167 +4225 trim other 0.9167 +4226 trim other 0.9167 +4227 trim other 0.9167 4228 keep constant 0.75 4229 keep singleton 0.75 4230 keep singleton 0.75 @@ -4252,63 +4252,63 @@ 4252 keep singleton 0.75 4253 keep singleton 0.75 4254 keep singleton 0.75 -4255 keep parsimony-informative 0.3333333333333333 -4256 keep parsimony-informative 0.3333333333333333 -4257 keep parsimony-informative 0.3333333333333333 -4258 keep parsimony-informative 0.3333333333333333 -4259 keep parsimony-informative 0.3333333333333333 -4260 keep parsimony-informative 0.3333333333333333 -4261 keep parsimony-informative 0.08333333333333333 -4262 keep parsimony-informative 0.08333333333333333 -4263 keep singleton 0.08333333333333333 -4264 keep parsimony-informative 0.08333333333333333 -4265 keep parsimony-informative 0.08333333333333333 -4266 keep parsimony-informative 0.08333333333333333 -4267 keep parsimony-informative 0.08333333333333333 -4268 keep parsimony-informative 0.08333333333333333 -4269 keep parsimony-informative 0.08333333333333333 -4270 keep parsimony-informative 0.08333333333333333 -4271 keep parsimony-informative 0.08333333333333333 -4272 keep parsimony-informative 0.08333333333333333 -4273 keep singleton 0.08333333333333333 -4274 keep constant 0.08333333333333333 -4275 keep parsimony-informative 0.08333333333333333 -4276 keep parsimony-informative 0.16666666666666666 -4277 keep parsimony-informative 0.16666666666666666 -4278 keep parsimony-informative 0.16666666666666666 -4279 keep parsimony-informative 0.16666666666666666 -4280 keep parsimony-informative 0.16666666666666666 -4281 keep parsimony-informative 0.16666666666666666 -4282 keep parsimony-informative 0.3333333333333333 -4283 keep singleton 0.3333333333333333 -4284 keep parsimony-informative 0.3333333333333333 -4285 trim other 0.9166666666666666 -4286 trim other 0.9166666666666666 -4287 trim other 0.9166666666666666 -4288 trim other 0.9166666666666666 -4289 trim other 0.9166666666666666 -4290 trim other 0.9166666666666666 -4291 trim other 0.9166666666666666 -4292 trim other 0.9166666666666666 -4293 trim other 0.9166666666666666 -4294 trim other 0.9166666666666666 -4295 trim other 0.9166666666666666 -4296 trim other 0.9166666666666666 -4297 trim other 0.9166666666666666 -4298 trim other 0.9166666666666666 -4299 trim other 0.9166666666666666 -4300 trim other 0.9166666666666666 -4301 trim other 0.9166666666666666 -4302 trim other 0.9166666666666666 -4303 trim other 0.9166666666666666 -4304 trim other 0.9166666666666666 -4305 trim other 0.9166666666666666 -4306 trim other 0.9166666666666666 -4307 trim other 0.9166666666666666 -4308 trim other 0.9166666666666666 -4309 trim other 0.9166666666666666 -4310 trim other 0.9166666666666666 -4311 trim other 0.9166666666666666 +4255 keep parsimony-informative 0.3333 +4256 keep parsimony-informative 0.3333 +4257 keep parsimony-informative 0.3333 +4258 keep parsimony-informative 0.3333 +4259 keep parsimony-informative 0.3333 +4260 keep parsimony-informative 0.3333 +4261 keep parsimony-informative 0.0833 +4262 keep parsimony-informative 0.0833 +4263 keep singleton 0.0833 +4264 keep parsimony-informative 0.0833 +4265 keep parsimony-informative 0.0833 +4266 keep parsimony-informative 0.0833 +4267 keep parsimony-informative 0.0833 +4268 keep parsimony-informative 0.0833 +4269 keep parsimony-informative 0.0833 +4270 keep parsimony-informative 0.0833 +4271 keep parsimony-informative 0.0833 +4272 keep parsimony-informative 0.0833 +4273 keep singleton 0.0833 +4274 keep constant 0.0833 +4275 keep parsimony-informative 0.0833 +4276 keep parsimony-informative 0.1667 +4277 keep parsimony-informative 0.1667 +4278 keep parsimony-informative 0.1667 +4279 keep parsimony-informative 0.1667 +4280 keep parsimony-informative 0.1667 +4281 keep parsimony-informative 0.1667 +4282 keep parsimony-informative 0.3333 +4283 keep singleton 0.3333 +4284 keep parsimony-informative 0.3333 +4285 trim other 0.9167 +4286 trim other 0.9167 +4287 trim other 0.9167 +4288 trim other 0.9167 +4289 trim other 0.9167 +4290 trim other 0.9167 +4291 trim other 0.9167 +4292 trim other 0.9167 +4293 trim other 0.9167 +4294 trim other 0.9167 +4295 trim other 0.9167 +4296 trim other 0.9167 +4297 trim other 0.9167 +4298 trim other 0.9167 +4299 trim other 0.9167 +4300 trim other 0.9167 +4301 trim other 0.9167 +4302 trim other 0.9167 +4303 trim other 0.9167 +4304 trim other 0.9167 +4305 trim other 0.9167 +4306 trim other 0.9167 +4307 trim other 0.9167 +4308 trim other 0.9167 +4309 trim other 0.9167 +4310 trim other 0.9167 +4311 trim other 0.9167 4312 keep parsimony-informative 0.0 4313 keep parsimony-informative 0.0 4314 keep parsimony-informative 0.0 @@ -4327,108 +4327,108 @@ 4327 keep singleton 0.0 4328 keep singleton 0.0 4329 keep parsimony-informative 0.0 -4330 keep other 0.8333333333333334 -4331 keep constant 0.8333333333333334 -4332 keep other 0.8333333333333334 -4333 trim other 0.9166666666666666 -4334 trim other 0.9166666666666666 -4335 trim other 0.9166666666666666 +4330 keep other 0.8333 +4331 keep constant 0.8333 +4332 keep other 0.8333 +4333 trim other 0.9167 +4334 trim other 0.9167 +4335 trim other 0.9167 4336 keep parsimony-informative 0.25 4337 keep singleton 0.25 4338 keep parsimony-informative 0.25 -4339 keep singleton 0.5833333333333334 -4340 keep singleton 0.5833333333333334 -4341 keep singleton 0.5833333333333334 -4342 keep singleton 0.5833333333333334 -4343 keep singleton 0.5833333333333334 -4344 keep parsimony-informative 0.5833333333333334 -4345 keep singleton 0.5833333333333334 -4346 keep singleton 0.5833333333333334 -4347 keep singleton 0.5833333333333334 -4348 keep singleton 0.5833333333333334 -4349 keep parsimony-informative 0.5833333333333334 -4350 keep singleton 0.5833333333333334 -4351 keep singleton 0.5833333333333334 -4352 keep singleton 0.5833333333333334 -4353 keep singleton 0.5833333333333334 -4354 trim other 0.9166666666666666 -4355 trim other 0.9166666666666666 -4356 trim other 0.9166666666666666 -4357 trim other 0.9166666666666666 -4358 trim other 0.9166666666666666 -4359 trim other 0.9166666666666666 -4360 trim other 0.9166666666666666 -4361 trim other 0.9166666666666666 -4362 trim other 0.9166666666666666 -4363 trim other 0.9166666666666666 -4364 trim other 0.9166666666666666 -4365 trim other 0.9166666666666666 -4366 trim other 0.9166666666666666 -4367 trim other 0.9166666666666666 -4368 trim other 0.9166666666666666 -4369 keep singleton 0.5833333333333334 -4370 keep singleton 0.5833333333333334 -4371 keep singleton 0.5833333333333334 -4372 keep constant 0.5833333333333334 -4373 keep singleton 0.5833333333333334 -4374 keep parsimony-informative 0.5833333333333334 -4375 keep parsimony-informative 0.5833333333333334 -4376 keep singleton 0.5833333333333334 -4377 keep parsimony-informative 0.5833333333333334 -4378 keep singleton 0.5833333333333334 -4379 keep constant 0.5833333333333334 -4380 keep singleton 0.5833333333333334 -4381 keep singleton 0.5833333333333334 -4382 keep singleton 0.5833333333333334 -4383 keep singleton 0.5833333333333334 -4384 keep singleton 0.5833333333333334 -4385 keep singleton 0.5833333333333334 -4386 keep singleton 0.5833333333333334 -4387 keep parsimony-informative 0.4166666666666667 -4388 keep constant 0.4166666666666667 -4389 keep parsimony-informative 0.4166666666666667 -4390 keep singleton 0.4166666666666667 -4391 keep parsimony-informative 0.4166666666666667 -4392 keep parsimony-informative 0.4166666666666667 -4393 keep parsimony-informative 0.4166666666666667 -4394 keep parsimony-informative 0.4166666666666667 -4395 keep parsimony-informative 0.4166666666666667 -4396 keep parsimony-informative 0.4166666666666667 -4397 keep parsimony-informative 0.4166666666666667 -4398 keep singleton 0.4166666666666667 -4399 keep singleton 0.4166666666666667 -4400 keep singleton 0.4166666666666667 -4401 keep constant 0.4166666666666667 -4402 keep singleton 0.4166666666666667 -4403 keep parsimony-informative 0.4166666666666667 -4404 keep parsimony-informative 0.4166666666666667 -4405 keep singleton 0.4166666666666667 -4406 keep parsimony-informative 0.4166666666666667 -4407 keep parsimony-informative 0.4166666666666667 -4408 keep singleton 0.4166666666666667 -4409 keep parsimony-informative 0.4166666666666667 -4410 keep parsimony-informative 0.4166666666666667 +4339 keep singleton 0.5833 +4340 keep singleton 0.5833 +4341 keep singleton 0.5833 +4342 keep singleton 0.5833 +4343 keep singleton 0.5833 +4344 keep parsimony-informative 0.5833 +4345 keep singleton 0.5833 +4346 keep singleton 0.5833 +4347 keep singleton 0.5833 +4348 keep singleton 0.5833 +4349 keep parsimony-informative 0.5833 +4350 keep singleton 0.5833 +4351 keep singleton 0.5833 +4352 keep singleton 0.5833 +4353 keep singleton 0.5833 +4354 trim other 0.9167 +4355 trim other 0.9167 +4356 trim other 0.9167 +4357 trim other 0.9167 +4358 trim other 0.9167 +4359 trim other 0.9167 +4360 trim other 0.9167 +4361 trim other 0.9167 +4362 trim other 0.9167 +4363 trim other 0.9167 +4364 trim other 0.9167 +4365 trim other 0.9167 +4366 trim other 0.9167 +4367 trim other 0.9167 +4368 trim other 0.9167 +4369 keep singleton 0.5833 +4370 keep singleton 0.5833 +4371 keep singleton 0.5833 +4372 keep constant 0.5833 +4373 keep singleton 0.5833 +4374 keep parsimony-informative 0.5833 +4375 keep parsimony-informative 0.5833 +4376 keep singleton 0.5833 +4377 keep parsimony-informative 0.5833 +4378 keep singleton 0.5833 +4379 keep constant 0.5833 +4380 keep singleton 0.5833 +4381 keep singleton 0.5833 +4382 keep singleton 0.5833 +4383 keep singleton 0.5833 +4384 keep singleton 0.5833 +4385 keep singleton 0.5833 +4386 keep singleton 0.5833 +4387 keep parsimony-informative 0.4167 +4388 keep constant 0.4167 +4389 keep parsimony-informative 0.4167 +4390 keep singleton 0.4167 +4391 keep parsimony-informative 0.4167 +4392 keep parsimony-informative 0.4167 +4393 keep parsimony-informative 0.4167 +4394 keep parsimony-informative 0.4167 +4395 keep parsimony-informative 0.4167 +4396 keep parsimony-informative 0.4167 +4397 keep parsimony-informative 0.4167 +4398 keep singleton 0.4167 +4399 keep singleton 0.4167 +4400 keep singleton 0.4167 +4401 keep constant 0.4167 +4402 keep singleton 0.4167 +4403 keep parsimony-informative 0.4167 +4404 keep parsimony-informative 0.4167 +4405 keep singleton 0.4167 +4406 keep parsimony-informative 0.4167 +4407 keep parsimony-informative 0.4167 +4408 keep singleton 0.4167 +4409 keep parsimony-informative 0.4167 +4410 keep parsimony-informative 0.4167 4411 keep parsimony-informative 0.5 4412 keep singleton 0.5 4413 keep parsimony-informative 0.5 -4414 trim other 0.9166666666666666 -4415 trim other 0.9166666666666666 -4416 trim other 0.9166666666666666 -4417 trim other 0.9166666666666666 -4418 trim other 0.9166666666666666 -4419 trim other 0.9166666666666666 -4420 trim other 0.9166666666666666 -4421 trim other 0.9166666666666666 -4422 trim other 0.9166666666666666 -4423 trim other 0.9166666666666666 -4424 trim other 0.9166666666666666 -4425 trim other 0.9166666666666666 -4426 keep constant 0.8333333333333334 -4427 keep other 0.8333333333333334 -4428 keep constant 0.8333333333333334 -4429 keep constant 0.8333333333333334 -4430 keep constant 0.8333333333333334 -4431 keep other 0.8333333333333334 +4414 trim other 0.9167 +4415 trim other 0.9167 +4416 trim other 0.9167 +4417 trim other 0.9167 +4418 trim other 0.9167 +4419 trim other 0.9167 +4420 trim other 0.9167 +4421 trim other 0.9167 +4422 trim other 0.9167 +4423 trim other 0.9167 +4424 trim other 0.9167 +4425 trim other 0.9167 +4426 keep constant 0.8333 +4427 keep other 0.8333 +4428 keep constant 0.8333 +4429 keep constant 0.8333 +4430 keep constant 0.8333 +4431 keep other 0.8333 4432 keep singleton 0.75 4433 keep singleton 0.75 4434 keep other 0.75 @@ -4441,21 +4441,21 @@ 4441 keep singleton 0.75 4442 keep other 0.75 4443 keep singleton 0.75 -4444 keep constant 0.5833333333333334 -4445 keep constant 0.5833333333333334 -4446 keep singleton 0.5833333333333334 -4447 keep singleton 0.5833333333333334 -4448 keep parsimony-informative 0.5833333333333334 -4449 keep parsimony-informative 0.5833333333333334 -4450 keep parsimony-informative 0.5833333333333334 -4451 keep singleton 0.5833333333333334 -4452 keep parsimony-informative 0.5833333333333334 -4453 keep parsimony-informative 0.6666666666666666 -4454 keep constant 0.6666666666666666 -4455 keep singleton 0.6666666666666666 -4456 trim other 0.9166666666666666 -4457 trim other 0.9166666666666666 -4458 trim other 0.9166666666666666 +4444 keep constant 0.5833 +4445 keep constant 0.5833 +4446 keep singleton 0.5833 +4447 keep singleton 0.5833 +4448 keep parsimony-informative 0.5833 +4449 keep parsimony-informative 0.5833 +4450 keep parsimony-informative 0.5833 +4451 keep singleton 0.5833 +4452 keep parsimony-informative 0.5833 +4453 keep parsimony-informative 0.6667 +4454 keep constant 0.6667 +4455 keep singleton 0.6667 +4456 trim other 0.9167 +4457 trim other 0.9167 +4458 trim other 0.9167 4459 keep parsimony-informative 0.25 4460 keep parsimony-informative 0.25 4461 keep parsimony-informative 0.25 @@ -4489,21 +4489,21 @@ 4489 keep parsimony-informative 0.25 4490 keep parsimony-informative 0.25 4491 keep parsimony-informative 0.25 -4492 keep parsimony-informative 0.08333333333333333 -4493 keep singleton 0.08333333333333333 -4494 keep parsimony-informative 0.08333333333333333 -4495 keep parsimony-informative 0.08333333333333333 -4496 keep parsimony-informative 0.08333333333333333 -4497 keep parsimony-informative 0.08333333333333333 -4498 keep parsimony-informative 0.08333333333333333 -4499 keep parsimony-informative 0.08333333333333333 -4500 keep parsimony-informative 0.08333333333333333 -4501 keep parsimony-informative 0.08333333333333333 -4502 keep parsimony-informative 0.08333333333333333 -4503 keep parsimony-informative 0.08333333333333333 -4504 keep parsimony-informative 0.08333333333333333 -4505 keep parsimony-informative 0.08333333333333333 -4506 keep parsimony-informative 0.08333333333333333 +4492 keep parsimony-informative 0.0833 +4493 keep singleton 0.0833 +4494 keep parsimony-informative 0.0833 +4495 keep parsimony-informative 0.0833 +4496 keep parsimony-informative 0.0833 +4497 keep parsimony-informative 0.0833 +4498 keep parsimony-informative 0.0833 +4499 keep parsimony-informative 0.0833 +4500 keep parsimony-informative 0.0833 +4501 keep parsimony-informative 0.0833 +4502 keep parsimony-informative 0.0833 +4503 keep parsimony-informative 0.0833 +4504 keep parsimony-informative 0.0833 +4505 keep parsimony-informative 0.0833 +4506 keep parsimony-informative 0.0833 4507 keep parsimony-informative 0.0 4508 keep parsimony-informative 0.0 4509 keep parsimony-informative 0.0 @@ -4543,180 +4543,180 @@ 4543 keep parsimony-informative 0.0 4544 keep parsimony-informative 0.0 4545 keep parsimony-informative 0.0 -4546 trim other 0.9166666666666666 -4547 trim other 0.9166666666666666 -4548 trim other 0.9166666666666666 -4549 keep other 0.8333333333333334 -4550 keep other 0.8333333333333334 -4551 keep other 0.8333333333333334 -4552 keep parsimony-informative 0.08333333333333333 -4553 keep parsimony-informative 0.08333333333333333 -4554 keep parsimony-informative 0.08333333333333333 -4555 keep parsimony-informative 0.08333333333333333 -4556 keep parsimony-informative 0.08333333333333333 -4557 keep parsimony-informative 0.08333333333333333 -4558 keep parsimony-informative 0.08333333333333333 -4559 keep parsimony-informative 0.08333333333333333 -4560 keep parsimony-informative 0.08333333333333333 -4561 keep parsimony-informative 0.08333333333333333 -4562 keep parsimony-informative 0.08333333333333333 -4563 keep parsimony-informative 0.08333333333333333 -4564 keep parsimony-informative 0.08333333333333333 -4565 keep parsimony-informative 0.08333333333333333 -4566 keep parsimony-informative 0.08333333333333333 -4567 keep parsimony-informative 0.08333333333333333 -4568 keep parsimony-informative 0.08333333333333333 -4569 keep parsimony-informative 0.08333333333333333 -4570 keep parsimony-informative 0.08333333333333333 -4571 keep singleton 0.08333333333333333 -4572 keep parsimony-informative 0.08333333333333333 -4573 keep parsimony-informative 0.08333333333333333 -4574 keep parsimony-informative 0.08333333333333333 -4575 keep parsimony-informative 0.08333333333333333 -4576 keep parsimony-informative 0.08333333333333333 -4577 keep parsimony-informative 0.08333333333333333 -4578 keep parsimony-informative 0.08333333333333333 -4579 keep parsimony-informative 0.08333333333333333 -4580 keep parsimony-informative 0.08333333333333333 -4581 keep parsimony-informative 0.08333333333333333 -4582 keep parsimony-informative 0.08333333333333333 -4583 keep parsimony-informative 0.08333333333333333 -4584 keep parsimony-informative 0.08333333333333333 -4585 keep parsimony-informative 0.08333333333333333 -4586 keep parsimony-informative 0.08333333333333333 -4587 keep parsimony-informative 0.08333333333333333 -4588 keep parsimony-informative 0.08333333333333333 -4589 keep parsimony-informative 0.08333333333333333 -4590 keep parsimony-informative 0.08333333333333333 -4591 keep parsimony-informative 0.08333333333333333 -4592 keep constant 0.08333333333333333 -4593 keep parsimony-informative 0.08333333333333333 -4594 keep parsimony-informative 0.08333333333333333 -4595 keep parsimony-informative 0.08333333333333333 -4596 keep parsimony-informative 0.08333333333333333 -4597 keep parsimony-informative 0.08333333333333333 -4598 keep singleton 0.08333333333333333 -4599 keep parsimony-informative 0.08333333333333333 -4600 keep parsimony-informative 0.08333333333333333 -4601 keep parsimony-informative 0.08333333333333333 -4602 keep parsimony-informative 0.08333333333333333 -4603 keep parsimony-informative 0.08333333333333333 -4604 keep parsimony-informative 0.08333333333333333 -4605 keep parsimony-informative 0.08333333333333333 -4606 keep parsimony-informative 0.08333333333333333 -4607 keep parsimony-informative 0.08333333333333333 -4608 keep parsimony-informative 0.08333333333333333 -4609 keep parsimony-informative 0.08333333333333333 -4610 keep parsimony-informative 0.08333333333333333 -4611 keep parsimony-informative 0.08333333333333333 -4612 keep parsimony-informative 0.08333333333333333 -4613 keep parsimony-informative 0.08333333333333333 -4614 keep parsimony-informative 0.08333333333333333 -4615 keep constant 0.8333333333333334 -4616 keep constant 0.8333333333333334 -4617 keep other 0.8333333333333334 -4618 keep other 0.8333333333333334 -4619 keep constant 0.8333333333333334 -4620 keep constant 0.8333333333333334 -4621 trim other 0.9166666666666666 -4622 trim other 0.9166666666666666 -4623 trim other 0.9166666666666666 -4624 keep parsimony-informative 0.08333333333333333 -4625 keep constant 0.08333333333333333 -4626 keep parsimony-informative 0.08333333333333333 -4627 keep parsimony-informative 0.08333333333333333 -4628 keep parsimony-informative 0.08333333333333333 -4629 keep parsimony-informative 0.08333333333333333 -4630 keep singleton 0.08333333333333333 -4631 keep singleton 0.08333333333333333 -4632 keep parsimony-informative 0.08333333333333333 -4633 keep parsimony-informative 0.08333333333333333 -4634 keep parsimony-informative 0.08333333333333333 -4635 keep parsimony-informative 0.08333333333333333 -4636 keep parsimony-informative 0.08333333333333333 -4637 keep parsimony-informative 0.08333333333333333 -4638 keep parsimony-informative 0.08333333333333333 -4639 keep parsimony-informative 0.08333333333333333 -4640 keep singleton 0.08333333333333333 -4641 keep parsimony-informative 0.08333333333333333 -4642 keep parsimony-informative 0.08333333333333333 -4643 keep parsimony-informative 0.08333333333333333 -4644 keep parsimony-informative 0.08333333333333333 -4645 keep parsimony-informative 0.08333333333333333 -4646 keep parsimony-informative 0.08333333333333333 -4647 keep parsimony-informative 0.08333333333333333 -4648 keep parsimony-informative 0.08333333333333333 -4649 keep constant 0.08333333333333333 -4650 keep parsimony-informative 0.08333333333333333 +4546 trim other 0.9167 +4547 trim other 0.9167 +4548 trim other 0.9167 +4549 keep other 0.8333 +4550 keep other 0.8333 +4551 keep other 0.8333 +4552 keep parsimony-informative 0.0833 +4553 keep parsimony-informative 0.0833 +4554 keep parsimony-informative 0.0833 +4555 keep parsimony-informative 0.0833 +4556 keep parsimony-informative 0.0833 +4557 keep parsimony-informative 0.0833 +4558 keep parsimony-informative 0.0833 +4559 keep parsimony-informative 0.0833 +4560 keep parsimony-informative 0.0833 +4561 keep parsimony-informative 0.0833 +4562 keep parsimony-informative 0.0833 +4563 keep parsimony-informative 0.0833 +4564 keep parsimony-informative 0.0833 +4565 keep parsimony-informative 0.0833 +4566 keep parsimony-informative 0.0833 +4567 keep parsimony-informative 0.0833 +4568 keep parsimony-informative 0.0833 +4569 keep parsimony-informative 0.0833 +4570 keep parsimony-informative 0.0833 +4571 keep singleton 0.0833 +4572 keep parsimony-informative 0.0833 +4573 keep parsimony-informative 0.0833 +4574 keep parsimony-informative 0.0833 +4575 keep parsimony-informative 0.0833 +4576 keep parsimony-informative 0.0833 +4577 keep parsimony-informative 0.0833 +4578 keep parsimony-informative 0.0833 +4579 keep parsimony-informative 0.0833 +4580 keep parsimony-informative 0.0833 +4581 keep parsimony-informative 0.0833 +4582 keep parsimony-informative 0.0833 +4583 keep parsimony-informative 0.0833 +4584 keep parsimony-informative 0.0833 +4585 keep parsimony-informative 0.0833 +4586 keep parsimony-informative 0.0833 +4587 keep parsimony-informative 0.0833 +4588 keep parsimony-informative 0.0833 +4589 keep parsimony-informative 0.0833 +4590 keep parsimony-informative 0.0833 +4591 keep parsimony-informative 0.0833 +4592 keep constant 0.0833 +4593 keep parsimony-informative 0.0833 +4594 keep parsimony-informative 0.0833 +4595 keep parsimony-informative 0.0833 +4596 keep parsimony-informative 0.0833 +4597 keep parsimony-informative 0.0833 +4598 keep singleton 0.0833 +4599 keep parsimony-informative 0.0833 +4600 keep parsimony-informative 0.0833 +4601 keep parsimony-informative 0.0833 +4602 keep parsimony-informative 0.0833 +4603 keep parsimony-informative 0.0833 +4604 keep parsimony-informative 0.0833 +4605 keep parsimony-informative 0.0833 +4606 keep parsimony-informative 0.0833 +4607 keep parsimony-informative 0.0833 +4608 keep parsimony-informative 0.0833 +4609 keep parsimony-informative 0.0833 +4610 keep parsimony-informative 0.0833 +4611 keep parsimony-informative 0.0833 +4612 keep parsimony-informative 0.0833 +4613 keep parsimony-informative 0.0833 +4614 keep parsimony-informative 0.0833 +4615 keep constant 0.8333 +4616 keep constant 0.8333 +4617 keep other 0.8333 +4618 keep other 0.8333 +4619 keep constant 0.8333 +4620 keep constant 0.8333 +4621 trim other 0.9167 +4622 trim other 0.9167 +4623 trim other 0.9167 +4624 keep parsimony-informative 0.0833 +4625 keep constant 0.0833 +4626 keep parsimony-informative 0.0833 +4627 keep parsimony-informative 0.0833 +4628 keep parsimony-informative 0.0833 +4629 keep parsimony-informative 0.0833 +4630 keep singleton 0.0833 +4631 keep singleton 0.0833 +4632 keep parsimony-informative 0.0833 +4633 keep parsimony-informative 0.0833 +4634 keep parsimony-informative 0.0833 +4635 keep parsimony-informative 0.0833 +4636 keep parsimony-informative 0.0833 +4637 keep parsimony-informative 0.0833 +4638 keep parsimony-informative 0.0833 +4639 keep parsimony-informative 0.0833 +4640 keep singleton 0.0833 +4641 keep parsimony-informative 0.0833 +4642 keep parsimony-informative 0.0833 +4643 keep parsimony-informative 0.0833 +4644 keep parsimony-informative 0.0833 +4645 keep parsimony-informative 0.0833 +4646 keep parsimony-informative 0.0833 +4647 keep parsimony-informative 0.0833 +4648 keep parsimony-informative 0.0833 +4649 keep constant 0.0833 +4650 keep parsimony-informative 0.0833 4651 keep singleton 0.5 4652 keep parsimony-informative 0.5 4653 keep singleton 0.5 -4654 keep parsimony-informative 0.4166666666666667 -4655 keep parsimony-informative 0.4166666666666667 -4656 keep parsimony-informative 0.4166666666666667 +4654 keep parsimony-informative 0.4167 +4655 keep parsimony-informative 0.4167 +4656 keep parsimony-informative 0.4167 4657 keep singleton 0.5 4658 keep parsimony-informative 0.5 4659 keep parsimony-informative 0.5 4660 keep parsimony-informative 0.5 4661 keep constant 0.5 4662 keep parsimony-informative 0.5 -4663 trim other 0.9166666666666666 -4664 trim other 0.9166666666666666 -4665 trim other 0.9166666666666666 -4666 trim other 0.9166666666666666 -4667 trim other 0.9166666666666666 -4668 trim other 0.9166666666666666 -4669 trim other 0.9166666666666666 -4670 trim other 0.9166666666666666 -4671 trim other 0.9166666666666666 -4672 trim other 0.9166666666666666 -4673 trim other 0.9166666666666666 -4674 trim other 0.9166666666666666 -4675 trim other 0.9166666666666666 -4676 trim other 0.9166666666666666 -4677 trim other 0.9166666666666666 -4678 keep parsimony-informative 0.4166666666666667 -4679 keep parsimony-informative 0.4166666666666667 -4680 keep parsimony-informative 0.4166666666666667 -4681 keep parsimony-informative 0.4166666666666667 -4682 keep singleton 0.4166666666666667 -4683 keep singleton 0.4166666666666667 -4684 keep parsimony-informative 0.4166666666666667 -4685 keep constant 0.4166666666666667 -4686 keep parsimony-informative 0.4166666666666667 -4687 keep other 0.8333333333333334 -4688 keep other 0.8333333333333334 -4689 keep other 0.8333333333333334 +4663 trim other 0.9167 +4664 trim other 0.9167 +4665 trim other 0.9167 +4666 trim other 0.9167 +4667 trim other 0.9167 +4668 trim other 0.9167 +4669 trim other 0.9167 +4670 trim other 0.9167 +4671 trim other 0.9167 +4672 trim other 0.9167 +4673 trim other 0.9167 +4674 trim other 0.9167 +4675 trim other 0.9167 +4676 trim other 0.9167 +4677 trim other 0.9167 +4678 keep parsimony-informative 0.4167 +4679 keep parsimony-informative 0.4167 +4680 keep parsimony-informative 0.4167 +4681 keep parsimony-informative 0.4167 +4682 keep singleton 0.4167 +4683 keep singleton 0.4167 +4684 keep parsimony-informative 0.4167 +4685 keep constant 0.4167 +4686 keep parsimony-informative 0.4167 +4687 keep other 0.8333 +4688 keep other 0.8333 +4689 keep other 0.8333 4690 keep singleton 0.5 4691 keep parsimony-informative 0.5 4692 keep singleton 0.5 4693 keep parsimony-informative 0.5 4694 keep singleton 0.5 4695 keep singleton 0.5 -4696 keep singleton 0.4166666666666667 -4697 keep parsimony-informative 0.4166666666666667 -4698 keep parsimony-informative 0.4166666666666667 -4699 keep singleton 0.4166666666666667 -4700 keep singleton 0.4166666666666667 -4701 keep constant 0.4166666666666667 -4702 keep parsimony-informative 0.4166666666666667 -4703 keep parsimony-informative 0.4166666666666667 -4704 keep parsimony-informative 0.4166666666666667 -4705 keep parsimony-informative 0.4166666666666667 -4706 keep singleton 0.4166666666666667 -4707 keep parsimony-informative 0.4166666666666667 -4708 keep parsimony-informative 0.4166666666666667 -4709 keep parsimony-informative 0.4166666666666667 -4710 keep parsimony-informative 0.4166666666666667 -4711 keep parsimony-informative 0.4166666666666667 -4712 keep singleton 0.4166666666666667 -4713 keep singleton 0.4166666666666667 -4714 keep parsimony-informative 0.4166666666666667 -4715 keep parsimony-informative 0.4166666666666667 -4716 keep parsimony-informative 0.4166666666666667 -4717 keep parsimony-informative 0.4166666666666667 -4718 keep parsimony-informative 0.4166666666666667 -4719 keep parsimony-informative 0.4166666666666667 +4696 keep singleton 0.4167 +4697 keep parsimony-informative 0.4167 +4698 keep parsimony-informative 0.4167 +4699 keep singleton 0.4167 +4700 keep singleton 0.4167 +4701 keep constant 0.4167 +4702 keep parsimony-informative 0.4167 +4703 keep parsimony-informative 0.4167 +4704 keep parsimony-informative 0.4167 +4705 keep parsimony-informative 0.4167 +4706 keep singleton 0.4167 +4707 keep parsimony-informative 0.4167 +4708 keep parsimony-informative 0.4167 +4709 keep parsimony-informative 0.4167 +4710 keep parsimony-informative 0.4167 +4711 keep parsimony-informative 0.4167 +4712 keep singleton 0.4167 +4713 keep singleton 0.4167 +4714 keep parsimony-informative 0.4167 +4715 keep parsimony-informative 0.4167 +4716 keep parsimony-informative 0.4167 +4717 keep parsimony-informative 0.4167 +4718 keep parsimony-informative 0.4167 +4719 keep parsimony-informative 0.4167 4720 keep constant 0.5 4721 keep singleton 0.5 4722 keep singleton 0.5 @@ -4747,84 +4747,84 @@ 4747 keep parsimony-informative 0.5 4748 keep parsimony-informative 0.5 4749 keep singleton 0.5 -4750 keep constant 0.8333333333333334 -4751 keep constant 0.8333333333333334 -4752 keep other 0.8333333333333334 -4753 keep other 0.8333333333333334 -4754 keep constant 0.8333333333333334 -4755 keep other 0.8333333333333334 -4756 keep other 0.8333333333333334 -4757 keep constant 0.8333333333333334 -4758 keep other 0.8333333333333334 -4759 keep constant 0.8333333333333334 -4760 keep constant 0.8333333333333334 -4761 keep constant 0.8333333333333334 -4762 keep other 0.8333333333333334 -4763 keep other 0.8333333333333334 -4764 keep other 0.8333333333333334 -4765 keep constant 0.8333333333333334 -4766 keep constant 0.8333333333333334 -4767 keep constant 0.8333333333333334 -4768 keep other 0.8333333333333334 -4769 keep other 0.8333333333333334 -4770 keep constant 0.8333333333333334 -4771 keep other 0.8333333333333334 -4772 keep other 0.8333333333333334 -4773 keep other 0.8333333333333334 -4774 keep other 0.8333333333333334 -4775 keep constant 0.8333333333333334 -4776 keep constant 0.8333333333333334 -4777 keep constant 0.8333333333333334 -4778 keep constant 0.8333333333333334 -4779 keep constant 0.8333333333333334 -4780 keep other 0.8333333333333334 -4781 keep other 0.8333333333333334 -4782 keep other 0.8333333333333334 -4783 keep constant 0.3333333333333333 -4784 keep singleton 0.3333333333333333 -4785 keep parsimony-informative 0.3333333333333333 -4786 trim other 0.9166666666666666 -4787 trim other 0.9166666666666666 -4788 trim other 0.9166666666666666 -4789 keep parsimony-informative 0.16666666666666666 -4790 keep parsimony-informative 0.16666666666666666 -4791 keep parsimony-informative 0.16666666666666666 -4792 keep parsimony-informative 0.16666666666666666 -4793 keep parsimony-informative 0.16666666666666666 -4794 keep parsimony-informative 0.16666666666666666 -4795 keep parsimony-informative 0.16666666666666666 -4796 keep parsimony-informative 0.16666666666666666 -4797 keep parsimony-informative 0.16666666666666666 +4750 keep constant 0.8333 +4751 keep constant 0.8333 +4752 keep other 0.8333 +4753 keep other 0.8333 +4754 keep constant 0.8333 +4755 keep other 0.8333 +4756 keep other 0.8333 +4757 keep constant 0.8333 +4758 keep other 0.8333 +4759 keep constant 0.8333 +4760 keep constant 0.8333 +4761 keep constant 0.8333 +4762 keep other 0.8333 +4763 keep other 0.8333 +4764 keep other 0.8333 +4765 keep constant 0.8333 +4766 keep constant 0.8333 +4767 keep constant 0.8333 +4768 keep other 0.8333 +4769 keep other 0.8333 +4770 keep constant 0.8333 +4771 keep other 0.8333 +4772 keep other 0.8333 +4773 keep other 0.8333 +4774 keep other 0.8333 +4775 keep constant 0.8333 +4776 keep constant 0.8333 +4777 keep constant 0.8333 +4778 keep constant 0.8333 +4779 keep constant 0.8333 +4780 keep other 0.8333 +4781 keep other 0.8333 +4782 keep other 0.8333 +4783 keep constant 0.3333 +4784 keep singleton 0.3333 +4785 keep parsimony-informative 0.3333 +4786 trim other 0.9167 +4787 trim other 0.9167 +4788 trim other 0.9167 +4789 keep parsimony-informative 0.1667 +4790 keep parsimony-informative 0.1667 +4791 keep parsimony-informative 0.1667 +4792 keep parsimony-informative 0.1667 +4793 keep parsimony-informative 0.1667 +4794 keep parsimony-informative 0.1667 +4795 keep parsimony-informative 0.1667 +4796 keep parsimony-informative 0.1667 +4797 keep parsimony-informative 0.1667 4798 keep parsimony-informative 0.0 4799 keep singleton 0.0 4800 keep parsimony-informative 0.0 -4801 keep parsimony-informative 0.08333333333333333 -4802 keep parsimony-informative 0.08333333333333333 -4803 keep parsimony-informative 0.08333333333333333 -4804 keep parsimony-informative 0.08333333333333333 -4805 keep parsimony-informative 0.08333333333333333 -4806 keep parsimony-informative 0.08333333333333333 -4807 keep parsimony-informative 0.08333333333333333 -4808 keep parsimony-informative 0.08333333333333333 -4809 keep parsimony-informative 0.08333333333333333 -4810 keep parsimony-informative 0.16666666666666666 -4811 keep parsimony-informative 0.16666666666666666 -4812 keep parsimony-informative 0.16666666666666666 -4813 keep parsimony-informative 0.08333333333333333 -4814 keep parsimony-informative 0.08333333333333333 -4815 keep parsimony-informative 0.08333333333333333 -4816 keep parsimony-informative 0.16666666666666666 -4817 keep parsimony-informative 0.16666666666666666 -4818 keep parsimony-informative 0.16666666666666666 -4819 keep parsimony-informative 0.16666666666666666 -4820 keep parsimony-informative 0.16666666666666666 -4821 keep parsimony-informative 0.16666666666666666 -4822 keep parsimony-informative 0.16666666666666666 -4823 keep parsimony-informative 0.16666666666666666 -4824 keep parsimony-informative 0.16666666666666666 -4825 keep parsimony-informative 0.16666666666666666 -4826 keep parsimony-informative 0.16666666666666666 -4827 keep parsimony-informative 0.16666666666666666 +4801 keep parsimony-informative 0.0833 +4802 keep parsimony-informative 0.0833 +4803 keep parsimony-informative 0.0833 +4804 keep parsimony-informative 0.0833 +4805 keep parsimony-informative 0.0833 +4806 keep parsimony-informative 0.0833 +4807 keep parsimony-informative 0.0833 +4808 keep parsimony-informative 0.0833 +4809 keep parsimony-informative 0.0833 +4810 keep parsimony-informative 0.1667 +4811 keep parsimony-informative 0.1667 +4812 keep parsimony-informative 0.1667 +4813 keep parsimony-informative 0.0833 +4814 keep parsimony-informative 0.0833 +4815 keep parsimony-informative 0.0833 +4816 keep parsimony-informative 0.1667 +4817 keep parsimony-informative 0.1667 +4818 keep parsimony-informative 0.1667 +4819 keep parsimony-informative 0.1667 +4820 keep parsimony-informative 0.1667 +4821 keep parsimony-informative 0.1667 +4822 keep parsimony-informative 0.1667 +4823 keep parsimony-informative 0.1667 +4824 keep parsimony-informative 0.1667 +4825 keep parsimony-informative 0.1667 +4826 keep parsimony-informative 0.1667 +4827 keep parsimony-informative 0.1667 4828 keep parsimony-informative 0.25 4829 keep parsimony-informative 0.25 4830 keep singleton 0.25 @@ -4846,129 +4846,129 @@ 4846 keep parsimony-informative 0.25 4847 keep parsimony-informative 0.25 4848 keep parsimony-informative 0.25 -4849 keep singleton 0.3333333333333333 -4850 keep parsimony-informative 0.3333333333333333 -4851 keep parsimony-informative 0.3333333333333333 -4852 keep singleton 0.3333333333333333 -4853 keep parsimony-informative 0.3333333333333333 -4854 keep parsimony-informative 0.3333333333333333 -4855 keep parsimony-informative 0.3333333333333333 -4856 keep parsimony-informative 0.3333333333333333 -4857 keep parsimony-informative 0.3333333333333333 -4858 keep parsimony-informative 0.3333333333333333 -4859 keep constant 0.3333333333333333 -4860 keep parsimony-informative 0.3333333333333333 -4861 keep parsimony-informative 0.3333333333333333 -4862 keep parsimony-informative 0.3333333333333333 -4863 keep parsimony-informative 0.3333333333333333 -4864 keep parsimony-informative 0.3333333333333333 -4865 keep parsimony-informative 0.3333333333333333 -4866 keep parsimony-informative 0.3333333333333333 -4867 keep parsimony-informative 0.3333333333333333 -4868 keep parsimony-informative 0.3333333333333333 -4869 keep parsimony-informative 0.3333333333333333 -4870 keep parsimony-informative 0.4166666666666667 -4871 keep singleton 0.4166666666666667 -4872 keep parsimony-informative 0.4166666666666667 -4873 keep parsimony-informative 0.4166666666666667 -4874 keep parsimony-informative 0.4166666666666667 -4875 keep parsimony-informative 0.4166666666666667 -4876 keep parsimony-informative 0.4166666666666667 -4877 keep singleton 0.4166666666666667 -4878 keep parsimony-informative 0.4166666666666667 -4879 keep parsimony-informative 0.4166666666666667 -4880 keep parsimony-informative 0.4166666666666667 -4881 keep parsimony-informative 0.4166666666666667 -4882 keep parsimony-informative 0.4166666666666667 -4883 keep parsimony-informative 0.4166666666666667 -4884 keep parsimony-informative 0.4166666666666667 -4885 keep parsimony-informative 0.4166666666666667 -4886 keep constant 0.4166666666666667 -4887 keep singleton 0.4166666666666667 -4888 keep parsimony-informative 0.4166666666666667 -4889 keep parsimony-informative 0.4166666666666667 -4890 keep parsimony-informative 0.4166666666666667 -4891 keep parsimony-informative 0.4166666666666667 -4892 keep parsimony-informative 0.4166666666666667 -4893 keep parsimony-informative 0.4166666666666667 -4894 keep singleton 0.4166666666666667 -4895 keep parsimony-informative 0.4166666666666667 -4896 keep parsimony-informative 0.4166666666666667 -4897 keep other 0.8333333333333334 -4898 keep other 0.8333333333333334 -4899 keep other 0.8333333333333334 -4900 trim other 0.9166666666666666 -4901 trim other 0.9166666666666666 -4902 trim other 0.9166666666666666 -4903 trim other 0.9166666666666666 -4904 trim other 0.9166666666666666 -4905 trim other 0.9166666666666666 -4906 trim other 0.9166666666666666 -4907 trim other 0.9166666666666666 -4908 trim other 0.9166666666666666 -4909 trim other 0.9166666666666666 -4910 trim other 0.9166666666666666 -4911 trim other 0.9166666666666666 -4912 trim other 0.9166666666666666 -4913 trim other 0.9166666666666666 -4914 trim other 0.9166666666666666 -4915 trim other 0.9166666666666666 -4916 trim other 0.9166666666666666 -4917 trim other 0.9166666666666666 -4918 trim other 0.9166666666666666 -4919 trim other 0.9166666666666666 -4920 trim other 0.9166666666666666 -4921 trim other 0.9166666666666666 -4922 trim other 0.9166666666666666 -4923 trim other 0.9166666666666666 -4924 trim other 0.9166666666666666 -4925 trim other 0.9166666666666666 -4926 trim other 0.9166666666666666 -4927 trim other 0.9166666666666666 -4928 trim other 0.9166666666666666 -4929 trim other 0.9166666666666666 -4930 trim other 0.9166666666666666 -4931 trim other 0.9166666666666666 -4932 trim other 0.9166666666666666 -4933 trim other 0.9166666666666666 -4934 trim other 0.9166666666666666 -4935 trim other 0.9166666666666666 -4936 keep other 0.8333333333333334 -4937 keep other 0.8333333333333334 -4938 keep other 0.8333333333333334 -4939 keep constant 0.8333333333333334 -4940 keep other 0.8333333333333334 -4941 keep other 0.8333333333333334 -4942 keep other 0.8333333333333334 -4943 keep constant 0.8333333333333334 -4944 keep constant 0.8333333333333334 -4945 keep constant 0.8333333333333334 -4946 keep constant 0.8333333333333334 -4947 keep other 0.8333333333333334 -4948 keep other 0.8333333333333334 -4949 keep other 0.8333333333333334 -4950 keep other 0.8333333333333334 -4951 keep other 0.8333333333333334 -4952 keep other 0.8333333333333334 -4953 keep other 0.8333333333333334 -4954 keep other 0.8333333333333334 -4955 keep other 0.8333333333333334 -4956 keep other 0.8333333333333334 -4957 keep other 0.8333333333333334 -4958 keep constant 0.8333333333333334 -4959 keep constant 0.8333333333333334 -4960 keep constant 0.8333333333333334 -4961 keep other 0.8333333333333334 -4962 keep constant 0.8333333333333334 -4963 keep other 0.8333333333333334 -4964 keep other 0.8333333333333334 -4965 keep other 0.8333333333333334 -4966 keep constant 0.8333333333333334 -4967 keep constant 0.8333333333333334 -4968 keep other 0.8333333333333334 -4969 keep other 0.8333333333333334 -4970 keep other 0.8333333333333334 -4971 keep constant 0.8333333333333334 +4849 keep singleton 0.3333 +4850 keep parsimony-informative 0.3333 +4851 keep parsimony-informative 0.3333 +4852 keep singleton 0.3333 +4853 keep parsimony-informative 0.3333 +4854 keep parsimony-informative 0.3333 +4855 keep parsimony-informative 0.3333 +4856 keep parsimony-informative 0.3333 +4857 keep parsimony-informative 0.3333 +4858 keep parsimony-informative 0.3333 +4859 keep constant 0.3333 +4860 keep parsimony-informative 0.3333 +4861 keep parsimony-informative 0.3333 +4862 keep parsimony-informative 0.3333 +4863 keep parsimony-informative 0.3333 +4864 keep parsimony-informative 0.3333 +4865 keep parsimony-informative 0.3333 +4866 keep parsimony-informative 0.3333 +4867 keep parsimony-informative 0.3333 +4868 keep parsimony-informative 0.3333 +4869 keep parsimony-informative 0.3333 +4870 keep parsimony-informative 0.4167 +4871 keep singleton 0.4167 +4872 keep parsimony-informative 0.4167 +4873 keep parsimony-informative 0.4167 +4874 keep parsimony-informative 0.4167 +4875 keep parsimony-informative 0.4167 +4876 keep parsimony-informative 0.4167 +4877 keep singleton 0.4167 +4878 keep parsimony-informative 0.4167 +4879 keep parsimony-informative 0.4167 +4880 keep parsimony-informative 0.4167 +4881 keep parsimony-informative 0.4167 +4882 keep parsimony-informative 0.4167 +4883 keep parsimony-informative 0.4167 +4884 keep parsimony-informative 0.4167 +4885 keep parsimony-informative 0.4167 +4886 keep constant 0.4167 +4887 keep singleton 0.4167 +4888 keep parsimony-informative 0.4167 +4889 keep parsimony-informative 0.4167 +4890 keep parsimony-informative 0.4167 +4891 keep parsimony-informative 0.4167 +4892 keep parsimony-informative 0.4167 +4893 keep parsimony-informative 0.4167 +4894 keep singleton 0.4167 +4895 keep parsimony-informative 0.4167 +4896 keep parsimony-informative 0.4167 +4897 keep other 0.8333 +4898 keep other 0.8333 +4899 keep other 0.8333 +4900 trim other 0.9167 +4901 trim other 0.9167 +4902 trim other 0.9167 +4903 trim other 0.9167 +4904 trim other 0.9167 +4905 trim other 0.9167 +4906 trim other 0.9167 +4907 trim other 0.9167 +4908 trim other 0.9167 +4909 trim other 0.9167 +4910 trim other 0.9167 +4911 trim other 0.9167 +4912 trim other 0.9167 +4913 trim other 0.9167 +4914 trim other 0.9167 +4915 trim other 0.9167 +4916 trim other 0.9167 +4917 trim other 0.9167 +4918 trim other 0.9167 +4919 trim other 0.9167 +4920 trim other 0.9167 +4921 trim other 0.9167 +4922 trim other 0.9167 +4923 trim other 0.9167 +4924 trim other 0.9167 +4925 trim other 0.9167 +4926 trim other 0.9167 +4927 trim other 0.9167 +4928 trim other 0.9167 +4929 trim other 0.9167 +4930 trim other 0.9167 +4931 trim other 0.9167 +4932 trim other 0.9167 +4933 trim other 0.9167 +4934 trim other 0.9167 +4935 trim other 0.9167 +4936 keep other 0.8333 +4937 keep other 0.8333 +4938 keep other 0.8333 +4939 keep constant 0.8333 +4940 keep other 0.8333 +4941 keep other 0.8333 +4942 keep other 0.8333 +4943 keep constant 0.8333 +4944 keep constant 0.8333 +4945 keep constant 0.8333 +4946 keep constant 0.8333 +4947 keep other 0.8333 +4948 keep other 0.8333 +4949 keep other 0.8333 +4950 keep other 0.8333 +4951 keep other 0.8333 +4952 keep other 0.8333 +4953 keep other 0.8333 +4954 keep other 0.8333 +4955 keep other 0.8333 +4956 keep other 0.8333 +4957 keep other 0.8333 +4958 keep constant 0.8333 +4959 keep constant 0.8333 +4960 keep constant 0.8333 +4961 keep other 0.8333 +4962 keep constant 0.8333 +4963 keep other 0.8333 +4964 keep other 0.8333 +4965 keep other 0.8333 +4966 keep constant 0.8333 +4967 keep constant 0.8333 +4968 keep other 0.8333 +4969 keep other 0.8333 +4970 keep other 0.8333 +4971 keep constant 0.8333 4972 keep singleton 0.0 4973 keep parsimony-informative 0.0 4974 keep parsimony-informative 0.0 @@ -4981,48 +4981,48 @@ 4981 keep singleton 0.0 4982 keep constant 0.0 4983 keep parsimony-informative 0.0 -4984 keep constant 0.8333333333333334 -4985 keep other 0.8333333333333334 -4986 keep other 0.8333333333333334 -4987 keep other 0.6666666666666666 -4988 keep singleton 0.6666666666666666 -4989 keep parsimony-informative 0.6666666666666666 -4990 keep singleton 0.5833333333333334 -4991 keep singleton 0.5833333333333334 -4992 keep singleton 0.5833333333333334 -4993 keep singleton 0.5833333333333334 -4994 keep parsimony-informative 0.5833333333333334 -4995 keep singleton 0.5833333333333334 -4996 keep parsimony-informative 0.5833333333333334 -4997 keep parsimony-informative 0.5833333333333334 -4998 keep singleton 0.5833333333333334 -4999 keep parsimony-informative 0.5833333333333334 -5000 keep singleton 0.5833333333333334 -5001 keep singleton 0.5833333333333334 -5002 keep parsimony-informative 0.5833333333333334 -5003 keep constant 0.5833333333333334 -5004 keep parsimony-informative 0.5833333333333334 -5005 keep constant 0.5833333333333334 -5006 keep constant 0.5833333333333334 -5007 keep parsimony-informative 0.5833333333333334 -5008 keep singleton 0.5833333333333334 -5009 keep singleton 0.5833333333333334 -5010 keep singleton 0.5833333333333334 -5011 trim other 0.9166666666666666 -5012 trim other 0.9166666666666666 -5013 trim other 0.9166666666666666 -5014 keep other 0.8333333333333334 -5015 keep other 0.8333333333333334 -5016 keep constant 0.8333333333333334 -5017 trim other 0.9166666666666666 -5018 trim other 0.9166666666666666 -5019 trim other 0.9166666666666666 -5020 keep other 0.8333333333333334 -5021 keep other 0.8333333333333334 -5022 keep constant 0.8333333333333334 -5023 keep constant 0.8333333333333334 -5024 keep constant 0.8333333333333334 -5025 keep constant 0.8333333333333334 +4984 keep constant 0.8333 +4985 keep other 0.8333 +4986 keep other 0.8333 +4987 keep other 0.6667 +4988 keep singleton 0.6667 +4989 keep parsimony-informative 0.6667 +4990 keep singleton 0.5833 +4991 keep singleton 0.5833 +4992 keep singleton 0.5833 +4993 keep singleton 0.5833 +4994 keep parsimony-informative 0.5833 +4995 keep singleton 0.5833 +4996 keep parsimony-informative 0.5833 +4997 keep parsimony-informative 0.5833 +4998 keep singleton 0.5833 +4999 keep parsimony-informative 0.5833 +5000 keep singleton 0.5833 +5001 keep singleton 0.5833 +5002 keep parsimony-informative 0.5833 +5003 keep constant 0.5833 +5004 keep parsimony-informative 0.5833 +5005 keep constant 0.5833 +5006 keep constant 0.5833 +5007 keep parsimony-informative 0.5833 +5008 keep singleton 0.5833 +5009 keep singleton 0.5833 +5010 keep singleton 0.5833 +5011 trim other 0.9167 +5012 trim other 0.9167 +5013 trim other 0.9167 +5014 keep other 0.8333 +5015 keep other 0.8333 +5016 keep constant 0.8333 +5017 trim other 0.9167 +5018 trim other 0.9167 +5019 trim other 0.9167 +5020 keep other 0.8333 +5021 keep other 0.8333 +5022 keep constant 0.8333 +5023 keep constant 0.8333 +5024 keep constant 0.8333 +5025 keep constant 0.8333 5026 keep parsimony-informative 0.25 5027 keep parsimony-informative 0.25 5028 keep parsimony-informative 0.25 @@ -5035,111 +5035,111 @@ 5035 keep parsimony-informative 0.25 5036 keep parsimony-informative 0.25 5037 keep parsimony-informative 0.25 -5038 keep singleton 0.16666666666666666 -5039 keep parsimony-informative 0.16666666666666666 -5040 keep parsimony-informative 0.16666666666666666 -5041 keep singleton 0.16666666666666666 -5042 keep parsimony-informative 0.16666666666666666 -5043 keep parsimony-informative 0.16666666666666666 -5044 keep parsimony-informative 0.16666666666666666 -5045 keep parsimony-informative 0.16666666666666666 -5046 keep parsimony-informative 0.16666666666666666 -5047 keep parsimony-informative 0.08333333333333333 -5048 keep parsimony-informative 0.08333333333333333 -5049 keep singleton 0.08333333333333333 -5050 keep parsimony-informative 0.08333333333333333 -5051 keep parsimony-informative 0.08333333333333333 -5052 keep parsimony-informative 0.08333333333333333 -5053 keep parsimony-informative 0.16666666666666666 -5054 keep singleton 0.16666666666666666 -5055 keep parsimony-informative 0.16666666666666666 -5056 keep singleton 0.16666666666666666 -5057 keep constant 0.16666666666666666 -5058 keep parsimony-informative 0.16666666666666666 -5059 keep parsimony-informative 0.16666666666666666 -5060 keep parsimony-informative 0.16666666666666666 -5061 keep parsimony-informative 0.16666666666666666 -5062 keep parsimony-informative 0.16666666666666666 -5063 keep parsimony-informative 0.16666666666666666 -5064 keep parsimony-informative 0.16666666666666666 -5065 keep parsimony-informative 0.16666666666666666 -5066 keep parsimony-informative 0.16666666666666666 -5067 keep parsimony-informative 0.16666666666666666 -5068 keep other 0.6666666666666666 -5069 keep singleton 0.6666666666666666 -5070 keep singleton 0.6666666666666666 -5071 keep singleton 0.6666666666666666 -5072 keep singleton 0.6666666666666666 -5073 keep singleton 0.6666666666666666 -5074 keep singleton 0.6666666666666666 -5075 keep singleton 0.6666666666666666 -5076 keep singleton 0.6666666666666666 -5077 keep singleton 0.6666666666666666 -5078 keep constant 0.6666666666666666 -5079 keep singleton 0.6666666666666666 -5080 keep singleton 0.6666666666666666 -5081 keep singleton 0.6666666666666666 -5082 keep parsimony-informative 0.6666666666666666 -5083 keep parsimony-informative 0.6666666666666666 -5084 keep parsimony-informative 0.6666666666666666 -5085 keep singleton 0.6666666666666666 -5086 keep parsimony-informative 0.08333333333333333 -5087 keep parsimony-informative 0.08333333333333333 -5088 keep parsimony-informative 0.08333333333333333 -5089 keep parsimony-informative 0.16666666666666666 -5090 keep parsimony-informative 0.16666666666666666 -5091 keep parsimony-informative 0.16666666666666666 -5092 keep parsimony-informative 0.16666666666666666 -5093 keep parsimony-informative 0.16666666666666666 -5094 keep parsimony-informative 0.16666666666666666 -5095 keep singleton 0.16666666666666666 -5096 keep parsimony-informative 0.16666666666666666 -5097 keep parsimony-informative 0.16666666666666666 -5098 keep singleton 0.16666666666666666 -5099 keep singleton 0.16666666666666666 -5100 keep parsimony-informative 0.16666666666666666 +5038 keep singleton 0.1667 +5039 keep parsimony-informative 0.1667 +5040 keep parsimony-informative 0.1667 +5041 keep singleton 0.1667 +5042 keep parsimony-informative 0.1667 +5043 keep parsimony-informative 0.1667 +5044 keep parsimony-informative 0.1667 +5045 keep parsimony-informative 0.1667 +5046 keep parsimony-informative 0.1667 +5047 keep parsimony-informative 0.0833 +5048 keep parsimony-informative 0.0833 +5049 keep singleton 0.0833 +5050 keep parsimony-informative 0.0833 +5051 keep parsimony-informative 0.0833 +5052 keep parsimony-informative 0.0833 +5053 keep parsimony-informative 0.1667 +5054 keep singleton 0.1667 +5055 keep parsimony-informative 0.1667 +5056 keep singleton 0.1667 +5057 keep constant 0.1667 +5058 keep parsimony-informative 0.1667 +5059 keep parsimony-informative 0.1667 +5060 keep parsimony-informative 0.1667 +5061 keep parsimony-informative 0.1667 +5062 keep parsimony-informative 0.1667 +5063 keep parsimony-informative 0.1667 +5064 keep parsimony-informative 0.1667 +5065 keep parsimony-informative 0.1667 +5066 keep parsimony-informative 0.1667 +5067 keep parsimony-informative 0.1667 +5068 keep other 0.6667 +5069 keep singleton 0.6667 +5070 keep singleton 0.6667 +5071 keep singleton 0.6667 +5072 keep singleton 0.6667 +5073 keep singleton 0.6667 +5074 keep singleton 0.6667 +5075 keep singleton 0.6667 +5076 keep singleton 0.6667 +5077 keep singleton 0.6667 +5078 keep constant 0.6667 +5079 keep singleton 0.6667 +5080 keep singleton 0.6667 +5081 keep singleton 0.6667 +5082 keep parsimony-informative 0.6667 +5083 keep parsimony-informative 0.6667 +5084 keep parsimony-informative 0.6667 +5085 keep singleton 0.6667 +5086 keep parsimony-informative 0.0833 +5087 keep parsimony-informative 0.0833 +5088 keep parsimony-informative 0.0833 +5089 keep parsimony-informative 0.1667 +5090 keep parsimony-informative 0.1667 +5091 keep parsimony-informative 0.1667 +5092 keep parsimony-informative 0.1667 +5093 keep parsimony-informative 0.1667 +5094 keep parsimony-informative 0.1667 +5095 keep singleton 0.1667 +5096 keep parsimony-informative 0.1667 +5097 keep parsimony-informative 0.1667 +5098 keep singleton 0.1667 +5099 keep singleton 0.1667 +5100 keep parsimony-informative 0.1667 5101 keep parsimony-informative 0.0 5102 keep parsimony-informative 0.0 5103 keep parsimony-informative 0.0 5104 keep parsimony-informative 0.0 5105 keep constant 0.0 5106 keep parsimony-informative 0.0 -5107 keep parsimony-informative 0.16666666666666666 -5108 keep singleton 0.16666666666666666 -5109 keep parsimony-informative 0.16666666666666666 -5110 keep parsimony-informative 0.08333333333333333 -5111 keep parsimony-informative 0.08333333333333333 -5112 keep parsimony-informative 0.08333333333333333 -5113 keep parsimony-informative 0.08333333333333333 -5114 keep parsimony-informative 0.08333333333333333 -5115 keep parsimony-informative 0.08333333333333333 -5116 keep parsimony-informative 0.08333333333333333 -5117 keep parsimony-informative 0.08333333333333333 -5118 keep parsimony-informative 0.08333333333333333 -5119 keep singleton 0.08333333333333333 -5120 keep singleton 0.08333333333333333 -5121 keep parsimony-informative 0.08333333333333333 -5122 keep parsimony-informative 0.08333333333333333 -5123 keep parsimony-informative 0.08333333333333333 -5124 keep parsimony-informative 0.08333333333333333 -5125 keep parsimony-informative 0.08333333333333333 -5126 keep parsimony-informative 0.08333333333333333 -5127 keep parsimony-informative 0.08333333333333333 -5128 keep singleton 0.08333333333333333 -5129 keep singleton 0.08333333333333333 -5130 keep parsimony-informative 0.08333333333333333 -5131 keep parsimony-informative 0.08333333333333333 -5132 keep parsimony-informative 0.08333333333333333 -5133 keep parsimony-informative 0.08333333333333333 -5134 keep parsimony-informative 0.16666666666666666 -5135 keep singleton 0.16666666666666666 -5136 keep parsimony-informative 0.16666666666666666 -5137 keep parsimony-informative 0.16666666666666666 -5138 keep parsimony-informative 0.16666666666666666 -5139 keep parsimony-informative 0.16666666666666666 -5140 keep parsimony-informative 0.08333333333333333 -5141 keep singleton 0.08333333333333333 -5142 keep parsimony-informative 0.08333333333333333 +5107 keep parsimony-informative 0.1667 +5108 keep singleton 0.1667 +5109 keep parsimony-informative 0.1667 +5110 keep parsimony-informative 0.0833 +5111 keep parsimony-informative 0.0833 +5112 keep parsimony-informative 0.0833 +5113 keep parsimony-informative 0.0833 +5114 keep parsimony-informative 0.0833 +5115 keep parsimony-informative 0.0833 +5116 keep parsimony-informative 0.0833 +5117 keep parsimony-informative 0.0833 +5118 keep parsimony-informative 0.0833 +5119 keep singleton 0.0833 +5120 keep singleton 0.0833 +5121 keep parsimony-informative 0.0833 +5122 keep parsimony-informative 0.0833 +5123 keep parsimony-informative 0.0833 +5124 keep parsimony-informative 0.0833 +5125 keep parsimony-informative 0.0833 +5126 keep parsimony-informative 0.0833 +5127 keep parsimony-informative 0.0833 +5128 keep singleton 0.0833 +5129 keep singleton 0.0833 +5130 keep parsimony-informative 0.0833 +5131 keep parsimony-informative 0.0833 +5132 keep parsimony-informative 0.0833 +5133 keep parsimony-informative 0.0833 +5134 keep parsimony-informative 0.1667 +5135 keep singleton 0.1667 +5136 keep parsimony-informative 0.1667 +5137 keep parsimony-informative 0.1667 +5138 keep parsimony-informative 0.1667 +5139 keep parsimony-informative 0.1667 +5140 keep parsimony-informative 0.0833 +5141 keep singleton 0.0833 +5142 keep parsimony-informative 0.0833 5143 keep parsimony-informative 0.0 5144 keep parsimony-informative 0.0 5145 keep parsimony-informative 0.0 @@ -5158,36 +5158,36 @@ 5158 keep parsimony-informative 0.0 5159 keep singleton 0.0 5160 keep parsimony-informative 0.0 -5161 keep singleton 0.4166666666666667 -5162 keep parsimony-informative 0.4166666666666667 -5163 keep parsimony-informative 0.4166666666666667 -5164 keep parsimony-informative 0.4166666666666667 -5165 keep parsimony-informative 0.4166666666666667 -5166 keep parsimony-informative 0.4166666666666667 -5167 keep parsimony-informative 0.4166666666666667 -5168 keep parsimony-informative 0.4166666666666667 -5169 keep parsimony-informative 0.4166666666666667 -5170 keep parsimony-informative 0.4166666666666667 -5171 keep parsimony-informative 0.4166666666666667 -5172 keep parsimony-informative 0.4166666666666667 -5173 keep singleton 0.4166666666666667 -5174 keep singleton 0.4166666666666667 -5175 keep singleton 0.4166666666666667 -5176 keep singleton 0.5833333333333334 -5177 keep parsimony-informative 0.5833333333333334 -5178 keep parsimony-informative 0.5833333333333334 -5179 keep singleton 0.5833333333333334 -5180 keep singleton 0.5833333333333334 -5181 keep parsimony-informative 0.5833333333333334 +5161 keep singleton 0.4167 +5162 keep parsimony-informative 0.4167 +5163 keep parsimony-informative 0.4167 +5164 keep parsimony-informative 0.4167 +5165 keep parsimony-informative 0.4167 +5166 keep parsimony-informative 0.4167 +5167 keep parsimony-informative 0.4167 +5168 keep parsimony-informative 0.4167 +5169 keep parsimony-informative 0.4167 +5170 keep parsimony-informative 0.4167 +5171 keep parsimony-informative 0.4167 +5172 keep parsimony-informative 0.4167 +5173 keep singleton 0.4167 +5174 keep singleton 0.4167 +5175 keep singleton 0.4167 +5176 keep singleton 0.5833 +5177 keep parsimony-informative 0.5833 +5178 keep parsimony-informative 0.5833 +5179 keep singleton 0.5833 +5180 keep singleton 0.5833 +5181 keep parsimony-informative 0.5833 5182 keep singleton 0.5 5183 keep parsimony-informative 0.5 5184 keep singleton 0.5 5185 keep parsimony-informative 0.5 5186 keep parsimony-informative 0.5 5187 keep singleton 0.5 -5188 keep parsimony-informative 0.3333333333333333 -5189 keep parsimony-informative 0.3333333333333333 -5190 keep singleton 0.3333333333333333 +5188 keep parsimony-informative 0.3333 +5189 keep parsimony-informative 0.3333 +5190 keep singleton 0.3333 5191 keep singleton 0.0 5192 keep singleton 0.0 5193 keep parsimony-informative 0.0 @@ -5209,33 +5209,33 @@ 5209 keep singleton 0.0 5210 keep parsimony-informative 0.0 5211 keep parsimony-informative 0.0 -5212 keep parsimony-informative 0.08333333333333333 -5213 keep parsimony-informative 0.08333333333333333 -5214 keep parsimony-informative 0.08333333333333333 -5215 keep parsimony-informative 0.08333333333333333 -5216 keep singleton 0.08333333333333333 -5217 keep parsimony-informative 0.08333333333333333 -5218 keep parsimony-informative 0.08333333333333333 -5219 keep parsimony-informative 0.08333333333333333 -5220 keep parsimony-informative 0.08333333333333333 -5221 keep parsimony-informative 0.08333333333333333 -5222 keep parsimony-informative 0.08333333333333333 -5223 keep parsimony-informative 0.08333333333333333 -5224 keep parsimony-informative 0.08333333333333333 -5225 keep parsimony-informative 0.08333333333333333 -5226 keep parsimony-informative 0.08333333333333333 -5227 keep parsimony-informative 0.16666666666666666 -5228 keep parsimony-informative 0.16666666666666666 -5229 keep parsimony-informative 0.16666666666666666 -5230 keep parsimony-informative 0.16666666666666666 -5231 keep parsimony-informative 0.16666666666666666 -5232 keep parsimony-informative 0.16666666666666666 -5233 keep singleton 0.16666666666666666 -5234 keep parsimony-informative 0.16666666666666666 -5235 keep parsimony-informative 0.16666666666666666 -5236 keep parsimony-informative 0.16666666666666666 -5237 keep singleton 0.16666666666666666 -5238 keep parsimony-informative 0.16666666666666666 +5212 keep parsimony-informative 0.0833 +5213 keep parsimony-informative 0.0833 +5214 keep parsimony-informative 0.0833 +5215 keep parsimony-informative 0.0833 +5216 keep singleton 0.0833 +5217 keep parsimony-informative 0.0833 +5218 keep parsimony-informative 0.0833 +5219 keep parsimony-informative 0.0833 +5220 keep parsimony-informative 0.0833 +5221 keep parsimony-informative 0.0833 +5222 keep parsimony-informative 0.0833 +5223 keep parsimony-informative 0.0833 +5224 keep parsimony-informative 0.0833 +5225 keep parsimony-informative 0.0833 +5226 keep parsimony-informative 0.0833 +5227 keep parsimony-informative 0.1667 +5228 keep parsimony-informative 0.1667 +5229 keep parsimony-informative 0.1667 +5230 keep parsimony-informative 0.1667 +5231 keep parsimony-informative 0.1667 +5232 keep parsimony-informative 0.1667 +5233 keep singleton 0.1667 +5234 keep parsimony-informative 0.1667 +5235 keep parsimony-informative 0.1667 +5236 keep parsimony-informative 0.1667 +5237 keep singleton 0.1667 +5238 keep parsimony-informative 0.1667 5239 keep constant 0.75 5240 keep singleton 0.75 5241 keep other 0.75 @@ -5248,21 +5248,21 @@ 5248 keep other 0.75 5249 keep singleton 0.75 5250 keep other 0.75 -5251 keep other 0.8333333333333334 -5252 keep constant 0.8333333333333334 -5253 keep other 0.8333333333333334 -5254 keep constant 0.8333333333333334 -5255 keep constant 0.8333333333333334 -5256 keep constant 0.8333333333333334 -5257 trim other 0.9166666666666666 -5258 trim other 0.9166666666666666 -5259 trim other 0.9166666666666666 -5260 trim other 0.9166666666666666 -5261 trim other 0.9166666666666666 -5262 trim other 0.9166666666666666 -5263 keep other 0.8333333333333334 -5264 keep other 0.8333333333333334 -5265 keep constant 0.8333333333333334 +5251 keep other 0.8333 +5252 keep constant 0.8333 +5253 keep other 0.8333 +5254 keep constant 0.8333 +5255 keep constant 0.8333 +5256 keep constant 0.8333 +5257 trim other 0.9167 +5258 trim other 0.9167 +5259 trim other 0.9167 +5260 trim other 0.9167 +5261 trim other 0.9167 +5262 trim other 0.9167 +5263 keep other 0.8333 +5264 keep other 0.8333 +5265 keep constant 0.8333 5266 keep singleton 0.75 5267 keep singleton 0.75 5268 keep other 0.75 @@ -5293,12 +5293,12 @@ 5293 keep parsimony-informative 0.0 5294 keep singleton 0.0 5295 keep parsimony-informative 0.0 -5296 keep singleton 0.5833333333333334 -5297 keep singleton 0.5833333333333334 -5298 keep parsimony-informative 0.5833333333333334 -5299 keep parsimony-informative 0.3333333333333333 -5300 keep parsimony-informative 0.3333333333333333 -5301 keep parsimony-informative 0.3333333333333333 +5296 keep singleton 0.5833 +5297 keep singleton 0.5833 +5298 keep parsimony-informative 0.5833 +5299 keep parsimony-informative 0.3333 +5300 keep parsimony-informative 0.3333 +5301 keep parsimony-informative 0.3333 5302 keep parsimony-informative 0.0 5303 keep parsimony-informative 0.0 5304 keep parsimony-informative 0.0 @@ -5320,45 +5320,45 @@ 5320 keep parsimony-informative 0.0 5321 keep parsimony-informative 0.0 5322 keep parsimony-informative 0.0 -5323 keep parsimony-informative 0.08333333333333333 -5324 keep parsimony-informative 0.08333333333333333 -5325 keep parsimony-informative 0.08333333333333333 -5326 keep parsimony-informative 0.08333333333333333 -5327 keep parsimony-informative 0.08333333333333333 -5328 keep parsimony-informative 0.08333333333333333 -5329 keep singleton 0.08333333333333333 -5330 keep constant 0.08333333333333333 -5331 keep singleton 0.08333333333333333 -5332 keep constant 0.08333333333333333 -5333 keep singleton 0.08333333333333333 -5334 keep parsimony-informative 0.08333333333333333 -5335 keep singleton 0.08333333333333333 -5336 keep singleton 0.08333333333333333 -5337 keep parsimony-informative 0.08333333333333333 -5338 keep parsimony-informative 0.08333333333333333 -5339 keep parsimony-informative 0.08333333333333333 -5340 keep parsimony-informative 0.08333333333333333 -5341 keep parsimony-informative 0.08333333333333333 -5342 keep parsimony-informative 0.08333333333333333 -5343 keep parsimony-informative 0.08333333333333333 -5344 keep parsimony-informative 0.08333333333333333 -5345 keep parsimony-informative 0.08333333333333333 -5346 keep parsimony-informative 0.08333333333333333 -5347 keep parsimony-informative 0.08333333333333333 -5348 keep parsimony-informative 0.08333333333333333 -5349 keep parsimony-informative 0.08333333333333333 -5350 keep parsimony-informative 0.16666666666666666 -5351 keep parsimony-informative 0.16666666666666666 -5352 keep parsimony-informative 0.16666666666666666 -5353 keep parsimony-informative 0.16666666666666666 -5354 keep parsimony-informative 0.16666666666666666 -5355 keep parsimony-informative 0.16666666666666666 -5356 keep parsimony-informative 0.16666666666666666 -5357 keep parsimony-informative 0.16666666666666666 -5358 keep parsimony-informative 0.16666666666666666 -5359 keep parsimony-informative 0.08333333333333333 -5360 keep parsimony-informative 0.08333333333333333 -5361 keep parsimony-informative 0.08333333333333333 +5323 keep parsimony-informative 0.0833 +5324 keep parsimony-informative 0.0833 +5325 keep parsimony-informative 0.0833 +5326 keep parsimony-informative 0.0833 +5327 keep parsimony-informative 0.0833 +5328 keep parsimony-informative 0.0833 +5329 keep singleton 0.0833 +5330 keep constant 0.0833 +5331 keep singleton 0.0833 +5332 keep constant 0.0833 +5333 keep singleton 0.0833 +5334 keep parsimony-informative 0.0833 +5335 keep singleton 0.0833 +5336 keep singleton 0.0833 +5337 keep parsimony-informative 0.0833 +5338 keep parsimony-informative 0.0833 +5339 keep parsimony-informative 0.0833 +5340 keep parsimony-informative 0.0833 +5341 keep parsimony-informative 0.0833 +5342 keep parsimony-informative 0.0833 +5343 keep parsimony-informative 0.0833 +5344 keep parsimony-informative 0.0833 +5345 keep parsimony-informative 0.0833 +5346 keep parsimony-informative 0.0833 +5347 keep parsimony-informative 0.0833 +5348 keep parsimony-informative 0.0833 +5349 keep parsimony-informative 0.0833 +5350 keep parsimony-informative 0.1667 +5351 keep parsimony-informative 0.1667 +5352 keep parsimony-informative 0.1667 +5353 keep parsimony-informative 0.1667 +5354 keep parsimony-informative 0.1667 +5355 keep parsimony-informative 0.1667 +5356 keep parsimony-informative 0.1667 +5357 keep parsimony-informative 0.1667 +5358 keep parsimony-informative 0.1667 +5359 keep parsimony-informative 0.0833 +5360 keep parsimony-informative 0.0833 +5361 keep parsimony-informative 0.0833 5362 keep parsimony-informative 0.0 5363 keep parsimony-informative 0.0 5364 keep parsimony-informative 0.0 @@ -5368,9 +5368,9 @@ 5368 keep parsimony-informative 0.0 5369 keep parsimony-informative 0.0 5370 keep parsimony-informative 0.0 -5371 keep parsimony-informative 0.16666666666666666 -5372 keep parsimony-informative 0.16666666666666666 -5373 keep parsimony-informative 0.16666666666666666 +5371 keep parsimony-informative 0.1667 +5372 keep parsimony-informative 0.1667 +5373 keep parsimony-informative 0.1667 5374 keep parsimony-informative 0.0 5375 keep parsimony-informative 0.0 5376 keep parsimony-informative 0.0 @@ -5668,9 +5668,9 @@ 5668 keep singleton 0.0 5669 keep parsimony-informative 0.0 5670 keep parsimony-informative 0.0 -5671 keep parsimony-informative 0.08333333333333333 -5672 keep constant 0.08333333333333333 -5673 keep parsimony-informative 0.08333333333333333 +5671 keep parsimony-informative 0.0833 +5672 keep constant 0.0833 +5673 keep parsimony-informative 0.0833 5674 keep singleton 0.0 5675 keep singleton 0.0 5676 keep parsimony-informative 0.0 @@ -5746,9 +5746,9 @@ 5746 keep parsimony-informative 0.0 5747 keep singleton 0.0 5748 keep parsimony-informative 0.0 -5749 keep parsimony-informative 0.6666666666666666 -5750 keep constant 0.6666666666666666 -5751 keep constant 0.6666666666666666 +5749 keep parsimony-informative 0.6667 +5750 keep constant 0.6667 +5751 keep constant 0.6667 5752 keep parsimony-informative 0.0 5753 keep parsimony-informative 0.0 5754 keep parsimony-informative 0.0 @@ -5803,30 +5803,30 @@ 5803 keep parsimony-informative 0.0 5804 keep parsimony-informative 0.0 5805 keep parsimony-informative 0.0 -5806 keep parsimony-informative 0.08333333333333333 -5807 keep constant 0.08333333333333333 -5808 keep parsimony-informative 0.08333333333333333 -5809 keep parsimony-informative 0.08333333333333333 -5810 keep parsimony-informative 0.08333333333333333 -5811 keep parsimony-informative 0.08333333333333333 -5812 keep parsimony-informative 0.08333333333333333 -5813 keep parsimony-informative 0.08333333333333333 -5814 keep parsimony-informative 0.08333333333333333 -5815 keep singleton 0.08333333333333333 -5816 keep parsimony-informative 0.08333333333333333 -5817 keep parsimony-informative 0.08333333333333333 -5818 keep parsimony-informative 0.16666666666666666 -5819 keep parsimony-informative 0.16666666666666666 -5820 keep parsimony-informative 0.16666666666666666 -5821 trim other 0.9166666666666666 -5822 trim other 0.9166666666666666 -5823 trim other 0.9166666666666666 -5824 keep other 0.8333333333333334 -5825 keep other 0.8333333333333334 -5826 keep other 0.8333333333333334 -5827 keep other 0.8333333333333334 -5828 keep other 0.8333333333333334 -5829 keep constant 0.8333333333333334 +5806 keep parsimony-informative 0.0833 +5807 keep constant 0.0833 +5808 keep parsimony-informative 0.0833 +5809 keep parsimony-informative 0.0833 +5810 keep parsimony-informative 0.0833 +5811 keep parsimony-informative 0.0833 +5812 keep parsimony-informative 0.0833 +5813 keep parsimony-informative 0.0833 +5814 keep parsimony-informative 0.0833 +5815 keep singleton 0.0833 +5816 keep parsimony-informative 0.0833 +5817 keep parsimony-informative 0.0833 +5818 keep parsimony-informative 0.1667 +5819 keep parsimony-informative 0.1667 +5820 keep parsimony-informative 0.1667 +5821 trim other 0.9167 +5822 trim other 0.9167 +5823 trim other 0.9167 +5824 keep other 0.8333 +5825 keep other 0.8333 +5826 keep other 0.8333 +5827 keep other 0.8333 +5828 keep other 0.8333 +5829 keep constant 0.8333 5830 keep parsimony-informative 0.0 5831 keep singleton 0.0 5832 keep parsimony-informative 0.0 @@ -5836,9 +5836,9 @@ 5836 keep parsimony-informative 0.0 5837 keep parsimony-informative 0.0 5838 keep parsimony-informative 0.0 -5839 keep parsimony-informative 0.08333333333333333 -5840 keep constant 0.08333333333333333 -5841 keep parsimony-informative 0.08333333333333333 +5839 keep parsimony-informative 0.0833 +5840 keep constant 0.0833 +5841 keep parsimony-informative 0.0833 5842 keep parsimony-informative 0.0 5843 keep parsimony-informative 0.0 5844 keep parsimony-informative 0.0 @@ -5893,21 +5893,21 @@ 5893 keep parsimony-informative 0.0 5894 keep parsimony-informative 0.0 5895 keep parsimony-informative 0.0 -5896 keep parsimony-informative 0.08333333333333333 -5897 keep parsimony-informative 0.08333333333333333 -5898 keep parsimony-informative 0.08333333333333333 -5899 keep parsimony-informative 0.08333333333333333 -5900 keep singleton 0.08333333333333333 -5901 keep parsimony-informative 0.08333333333333333 -5902 keep parsimony-informative 0.5833333333333334 -5903 keep singleton 0.5833333333333334 -5904 keep parsimony-informative 0.5833333333333334 -5905 keep parsimony-informative 0.08333333333333333 -5906 keep singleton 0.08333333333333333 -5907 keep parsimony-informative 0.08333333333333333 -5908 keep parsimony-informative 0.08333333333333333 -5909 keep singleton 0.08333333333333333 -5910 keep parsimony-informative 0.08333333333333333 +5896 keep parsimony-informative 0.0833 +5897 keep parsimony-informative 0.0833 +5898 keep parsimony-informative 0.0833 +5899 keep parsimony-informative 0.0833 +5900 keep singleton 0.0833 +5901 keep parsimony-informative 0.0833 +5902 keep parsimony-informative 0.5833 +5903 keep singleton 0.5833 +5904 keep parsimony-informative 0.5833 +5905 keep parsimony-informative 0.0833 +5906 keep singleton 0.0833 +5907 keep parsimony-informative 0.0833 +5908 keep parsimony-informative 0.0833 +5909 keep singleton 0.0833 +5910 keep parsimony-informative 0.0833 5911 keep parsimony-informative 0.0 5912 keep parsimony-informative 0.0 5913 keep parsimony-informative 0.0 @@ -5932,12 +5932,12 @@ 5932 keep parsimony-informative 0.0 5933 keep parsimony-informative 0.0 5934 keep parsimony-informative 0.0 -5935 trim other 0.9166666666666666 -5936 trim other 0.9166666666666666 -5937 trim other 0.9166666666666666 -5938 trim other 0.9166666666666666 -5939 trim other 0.9166666666666666 -5940 trim other 0.9166666666666666 +5935 trim other 0.9167 +5936 trim other 0.9167 +5937 trim other 0.9167 +5938 trim other 0.9167 +5939 trim other 0.9167 +5940 trim other 0.9167 5941 keep parsimony-informative 0.0 5942 keep constant 0.0 5943 keep parsimony-informative 0.0 @@ -6112,27 +6112,27 @@ 6112 keep parsimony-informative 0.0 6113 keep parsimony-informative 0.0 6114 keep parsimony-informative 0.0 -6115 keep parsimony-informative 0.08333333333333333 -6116 keep parsimony-informative 0.08333333333333333 -6117 keep singleton 0.08333333333333333 -6118 keep parsimony-informative 0.08333333333333333 -6119 keep parsimony-informative 0.08333333333333333 -6120 keep parsimony-informative 0.08333333333333333 -6121 keep parsimony-informative 0.08333333333333333 -6122 keep parsimony-informative 0.08333333333333333 -6123 keep parsimony-informative 0.08333333333333333 -6124 keep parsimony-informative 0.08333333333333333 -6125 keep constant 0.08333333333333333 -6126 keep parsimony-informative 0.08333333333333333 -6127 keep parsimony-informative 0.08333333333333333 -6128 keep constant 0.08333333333333333 -6129 keep parsimony-informative 0.08333333333333333 -6130 keep parsimony-informative 0.08333333333333333 -6131 keep singleton 0.08333333333333333 -6132 keep parsimony-informative 0.08333333333333333 -6133 keep parsimony-informative 0.08333333333333333 -6134 keep parsimony-informative 0.08333333333333333 -6135 keep parsimony-informative 0.08333333333333333 +6115 keep parsimony-informative 0.0833 +6116 keep parsimony-informative 0.0833 +6117 keep singleton 0.0833 +6118 keep parsimony-informative 0.0833 +6119 keep parsimony-informative 0.0833 +6120 keep parsimony-informative 0.0833 +6121 keep parsimony-informative 0.0833 +6122 keep parsimony-informative 0.0833 +6123 keep parsimony-informative 0.0833 +6124 keep parsimony-informative 0.0833 +6125 keep constant 0.0833 +6126 keep parsimony-informative 0.0833 +6127 keep parsimony-informative 0.0833 +6128 keep constant 0.0833 +6129 keep parsimony-informative 0.0833 +6130 keep parsimony-informative 0.0833 +6131 keep singleton 0.0833 +6132 keep parsimony-informative 0.0833 +6133 keep parsimony-informative 0.0833 +6134 keep parsimony-informative 0.0833 +6135 keep parsimony-informative 0.0833 6136 keep singleton 0.0 6137 keep constant 0.0 6138 keep parsimony-informative 0.0 @@ -6151,9 +6151,9 @@ 6151 keep parsimony-informative 0.0 6152 keep parsimony-informative 0.0 6153 keep parsimony-informative 0.0 -6154 keep parsimony-informative 0.08333333333333333 -6155 keep constant 0.08333333333333333 -6156 keep parsimony-informative 0.08333333333333333 +6154 keep parsimony-informative 0.0833 +6155 keep constant 0.0833 +6156 keep parsimony-informative 0.0833 6157 keep parsimony-informative 0.0 6158 keep constant 0.0 6159 keep parsimony-informative 0.0 @@ -6166,24 +6166,24 @@ 6166 keep parsimony-informative 0.0 6167 keep constant 0.0 6168 keep parsimony-informative 0.0 -6169 keep singleton 0.08333333333333333 -6170 keep parsimony-informative 0.08333333333333333 -6171 keep parsimony-informative 0.08333333333333333 -6172 keep parsimony-informative 0.08333333333333333 -6173 keep parsimony-informative 0.08333333333333333 -6174 keep parsimony-informative 0.08333333333333333 -6175 keep parsimony-informative 0.08333333333333333 -6176 keep parsimony-informative 0.08333333333333333 -6177 keep parsimony-informative 0.08333333333333333 -6178 keep parsimony-informative 0.08333333333333333 -6179 keep parsimony-informative 0.08333333333333333 -6180 keep parsimony-informative 0.08333333333333333 -6181 keep singleton 0.08333333333333333 -6182 keep parsimony-informative 0.08333333333333333 -6183 keep parsimony-informative 0.08333333333333333 -6184 keep parsimony-informative 0.08333333333333333 -6185 keep parsimony-informative 0.08333333333333333 -6186 keep parsimony-informative 0.08333333333333333 +6169 keep singleton 0.0833 +6170 keep parsimony-informative 0.0833 +6171 keep parsimony-informative 0.0833 +6172 keep parsimony-informative 0.0833 +6173 keep parsimony-informative 0.0833 +6174 keep parsimony-informative 0.0833 +6175 keep parsimony-informative 0.0833 +6176 keep parsimony-informative 0.0833 +6177 keep parsimony-informative 0.0833 +6178 keep parsimony-informative 0.0833 +6179 keep parsimony-informative 0.0833 +6180 keep parsimony-informative 0.0833 +6181 keep singleton 0.0833 +6182 keep parsimony-informative 0.0833 +6183 keep parsimony-informative 0.0833 +6184 keep parsimony-informative 0.0833 +6185 keep parsimony-informative 0.0833 +6186 keep parsimony-informative 0.0833 6187 keep parsimony-informative 0.0 6188 keep parsimony-informative 0.0 6189 keep parsimony-informative 0.0 @@ -6199,18 +6199,18 @@ 6199 keep parsimony-informative 0.0 6200 keep parsimony-informative 0.0 6201 keep parsimony-informative 0.0 -6202 keep parsimony-informative 0.08333333333333333 -6203 keep parsimony-informative 0.08333333333333333 -6204 keep parsimony-informative 0.08333333333333333 +6202 keep parsimony-informative 0.0833 +6203 keep parsimony-informative 0.0833 +6204 keep parsimony-informative 0.0833 6205 keep parsimony-informative 0.5 6206 keep singleton 0.5 6207 keep parsimony-informative 0.5 -6208 keep parsimony-informative 0.16666666666666666 -6209 keep parsimony-informative 0.16666666666666666 -6210 keep parsimony-informative 0.16666666666666666 -6211 keep parsimony-informative 0.08333333333333333 -6212 keep parsimony-informative 0.08333333333333333 -6213 keep parsimony-informative 0.08333333333333333 +6208 keep parsimony-informative 0.1667 +6209 keep parsimony-informative 0.1667 +6210 keep parsimony-informative 0.1667 +6211 keep parsimony-informative 0.0833 +6212 keep parsimony-informative 0.0833 +6213 keep parsimony-informative 0.0833 6214 keep parsimony-informative 0.0 6215 keep singleton 0.0 6216 keep parsimony-informative 0.0 @@ -6226,27 +6226,27 @@ 6226 keep singleton 0.0 6227 keep parsimony-informative 0.0 6228 keep parsimony-informative 0.0 -6229 keep constant 0.8333333333333334 -6230 keep constant 0.8333333333333334 -6231 keep other 0.8333333333333334 -6232 keep constant 0.8333333333333334 -6233 keep other 0.8333333333333334 -6234 keep other 0.8333333333333334 -6235 keep other 0.8333333333333334 -6236 keep constant 0.8333333333333334 -6237 keep other 0.8333333333333334 -6238 keep constant 0.8333333333333334 -6239 keep other 0.8333333333333334 -6240 keep other 0.8333333333333334 -6241 keep other 0.8333333333333334 -6242 keep other 0.8333333333333334 -6243 keep other 0.8333333333333334 -6244 keep other 0.8333333333333334 -6245 keep other 0.8333333333333334 -6246 keep other 0.8333333333333334 -6247 keep constant 0.8333333333333334 -6248 keep constant 0.8333333333333334 -6249 keep other 0.8333333333333334 +6229 keep constant 0.8333 +6230 keep constant 0.8333 +6231 keep other 0.8333 +6232 keep constant 0.8333 +6233 keep other 0.8333 +6234 keep other 0.8333 +6235 keep other 0.8333 +6236 keep constant 0.8333 +6237 keep other 0.8333 +6238 keep constant 0.8333 +6239 keep other 0.8333 +6240 keep other 0.8333 +6241 keep other 0.8333 +6242 keep other 0.8333 +6243 keep other 0.8333 +6244 keep other 0.8333 +6245 keep other 0.8333 +6246 keep other 0.8333 +6247 keep constant 0.8333 +6248 keep constant 0.8333 +6249 keep other 0.8333 6250 keep parsimony-informative 0.0 6251 keep parsimony-informative 0.0 6252 keep parsimony-informative 0.0 @@ -6325,12 +6325,12 @@ 6325 keep singleton 0.0 6326 keep parsimony-informative 0.0 6327 keep parsimony-informative 0.0 -6328 keep parsimony-informative 0.08333333333333333 -6329 keep singleton 0.08333333333333333 -6330 keep parsimony-informative 0.08333333333333333 -6331 keep parsimony-informative 0.16666666666666666 -6332 keep singleton 0.16666666666666666 -6333 keep parsimony-informative 0.16666666666666666 +6328 keep parsimony-informative 0.0833 +6329 keep singleton 0.0833 +6330 keep parsimony-informative 0.0833 +6331 keep parsimony-informative 0.1667 +6332 keep singleton 0.1667 +6333 keep parsimony-informative 0.1667 6334 keep parsimony-informative 0.25 6335 keep parsimony-informative 0.25 6336 keep parsimony-informative 0.25 @@ -6340,12 +6340,12 @@ 6340 keep parsimony-informative 0.25 6341 keep parsimony-informative 0.25 6342 keep singleton 0.25 -6343 trim other 0.9166666666666666 -6344 trim other 0.9166666666666666 -6345 trim other 0.9166666666666666 -6346 trim other 0.9166666666666666 -6347 trim other 0.9166666666666666 -6348 trim other 0.9166666666666666 +6343 trim other 0.9167 +6344 trim other 0.9167 +6345 trim other 0.9167 +6346 trim other 0.9167 +6347 trim other 0.9167 +6348 trim other 0.9167 6349 keep parsimony-informative 0.25 6350 keep parsimony-informative 0.25 6351 keep parsimony-informative 0.25 diff --git a/tests/integration/expected/EOG091N44M8_aa.clipkit_kpi_smart_gaps b/tests/integration/expected/EOG091N44M8_aa.clipkit_kpi_smart_gaps index e6b6001..f2c118e 100644 --- a/tests/integration/expected/EOG091N44M8_aa.clipkit_kpi_smart_gaps +++ b/tests/integration/expected/EOG091N44M8_aa.clipkit_kpi_smart_gaps @@ -1,468 +1,468 @@ >200_S38|EOG091N44M8 -YAATEATSAIASAEGDLEVISQGDLQESSASG-GAAAAAGGAEAPAEKVK-ESDEDMGFG -ISEYVGISPSNYAKIIDQYSHDDKKERVIIGAHVAAREMPDAISIRKIAKIVKVVGGMSD -PYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI +YAATEATSAIASAEGDLEVISQGDLQESSASG-GAA-AAAGGAEAPAEKVK-ESDEDMGF +GISEYVGISMPPSNYPLVDIPVDFENDAKIIDQYSHDDKKERVIIGAHVAAREMPDAISI +RKIAKIVKVVGGMSDPYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI >203_S40|EOG091N44M8 -YAATEATSAIASAEGDLEVISQGDLQESSASG-GAAAAAGGAEAPAEKVK-ESDEDMGFG -ISEYVGISPSNYAKIIDQYSHDDKKERVIIGAHVAAREMPDAISIRKIAKIVKVVGGMSD -PYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI +YAATEATSAIASAEGDLEVISQGDLQESSASG-GAA-AAAGGAEAPAEKVK-ESDEDMGF +GISEYVGISMPPSNYPLVDIPVDFENDAKIIDQYSHDDKKERVIIGAHVAAREMPDAISI +RKIAKIVKVVGGMSDPYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI >206_S41|EOG091N44M8 -YAANESSSAIASAEGDLEVVSQGDLNEASTSGAAA-AAPAGGAAPAEKKE-KSDEDMGFG -THEYVGIS------VLEQHAREDKRDKVVVAAGAAVKQMSEAVTLRKVEKVIMVIGGKSD -HYTITAIFDTIQEASQEAIVLLEFLIALRNEEEDKVSAHL +YAANESSSAIASAEGDLEVVSQGDLNEASTSGAAA--AAPAGGAAPAEKKE-KSDEDMGF +GTHEYVGIS--------------------VLEQHAREDKRDKVVVAAGAAVKQMSEAVTL +RKVEKVIMVIGGKSDHYTITAIFDTIQEASQEAIVLLEFLIALRNEEEDKVSAHL >207_S42|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >209_S43|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >212_S45|EOG091N44M8 -HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAAAAGGDAAAPAEKKE-KSDEDMGFG -C----------------------------------------------------------- --------TG------------------------------- +HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAA-AAGGDAAAPAEKKE-KSDEDMGF +GC---------------------------------------------------------- +----------------------TG------------------------------- >215_S46|EOG091N44M8 -YAATEATSAIASAEGDLEVISQGDLQESSASG-GAAAAAGGAEAPAEKVK-ESDEDMGFG -ISEYVGISPSNYAKIIDQYSHDDKKERVIIGAHVAAREMPDAISIRKIAKIVKVVGGMSD -PYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI +YAATEATSAIASAEGDLEVISQGDLQESSASG-GAA-AAAGGAEAPAEKVK-ESDEDMGF +GISEYVGISMPPSNYPLVDIPVDFENDAKIIDQYSHDDKKERVIIGAHVAAREMPDAISI +RKIAKIVKVVGGMSDPYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI >220_S48|EOG091N44M8 -YAANESSSAIASAEGDLEVVSQGDLNEASTSGAAA-AAPAGGAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSSAIASAEGDLEVVSQGDLNEASTSGAAA--AAPAGGAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >231_51|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >232-S52|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >236_53|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >244-S54|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQESSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSAAIASADSELEVVAQGNLQESSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >245_S55|EOG091N44M8 -YAATEATSAIASAEGDLEVISQGDLQESSASG-GAAAAAGGAEAPAEKVK-ESDEDMGFG -ISEYVGISPSNYAKIIDQYSHDDKKERVIIGAHVAAREMPDAISIRKIAKVVKVVGGMSD -PYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI +YAATEATSAIASAEGDLEVISQGDLQESSASG-GAA-AAAGGAEAPAEKVK-ESDEDMGF +GISEYVGISMPPSNYPLVDIPVDFENDAKIIDQYSHDDKKERVIIGAHVAAREMPDAISI +RKIAKVVKVVGGMSDPYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI >247_s46|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -F----------------------------------------------------------- --------KM------------------------------- +HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GF---------------------------------------------------------- +----------------------KM------------------------------- >250_S57|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >252_S58|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -S----------------------------------------------------------- --------KM------------------------------- +HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GS---------------------------------------------------------- +----------------------KM------------------------------- >256_S59|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >257_S60|EOG091N44M8 -YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAAAAAGGAAAPAEKKK-EDCDSSXIS -AIEYVGIS------LIDQHSREDKKERVIIGANVAVRELSDVTSIRKVAKVIRYIAANSN -PYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI +YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAA-AAAGGAAAPAEKKK-EDCDSSXI +SAIEYVGIS--------------------LIDQHSREDKKERVIIGANVAVRELSDVTSI +RKVAKVIRYIAANSNPYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI >258_S61|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >259_S62|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >261_S63|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFA -G---ISLV---------------------------------------------------- ----------------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +AG---ISLV--------------------------------------------------- +------------------------------------------------------- >262_S64|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >267_S66|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >269_S67|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >271_S68|EOG091N44M8 -YAATEASAAISSAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAATEASAAISSAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >274_S69|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -F----------------------------------------------------------- --------FV------------------------------- +HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GF---------------------------------------------------------- +----------------------FV------------------------------- >275_S70|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >276_S71|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >277_S72|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >278_S73|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >280_S74|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >284_S76|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQESSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -F----------------------------------------------------------- --------VG------------------------------- +HAANESSAAIASADSELEVVAQGNLQESSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GF---------------------------------------------------------- +----------------------VG------------------------------- >285_S77|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >288_S78|EOG091N44M8 -YAANESSSAIASAEGDLEVVSQGDLNEASTSGAAA-AAPAGGAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSSAIASAEGDLEVVSQGDLNEASTSGAAA--AAPAGGAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >289_S79|EOG091N44M8 -HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAAAAGGAAAAPAEKKE-KSDEDMGFG -F----------------------------------------------------------- --------FV------------------------------- +HAANESSAAIASADSELEVVAQGNLQDSSTSAGGAA-AAGGAAAAPAEKKE-KSDEDMGF +GF---------------------------------------------------------- +----------------------FV------------------------------- >Aspergillus_fumigatus_Af293_GCF_000002655.1|EOG091N44M8 -HAANTSSSEVASADEELNLIAEGDLQEASTSGAAAAAAAGGAAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANTSSSEVASADEELNLIAEGDLQEASTSGAAAAGAAAGGAAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Aspergillus_niger_GCF_000002855.3|EOG091N44M8 -YAANNTSAEISSAEEELQLLAEGDLQESTQSGAGAAGGAAAAEAPAEKKA-ASDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANNTSAEISSAEEELQLLAEGDLQESTQSGAGAA-GGAAAAEAPAEKKA-ASDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Aspergillus_oryzae_RIB40_GCF_000184455.2|EOG091N44M8 -HAANSTSVEISSADEELQVISEGDLQQTSESGAGAAAAAGG-DAPAE-KE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANSTSVEISSADEELQVISEGDLQQTSESGAGAAGAAAGG-DAPAE-KE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_antarcticum_GCA_002072345.1|EOG091N44M8 -YAANETSAAISSAEGDLDVIAEGNLQESSTSGAGAAAAAGGAAAPAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANETSAAISSAEGDLDVIAEGNLQESSTSGAGAA-AAAGGAAAPAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_biforme_FM169_GCA_000577785.1|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_brasilianum_GCA_000769745.1|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYI-------------- +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYI-------------- >Penicillium_brasilianum_GCA_001048715.1|EOG091N44M8 -HAANESSVSIESADSELEVVAQGNLQDASASGAGAAAAAGGAAEAPAAKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSVSIESADSELEVVAQGNLQDASASGAGAA-AAAGGAAEAPAAKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_brasilianum_GCA_002016555.1|EOG091N44M8 -HAANESSVSIESADSELEVVAQGNLQDASASGAGAAAAAGGAAEAPAAKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSVSIESADSELEVVAQGNLQDASASGAGAA-AAAGGAAEAPAAKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_brasilianum_GCA_004916855.1|EOG091N44M8 -HAANESSVSIESADSELEVVAQGNLQDASASGAGAAAAAGGAAEAPAAKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSVSIESADSELEVVAQGNLQDASASGAGAA-AAAGGAAEAPAAKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_camemberti_FM_013_GCA_000513335.1|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_capsulatum_GCA_000943765.1|EOG091N44M8 -YAANESSAAISSAEGDLDVIAEGNLQESSTSGGAAAAAAGGAAAPAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAISSAEGDLDVIAEGNLQESSTSGGAAA-AAAGGAAAPAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_capsulatum_GCA_000943775.1|EOG091N44M8 -YAANESSAAISSAEGDLDVIAEGNLQESSTSGGAAAAAAGGAAAPAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAISSAEGDLDVIAEGNLQESSTSGGAAA-AAAGGAAAPAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_chrysogenum_GCA_000710275.1|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_chrysogenum_GCA_000801355.1|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_chrysogenum_GCA_002080375.1|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_chrysogenum_KF-25_GCA_000816005.1|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_chrysogenum_NCPC10086_GCA_000523475.1|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_chrysogenum_NCPC10086_GCA_001773325.1|EOG091N44M8 -YAANETSAAISSAEGDLDVIAEGNLQESSTSGGGAAAAAGGAAAPAEKKKEESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANETSAAISSAEGDLDVIAEGNLQESSTSGGGAA-AAAGGAAAPAEKKKEESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_citrinum_GCA_001399475.1|EOG091N44M8 -HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAAAAGGDAAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAA-AAGGDAAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_citrinum_GCA_001950535.1|EOG091N44M8 -HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAAAAGGDAAAPAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAA-AAGGDAAAPAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_commune_162_3FA|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_coprophilum_GCA_002072405.1|EOG091N44M8 -YAANEASSAIASAEGDLEVISQGDLQEASTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAIASAEGDLEVISQGDLQEASTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_decumbens_GCA_000226395.1|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_decumbens_GCA_002072245.1|EOG091N44M8 -YSANESSAAIGSADSELDLIAQGNLQEASTSAAGAAAAGGAADAPAE-KE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YSANESSAAIGSADSELDLIAQGNLQEASTSAAGAA-AAGGAADAPAE-KE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_digitatum_Pd01-ZJU_GCA_000485865.1|EOG091N44M8 -YAANEASSDIASAEGDLEVISQGDLQESSASGSAAAAAAGGAAAPAEKVK-ESDEDMGFD -V-WMIGIS------VLDQYSRDNNKESIIIGVHVVVREMSGAISICRIAKVIRFTARERD -PYTITSIFDSLQQASQGAMELLEYYV-------------- +YAANEASSDIASAEGDLEVISQGDLQESSASGSAAA-AAAGGAAAPAEKVK-ESDEDMGF +DV-WMIGIS--------------------VLDQYSRDNNKESIIIGVHVVVREMSGAISI +CRIAKVIRFTARERDPYTITSIFDSLQQASQGAMELLEYYV-------------- >Penicillium_digitatum_PDC_102_GCA_001307865.1|EOG091N44M8 -YAANEASSDIASAEGDLEVISQGDLQESSASGSAAAAAAGGAAAPAEKVK-ESDEDMGFD -V-WMIGISLSKGS-FLDQYSRDNNKESIIIGVHVVVREMSGAISICRIAKVIRFTARERD -PYTITSIFDSLQQASQGAMELLEYYVAMKSVDEANI---- +YAANEASSDIASAEGDLEVISQGDLQESSASGSAAA-AAAGGAAAPAEKVK-ESDEDMGF +DV-WMIGIS--LSKG------------S-FLDQYSRDNNKESIIIGVHVVVREMSGAISI +CRIAKVIRFTARERDPYTITSIFDSLQQASQGAMELLEYYVAMKSVDEANI---- >Penicillium_digitatum_PHI26_GCA_000315665.1|EOG091N44M8 -YAANEASSDIASAEGDLEVISQGDLQESSASGSAAAAAAGGAAAPAEKVK-ESDEDMGFD -V-WMIGIS------VLDQYSRDNNKESIIIGVHVVVREMSGAISICRIAKVIRFTARERD -PYTITSIFDSLQQASQGAMELLEYYVAMKSVDEANI---- +YAANEASSDIASAEGDLEVISQGDLQESSASGSAAA-AAAGGAAAPAEKVK-ESDEDMGF +DV-WMIGIS--------------------VLDQYSRDNNKESIIIGVHVVVREMSGAISI +CRIAKVIRFTARERDPYTITSIFDSLQQASQGAMELLEYYVAMKSVDEANI---- >Penicillium_expansum_GCA_000688875.1|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYIAM------------ +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYIAM------------ >Penicillium_expansum_GCA_000769735.1|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYI-------------- +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYI-------------- >Penicillium_expansum_GCA_000769755.1|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYIAM------------ +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYIAM------------ >Penicillium_expansum_GCA_001750045.2|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYIAM------------ +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYIAM------------ >Penicillium_expansum_GCA_004302965.1|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYIAM------------ +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYIAM------------ >Penicillium_expansum_NRRL_62431_GCA_000584915.1|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYIAM------------ +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYIAM------------ >Penicillium_expansum_T01_GCA_001008385.1|EOG091N44M8 -YAANEASAAIASVEGDVEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -IMEYVGISSTEGLHIIDKLSRDDKKERVIIGAHVAVREMPDAISIRKIAAVIRFIGGMSD -LFTITAIFDSIQESSREAIELLEYYI-------------- +YAANEASAAIASVEGDVEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GIMEYVGISSTSTEGQIAEMSCRSQSQLHIIDKLSRDDKKERVIIGAHVAVREMPDAISI +RKIAAVIRFIGGMSDLFTITAIFDSIQESSREAIELLEYYI-------------- >Penicillium_expansum_YT02_GCA_002072455.1|EOG091N44M8 -HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_flavigenum_GCA_002072365.1|EOG091N44M8 -YAANEASAAIDSAEADLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASAAIDSAEADLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_freii_GCA_001513925.1|EOG091N44M8 -YAATEASAAISSAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAATEASAAISSAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_fuscoglaucum_FM041_GCA_000576735.1|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >Penicillium_griseofulvum_GCA_001561935.1|EOG091N44M8 -YAANEASSDIASAEGDLEVISQGDLQEASTTGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSDIASAEGDLEVISQGDLQEASTTGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_griseofulvum_GCA_001735785.1|EOG091N44M8 -YAANEASSDIASAEGDLEVISQGDLQEASTTGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSDIASAEGDLEVISQGDLQEASTTGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_italicum_GCA_000769765.1|EOG091N44M8 -YAANEASSAIASAEGDLEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_italicum_GCA_001008395.1|EOG091N44M8 -YAANEASSAIASAEGDLEVISQGDLQESSASGAGAAAAAGGAAAPAEKEK-ESDEDMGFG -IVEYVGIS------VIDQHSRDDNEERVIIGAHVAVREMSDLISTRKIATVTRFIGGMSD -PYNITAIFDSIQEASREAIELLEYHIAMTNADEARISASV +YAANEASSAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGAAAPAEKEK-ESDEDMGF +GIVEYVGIS--------------------VIDQHSRDDNEERVIIGAHVAVREMSDLIST +RKIATVTRFIGGMSDPYNITAIFDSIQEASREAIELLEYHIAMTNADEARISASV >Penicillium_italicum_GCA_002116305.1|EOG091N44M8 -YAANEASSAIASAEGDLEVISQGDLQESSASGAGAAAAAGGAAAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_janthinellum_GCA_002369805.1|EOG091N44M8 -HAANESSASIESADSDLEVVAQGNLQDASASGAGGAAAAGGAAEAPAAKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSDLEVVAQGNLQDASASGAGGAGAAAGGAAEAPAAKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_nalgiovense_FM193_GCA_000577395.2|EOG091N44M8 -YAANEASTAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASTAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_nalgiovense_GCA_002072425.1|EOG091N44M8 -YAANEASTAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASTAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_nordicum_GCA_000315645.2|EOG091N44M8 -YAANEASSDIASAEGDLEVISQGDLQESSASGSAAAAAAGGAAAPAEKVK-ESDEDMGFD -V-WMIGIS------VLDQYSRDNNKESIIIGVHVVVREMSGAISICRIAKVIRFTARERD -PYTITSIFDSLQQASQGAMELLEYYVA-GLCSQEEV---- +YAANEASSDIASAEGDLEVISQGDLQESSASGSAAA-AAAGGAAAPAEKVK-ESDEDMGF +DV-WMIGIS--------------------VLDQYSRDNNKESIIIGVHVVVREMSGAISI +CRIAKVIRFTARERDPYTITSIFDSLQQASQGAMELLEYYVA-GLCSQEEV---- >Penicillium_nordicum_GCA_000733025.2|EOG091N44M8 -YAATEATSAIASAEGDLEVISQGDLQESSASG-GAAAAAGGAEAPAEKVK-ESDEDMGFG -ISEYVGISPSNYAKIIDQYSHDDKKERVIIGAHVAAREMSDAISIRKIAKIVKVVGGMSD -PYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI +YAATEATSAIASAEGDLEVISQGDLQESSASG-GAA-AAAGGAEAPAEKVK-ESDEDMGF +GISEYVGISMPPSNYPLVDIPVDFENDAKIIDQYSHDDKKERVIIGAHVAAREMSDAISI +RKIAKIVKVVGGMSDPYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI >Penicillium_nordicum_GCA_001278595.1|EOG091N44M8 -YAATEATSAIASAEGDLEVISQGDLQESSASG-GAAAAAGGAEAPAEKVK-ESDEDMGFG -ISEYVGIS----AKIIDQYSHDDKKERVIIGAHVAAREMSDAISIRKIAKIVKAVGGMSD -PYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI +YAATEATSAIASAEGDLEVISQGDLQESSASG-GAA-AAAGGAEAPAEKVK-ESDEDMGF +GISEYVGIS------------------AKIIDQYSHDDKKERVIIGAHVAAREMSDAISI +RKIAKIVKAVGGMSDPYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI >Penicillium_oxalicum_114-2_GCA_000346795.1|EOG091N44M8 -HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_oxalicum_GCA_001723175.2|EOG091N44M8 -HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_oxalicum_GCA_004153425.1|EOG091N44M8 -HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_oxalicum_GCA_004521935.1|EOG091N44M8 -HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_oxalicum_GCA_005546515.1|EOG091N44M8 -HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_oxalicum_JU-A10-T_GCA_000383025.1|EOG091N44M8 -HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVSQGNLQDSSSSGA--AAAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_paneum_FM227_GCA_000577715.1|EOG091N44M8 -YAGNDDPSAIASAEGDVEVISKGDLQESSASGGGGAAAAAGAAAPAEKKKEESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAGNDDPSAIASAEGDVEVISKGDLQESSASGGGGA-AAAAGAAAPAEKKKEESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_paxilli_ATCC_26601_GCA_000347475.1|EOG091N44M8 -HAANESSAAIASADSDLDVVAQGDIQEASSSGAGAAAGGAAADAPAEKEK--SDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSAAIASADSDLDVVAQGDIQEASSSGAGAA-AGGAAADAPAEKEK--SDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_polonicum_GCA_002072265.1|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >Penicillium_polonicum_GCA_003344595.1|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_roqueforti_FM164_GCA_000513255.1|EOG091N44M8 -YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAAAAAGGAAAPAEKKK-EDCDSSXIS -AIEYVGIS------VIDQHSREDKKERVIIGANVAVRELSDVTSIRKVAKVIRYIAANSN -PYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI +YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAA-AAAGGAAAPAEKKK-EDCDSSXI +SAIEYVGIS--------------------VIDQHSREDKKERVIIGANVAVRELSDVTSI +RKVAKVIRYIAANSNPYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI >Penicillium_roqueforti_GCA_000737485.2|EOG091N44M8 -YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAAAAAGGAAAPAEKKK-EDCDSSXIS -AIEYVGIS------LIDQHSREDKKERVIIGANVAVRELSDVTSIRKVAKVIRYIAANSN -PYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI +YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAA-AAAGGAAAPAEKKK-EDCDSSXI +SAIEYVGIS--------------------LIDQHSREDKKERVIIGANVAVRELSDVTSI +RKVAKVIRYIAANSNPYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI >Penicillium_roqueforti_GCA_001599855.1|EOG091N44M8 -YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAAAAAGGAAAPAEKKK-EDCDSSXIS -AIEYVGIS------LIDQHSREDKKERVIIGANVAVRELSDVTSIRKVAKVIRYIAANSN -PYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI +YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAA-AAAGGAAAPAEKKK-EDCDSSXI +SAIEYVGIS--------------------LIDQHSREDKKERVIIGANVAVRELSDVTSI +RKVAKVIRYIAANSNPYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI >Penicillium_roqueforti_GCA_001939915.1|EOG091N44M8 -YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAAAAAGGAAAPAEKKK-EDCDSSXIS -AIEYVGIS------VIDQHSREDKKERVIIGANVAVRELSDVTSIRKVAKVIRYIAANSN -PYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI +YAANEASAAIASAEGDVEVISKDDLQVSSASGGAAA-AAAGGAAAPAEKKK-EDCDSSXI +SAIEYVGIS--------------------VIDQHSREDKKERVIIGANVAVRELSDVTSI +RKVAKVIRYIAANSNPYNLAAVFDSIHEASREAIVVMEYHITMRSEEEASISTSI >Penicillium_sclerotiorum_GCA_001750025.1|EOG091N44M8 -YAANAQSAAVESADSELDLIAQGDINEASTSGAGAAGGATTTEAAPAAKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANAQSAAVESADSELDLIAQGDINEASTSGAGAA-GGATTTEAAPAAKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_solitum_GCA_000952775.2|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >Penicillium_solitum_GCA_001750005.1|EOG091N44M8 -YAANEAASAISSAEGDLEVIAQGDLQESSASGAGAAAAAGGDAAPAEKAK-ESDEDMGFG -V----------------------------------------------------------- --------FG------------------------------- +YAANEAASAISSAEGDLEVIAQGDLQESSASGAGAA-AAAGGDAAPAEKAK-ESDEDMGF +GV---------------------------------------------------------- +----------------------FG------------------------------- >Penicillium_solitum_GCA_002072235.1|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp.12|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp._CF05_GCA_002916455.1|EOG091N44M8 -YAANEASTAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASTAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp._MA_6036_GCA_003138045.1|EOG091N44M8 -YAANEASSAIASAEGDLEVVSQGSLDEASTSGAG--AAAGG-AAPAEKEE-KSDEDMGFG -THEYVGIS------LLEQHAREDKRDKVVVAAGATVKQMSDGVTLRKVEKVIMVTGGNSN -HYTITAIFDTIQEASQTAIVLLQFLIALSSEDEEKISAHV +YAANEASSAIASAEGDLEVVSQGSLDEASTSGAG---AAAGG-AAPAEKEE-KSDEDMGF +GTHEYVGIS--------------------LLEQHAREDKRDKVVVAAGATVKQMSDGVTL +RKVEKVIMVTGGNSNHYTITAIFDTIQEASQTAIVLLQFLIALSSEDEEKISAHV >Penicillium_sp._MA_6040_GCA_003138025.1|EOG091N44M8 -YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAAAAAGGAEAAAEKKKVESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANESSAAIDSAEGDLEVIAQGDLQEASTSGGAAA-AAAGGAEAAAEKKKVESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp.MB|EOG091N44M8 -YAATEASAAIASAEGDLEVISQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFA -G---ISLV---------------------------------------------------- ----------------------------------------- +YAATEASAAIASAEGDLEVISQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +AG---ISLV--------------------------------------------------- +------------------------------------------------------- >Penicillium_sp._MT2_MMC-2018_GCA_003852855.1|EOG091N44M8 -HAANESSASIESADSDLEVVAQGNLQDASASGAGGAAAAGGAAEAPAAKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSDLEVVAQGNLQDASASGAGGAGAAAGGAAEAPAAKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp._occitanis_GCA_002382835.1|EOG091N44M8 -HGANASSASINEADEELELLAEGDIQEASSSGAG-GATAAGGAAAAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HGANASSASINEADEELELLAEGDIQEASSSGAG-GGATAAGGAAAAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp._occitanis_GCA_002382855.1|EOG091N44M8 -HGANASSASINEADEELELLAEGDIQEASSSGAG-GATAAGGAAAAEKKE-KSDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HGANASSASINEADEELELLAEGDIQEASSSGAG-GGATAAGGAAAAEKKE-KSDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp._SPG-F15_GCA_003800485.1|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAAAAAGGAAAPAEKVK-ESDEDMGFA -G---ISLS---------------------------------------------------- ----------------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSTSGAGAA-AAAGGAAAPAEKVK-ESDEDMGF +AG---ISLS--------------------------------------------------- +------------------------------------------------------- >Penicillium_sp._SPG-F1_GCA_003800495.1|EOG091N44M8 -YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAAAAAGGADAPAEKVK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASSAISSAEGDLEVIAQGDLQESSASGAGAA-AAAGGADAPAEKVK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_sp._W3_MMC-2018_GCA_004959885.1|EOG091N44M8 -YNGKANAAAISSSEEEVSLISADDISEAQETGTVAAGAAASSDAPAE-KE-KSDDDMGFG -VNDY-------------------------T--------EEPPRKLKH--QQYKTKKPPGI -I--II--ED--TELDTSNLVLLQL-L-L------------ +YNGKANAAAISSSEEEVSLISADDISEAQETGTVAA-GAAASSDAPAE-KE-KSDDDMGF +GVNDY---------------------------------------T--------EEPPRKL +KH--QQYKTKKPPGII--II--ED--TELDTSNLVLLQL-L-L------------ >Penicillium_steckii_GCA_002072375.1|EOG091N44M8 -HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAAAAGGDAAAPAEKKE-KSDEDMGFV -M----------------------------------------------------------- --------WC------------------------------- +HAANAESAAIGSADSELDVVAQGDIQESTTSGAGAA-AAGGDAAAPAEKKE-KSDEDMGF +VM---------------------------------------------------------- +----------------------WC------------------------------- >Penicillium_subrubescens_GCA_001908125.1|EOG091N44M8 -HAANESSASIESADSELEVVAQGNLQDASTSGAGGAAAAGGAAEAPAAKE-KSDDDMGFG -L----------------------------------------------------------- --------FD------------------------------- +HAANESSASIESADSELEVVAQGNLQDASTSGAGGAGAAAGGAAEAPAAKE-KSDDDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- >Penicillium_verrucosum_GCA_000970515.2|EOG091N44M8 -YAATEATSAIASAEGDLEVISQGDLQESSASG-GAAAAAGGAEAPAEKVK-ESDEDMGFG -ISEYVGISPSNYAKIIDQYSHDDKKERVIIGAHVAAREMPDAISIRKIAKIVKVVGGMSD -PYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI +YAATEATSAIASAEGDLEVISQGDLQESSASG-GAA-AAAGGAEAPAEKVK-ESDEDMGF +GISEYVGISMPPSNYPLVDIPVDFENDAKIIDQYSHDDKKERVIIGAHVAAREMPDAISI +RKIAKIVKVVGGMSDPYTITAIFDSIQEAARETIELMEYYIAMTSADQAMIGASI >Penicillium_vulpinum_GCA_002072255.1|EOG091N44M8 -YAANEASAAIASAEGDLDVISQGDLQQASTSGAGAAAGGAAAAAPAEKEK-ESDEDMGFG -L----------------------------------------------------------- --------FD------------------------------- +YAANEASAAIASAEGDLDVISQGDLQQASTSGAGAA-AGGAAAAAPAEKEK-ESDEDMGF +GL---------------------------------------------------------- +----------------------FD------------------------------- diff --git a/tests/integration/expected/EOG091N44M8_nt.clipkit_kpi_smart_gaps b/tests/integration/expected/EOG091N44M8_nt.clipkit_kpi_smart_gaps index 564d519..5cf7a3a 100644 --- a/tests/integration/expected/EOG091N44M8_nt.clipkit_kpi_smart_gaps +++ b/tests/integration/expected/EOG091N44M8_nt.clipkit_kpi_smart_gaps @@ -1,1404 +1,1521 @@ >200_S38|EOG091N44M8 ttcctcccccccctccctgaggcccactccgcccagcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgct---gtccctctctccgctgccgtg -tccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatactct -cttctctcccgcgtacctccccctcttactaaagctacagatacgcccattatatgaact -ggttgtaaatggcgctctcaaccagcactaacacaactgtcgtcgccgccccatcattaa -cacccgcgggatgaacctgccttccagccatcgatgcgtcacctgaactcgaatggtttg -ggggtgcctgccagtaaggtgttggcgggatgtgagccttgttcgccacgtattacccta -tacggttgctttacgttcgattagctcttgacttcggcgctactactccttgataggggc -ccgaccatctaggaacgacatctccttcgtccacgtgcagttcatgccgcctagcccgat -ccttgttagttttgatcttttacttccgtaggtagcctattcttttgactcgtagtcgcc -agtcgtcactgcaaggtgcagcgtttcccccgatg +gcactcccggccggagcgctccttgccctctccgct---gtccctctct---ccgctgcc +gtgtccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatac +tctcttctctcccgcgtacctccccccaatgcatcttactacccgtcccaagtggactgc +aagtaagctacagatacgcccattatatgaactggttgtaaatggcgctctcaaccagca +ctaacacaactgtcgtcgccgccccatcattaacacccgcgggatgaacctgccttccag +ccatcgatgcgtcacctgaactcgaatggtttgggggtgcctgccagtaaggtgttggcg +ggatgtgagccttgttcgccacgtattaccctatacggttgctttacgttcgattagctc +ttgacttcggcgctactactccttgataggggcccgaccatctaggaacgacatctcctt +cgtccacgtgcagttcatgccgcctagcccgatccttgttagttttgatcttttacttcc +gtaggtagcctattcttttgactcgtagtcgccagtcgtcactgcaaggtgcagcgtttc +ccccgatg >203_S40|EOG091N44M8 ttcctcccccccctccctgaggcccactccgcccagcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgct---gtccctctctccgctgccgtg -tccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatactct -cttctctcccgcgtacctccccctcttactaaagctacagatacgcccattatatgaact -ggttgtaaatggcgctctcaaccagcactaacacaactgtcgtcgccgccccatcattaa -cacccgcgggatgaacctgccttccagccatcgatgcgtcacctgaactcgaatggtttg -ggggtgcctgccagtaaggtgttggcgggatgtgagccttgttcgccacgtattacccta -tacggttgctttacgttcgattagctcttgacttcggcgctactactccttgataggggc -ccgaccatctaggaacgacatctccttcgtccacgtgcagttcatgccgcctagcccgat -ccttgttagttttgatcttttacttccgtaggtagcctattcttttgactcgtagtcgcc -agtcgtcactgcaaggtgcagcgtttcccccgatg +gcactcccggccggagcgctccttgccctctccgct---gtccctctct---ccgctgcc +gtgtccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatac +tctcttctctcccgcgtacctccccccaatgcatcttactacccgtcccaagtggactgc +aagtaagctacagatacgcccattatatgaactggttgtaaatggcgctctcaaccagca +ctaacacaactgtcgtcgccgccccatcattaacacccgcgggatgaacctgccttccag +ccatcgatgcgtcacctgaactcgaatggtttgggggtgcctgccagtaaggtgttggcg +ggatgtgagccttgttcgccacgtattaccctatacggttgctttacgttcgattagctc +ttgacttcggcgctactactccttgataggggcccgaccatctaggaacgacatctcctt +cgtccacgtgcagttcatgccgcctagcccgatccttgttagttttgatcttttacttcc +gtaggtagcctattcttttgactcgtagtcgccagtcgtcactgcaaggtgcagcgtttc +ccccgatg >206_S41|EOG091N44M8 tccctcccccccctctacgagtccctctccgcccagcccctcccccccctgggtccccgg -gcgctcccggcacgagcgtgtttcaccccttccgttgctccct-----cccgctcccccg -cgtctctccgtagaagaagaag--agtccgatggacatgctcggaactcacgaatactct -ctcttcccccgcgtacctcccc------------------gcccacccgccacggtcgcg -agctagcgctctaagtcgtcgtccgttaacgggcgctgcgtgtcccagtcaggcaggcta -cctgtaaaacgccgaagcatacctgtctgaacggtgtcccccaggagggagaactgctct -actgtgctcgcggactgggtattgatggtaaatgagtactctccatcgtgaatcacttta -catagccaccccagttttgactagcagcaaactcgagcggcgtagtggccttcaaagggc -gagaatcccgataaatagatcgttccccgcccccgagctgcctgcccccttccccctgag -cttctctcgtcttttctccctgcccccttgggctacccattgagacggtcaactatctag -aatagagaaaatggagcgccatgctctttcctcgc +gcgctcccggcacgagcgtgtttcaccccttccgttgctccct-----c---ccgctccc +ccgcgtctctccgtagaagaagaag--agtccgatggacatgctcggaactcacgaatac +tctctcttcccccgcgtacctcccc----------------------------------- +-------------gcccacccgccacggtcgcgagctagcgctctaagtcgtcgtccgtt +aacgggcgctgcgtgtcccagtcaggcaggctacctgtaaaacgccgaagcatacctgtc +tgaacggtgtcccccaggagggagaactgctctactgtgctcgcggactgggtattgatg +gtaaatgagtactctccatcgtgaatcactttacatagccaccccagttttgactagcag +caaactcgagcggcgtagtggccttcaaagggcgagaatcccgataaatagatcgttccc +cgcccccgagctgcctgcccccttccccctgagcttctctcgtcttttctccctgccccc +ttgggctacccattgagacggtcaactatctagaatagagaaaatggagcgccatgctct +ttcctcgc >207_S42|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga------------ -----------aaactattcc---------------------------------------- +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga--------- +-------------aaactattcc------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >209_S43|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >212_S45|EOG091N44M8 ccccaccctgcctgccacgccgagctcgccgcctaggccctccccttcctctctgcccgc -gcgcgtccggacggagtgctctataccccttccgttgctgtctcccc--ctgctggtgta -cccctccccgtagaagaagggg--agtccgatggacatgctcggttgt------------ -----a------------------------------------------------------- +gcgcgtccggacggagtgctctataccccttccgttgctgtctcccc-----ctgctggt +gtacccctccccgtagaagaagggg--agtccgatggacatgctcggttgt--------- +-------a---------------------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------accggc------ ------------------------------------------------------------ ----------------accggc--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >215_S46|EOG091N44M8 ttcctcccccccctccctgaggcccactccgcccagcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgct---gtccctctctccgctgccgtg -tccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatactct -cttctctcccgcgtacctccccctcttactaaagctacagatacgcccattatatgaact -ggttgtaaatggcgctctcaaccagcactaacacaactgtcgtcgccgccccatcattaa -cacccgcgggatgaacctgccttccagccatcgatgcgtcacctgaactcgaatggtttg -ggggtgcctgccagtaaggtgttggcgggatgtgagccttgttcgccacgtattacccta -tacggttgctttacgttcgattagctcttgacttcggcgctactactccttgataggggc -ccgaccatctaggaacgacatctccttcgtccacgtgcagttcatgccgcctagcccgat -ccttgttagttttgatcttttacttccgtaggtagcctattcttttgactcgtagtcgcc -agtcgtcactgcaaggtgcagcgtttcccccgatg +gcactcccggccggagcgctccttgccctctccgct---gtccctctct---ccgctgcc +gtgtccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatac +tctcttctctcccgcgtacctccccccaatgcatcttactacccgtcccaagtggactgc +aagtaagctacagatacgcccattatatgaactggttgtaaatggcgctctcaaccagca +ctaacacaactgtcgtcgccgccccatcattaacacccgcgggatgaacctgccttccag +ccatcgatgcgtcacctgaactcgaatggtttgggggtgcctgccagtaaggtgttggcg +ggatgtgagccttgttcgccacgtattaccctatacggttgctttacgttcgattagctc +ttgacttcggcgctactactccttgataggggcccgaccatctaggaacgacatctcctt +cgtccacgtgcagttcatgccgcctagcccgatccttgttagttttgatcttttacttcc +gtaggtagcctattcttttgactcgtagtcgccagtcgtcactgcaaggtgcagcgtttc +ccccgatg >220_S48|EOG091N44M8 tccctcccccccctctacgagtccctctccgcccagcccctcccccccctgggtccccgg -gcgctcccggcacgagcgtgtttcaccccttccgttgctccct-----cccgctcccccg -cgtctctccgtagaagaagaag--agtccgatggacatgctcggtctc------------ +gcgctcccggcacgagcgtgtttcaccccttccgttgctccct-----c---ccgctccc +ccgcgtctctccgtagaagaagaag--agtccgatggacatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >231_51|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >232-S52|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >236_53|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga------------ -----------aaactattcc---------------------------------------- +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga--------- +-------------aaactattcc------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >244-S54|EOG091N44M8 ccccatccactcctccacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gtgcgtgcgaccggagcgctcttcaccccctcgcctggtgtctctctc-ctgccggagtc -tccccccccgtagaagaagggg--agtccgatggacatgctcggtctc------------ +gtgcgtgcgaccggagcgctcttcaccccctcgcctggtgtctctctc----ctgccgga +gtctccccccccgtagaagaagggg--agtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >245_S55|EOG091N44M8 ttcctcccccccctccctgaggcccactccgcccagcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgct---gtccctctctccgctgccgtg -tccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatactct -cttctctcccgcgtacctccccctcttactaaagctacagatacgcccattatatgaact -ggttgtaaatggcgctctcaaccagcactaacacaactgtcgtcgctgccccatcattaa -cccccgcgggatgaacctgccttccagccatcgatgcgtcacctgaactcgaatggtttg -ggggtgcctgcgggtaaggtgttggcgggatgtgagccttgttcgccacgtattacccta -tacggttgctttacgttcgattagctcttgactccggcgctactactccttgatgggggc -ccgaccatctaggaacgacatctccttcgtccacgtgcagttcatgccgcctagcccgat -ccttgttagttttgatcttttacttccgtaggtagcctattcttttgactcgtagtcgcc -agtcgtcactgcaaggtgcagcgtttcccccgatg +gcactcccggccggagcgctccttgccctctccgct---gtccctctct---ccgctgcc +gtgtccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatac +tctcttctctcccgcgtacctccccccaatgcatcttactacccgtcccaagtggactgc +aagtaagctacagatacgcccattatatgaactggttgtaaatggcgctctcaaccagca +ctaacacaactgtcgtcgctgccccatcattaacccccgcgggatgaacctgccttccag +ccatcgatgcgtcacctgaactcgaatggtttgggggtgcctgcgggtaaggtgttggcg +ggatgtgagccttgttcgccacgtattaccctatacggttgctttacgttcgattagctc +ttgactccggcgctactactccttgatgggggcccgaccatctaggaacgacatctcctt +cgtccacgtgcagttcatgccgcctagcccgatccttgttagttttgatcttttacttcc +gtaggtagcctattcttttgactcgtagtcgccagtcgtcactgcaaggtgcagcgtttc +ccccgatg >247_s46|EOG091N44M8 ccccatccgctcccctacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gcgcgttcgaccggaccgctcttcaccccctcgcctggtgtctctccc-ctgccggtgtc -cccccctccgtagaagaagggg--agtccgacggacatgctcggcttc------------ +gcgcgttcgaccggaccgctcttcaccccctcgcctggtgtctctccc----ctgccggt +gtccccccctccgtagaagaagggg--agtccgacggacatgctcggcttc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------aaaatg------ ------------------------------------------------------------ ----------------aaaatg--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >250_S57|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >252_S58|EOG091N44M8 ccccatccgctcccctacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gcgcgttcgaccggaccgctcttcaccccctcgcctggtgtctctccc-ctgccggtgtc -cccccctccgtagaagaagggg--agtccgacggatatgctcggctcc------------ +gcgcgttcgaccggaccgctcttcaccccctcgcctggtgtctctccc----ctgccggt +gtccccccctccgtagaagaagggg--agtccgacggatatgctcggctcc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------aaaatg------ ------------------------------------------------------------ ----------------aaaatg--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >256_S59|EOG091N44M8 ccccatccgctcccctacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gcgcgtgcgaccggaccgctcttcaccccctcgcctggtgtctctccc-ctgccggtgtc -cccccctccgtagaagaagggg--agtccgacggacatgctcggtctc------------ +gcgcgtgcgaccggaccgctcttcaccccctcgcctggtgtctctccc----ctgccggt +gtccccccctccgtagaagaagggg--agtccgacggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >257_S60|EOG091N44M8 ttctccctgcccccccacgaggccctcgccgcctagctcctcccctccctgggtccgcgg -gcactccaagccggtgcgctccttgccctctccgtcggtctctctctctccgctgccgtg -tccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatactct -tctctcttctgcgtacctccttt-----------------ctatacccgccacatgagcg -ggttgcaaatggcgcggccgaccaggatcaatatggtagccatcgccacctaaccattag -cctgcgcgggatgattccgtctccgggtcattgacgtgtcatccgagcccgaatatcttt -gtggtgtccgcggatgggtaatccaggcaaacctaatctcattcgacgtggatcgatccc -tgcggttattctgcatttgacaaactgctgattaagaagccattactcttaggttgaggt -ccagccactcatggatggtttccccttcgtattcacactccttatgcgctcgagctcgat -tcttgtcagtcctgaccttttaccctcgcggacagtttatttttttaactcgtagtcctg -ggcaaagacgctaaagcatagcatgtccctcgatg +gcactccaagccggtgcgctccttgccctctccgtcggtctctctctct---ccgctgcc +gtgtccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatac +tcttctctcttctgcgtacctccttt---------------------------------- +-------------ctatacccgccacatgagcgggttgcaaatggcgcggccgaccagga +tcaatatggtagccatcgccacctaaccattagcctgcgcgggatgattccgtctccggg +tcattgacgtgtcatccgagcccgaatatctttgtggtgtccgcggatgggtaatccagg +caaacctaatctcattcgacgtggatcgatccctgcggttattctgcatttgacaaactg +ctgattaagaagccattactcttaggttgaggtccagccactcatggatggtttcccctt +cgtattcacactccttatgcgctcgagctcgattcttgtcagtcctgaccttttaccctc +gcggacagtttatttttttaactcgtagtcctgggcaaagacgctaaagcatagcatgtc +cctcgatg >258_S61|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga------------ -----------aaactattct---------------------------------------- +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga--------- +-------------aaactattct------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >259_S62|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctccccaccctgggtctccgg -gcacgcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >261_S63|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga------------ -----------aaactacgtg---------------------------------------- +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga--------- +-------------aaactacgtg------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >262_S64|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >267_S66|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctccccaccctgggtctccgg -gcacgcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >269_S67|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >271_S68|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccatcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga------------ -----------aaactattct---------------------------------------- +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga--------- +-------------aaactattct------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >274_S69|EOG091N44M8 ccccatccgctcccctacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gcgcgtgcgaccggaccgctcttcaccccctcgcctggtgtctctccc-ctgccggtgtc -cccccctccgtagaagaagggg--agtccgacggacatgctcggcttt------------ +gcgcgtgcgaccggaccgctcttcaccccctcgcctggtgtctctccc----ctgccggt +gtccccccctccgtagaagaagggg--agtccgacggacatgctcggcttt--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------tttgtc------ ------------------------------------------------------------ ----------------tttgtc--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >275_S70|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >276_S71|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >277_S72|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga------------ -----------aaactattcc---------------------------------------- +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga--------- +-------------aaactattcc------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >278_S73|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga------------ -----------aaactattcc---------------------------------------- +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga--------- +-------------aaactattcc------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >280_S74|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >284_S76|EOG091N44M8 ccccatccactcctccacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gtgcgtgcgaccggagcgctcttcaccccctcgcctggtgtctctctc-ctgccggagtc -tccccccccgtagaagaagggg--agtccgatggacatgctcggcttc------------ +gtgcgtgcgaccggagcgctcttcaccccctcgcctggtgtctctctc----ctgccgga +gtctccccccccgtagaagaagggg--agtccgatggacatgctcggcttc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------gtagga------ ------------------------------------------------------------ ----------------gtagga--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >285_S77|EOG091N44M8 ccccatccgctcccctacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gcgcgttcgaccggaccgctcttcaccccctcgcctggtgtctctccc-ctgccggtgtc -cccccctccgtagaagaagggg--agtccgacggacatgctcggtctc------------ +gcgcgttcgaccggaccgctcttcaccccctcgcctggtgtctctccc----ctgccggt +gtccccccctccgtagaagaagggg--agtccgacggacatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >288_S78|EOG091N44M8 tccctcccccccctctacgagtccctctccgcccagcccctcccccccctgggtccccgg -gcgctcccggcacgagcgtgtttcaccccttccgttgctccct-----cccgctcccccg -cgtctctccgtagaagaagaag--agtccgatggacatgctcggtctc------------ +gcgctcccggcacgagcgtgtttcaccccttccgttgctccct-----c---ccgctccc +ccgcgtctctccgtagaagaagaag--agtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >289_S79|EOG091N44M8 ccccatccgctcccctacgagtccctcgccgcccagctcctcccctctctcagcgcccgg -gcgcgtgcgaccggaccgctcttcaccccctcgcctggtgtctctccc-ctgccggtgtc -cccccctccgtagaagaagggg--agtccgacggacatgctcggcttt------------ +gcgcgtgcgaccggaccgctcttcaccccctcgcctggtgtctctccc----ctgccggt +gtccccccctccgtagaagaagggg--agtccgacggacatgctcggcttt--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------tttgtc------ ------------------------------------------------------------ ----------------tttgtc--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Aspergillus_fumigatus_Af293_GCF_000002655.1|EOG091N44M8 ccccctccccccctctacacctccgtctctgagtggcccctctctcttcctgaggccgac -ccatgtcgggccggagcccgcttcaccctttccgttgctccccctttctccgctgccgtg -tctctctctgtagaagaagggg--agtccgacggacatgctcggtctt------------ +ccatgtcgggccggagcccgcttcaccctttccgttgctccccctttctcgtccgctgcc +gtgtctctctctgtagaagaagggg--agtccgacggacatgctcggtctt--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Aspergillus_niger_GCF_000002855.3|EOG091N44M8 tccccccctggcctctacaacaccctcgctgagcatcccctccccctcctggaggccccg -ccctgttgggccggagccctctaccagctttccgttgccgtccctcctcgtggcgccctc -tctagctccgtagaagaagggg--ggtccgatggacatgctcggtctc------------ +ccctgttgggccggagccctctaccagctttccgttgccgtccctcctc---gtggcgcc +ctctctagctccgtagaagaagggg--ggtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Aspergillus_oryzae_RIB40_GCF_000184455.2|EOG091N44M8 ccctctccccccccctactccaccctcgttgagcaagctctctcctttcctgaggccccg -gcactccgggccgcagcgcattacgagctttccgttgctgtccctctttccgctgccgtg -t--acccccgtag---aaggag--agtccgatggacatgctcggtctc------------ +gcactccgggccgcagcgcattacgagctttccgttgctgtccctctttcgtccgctgcc +gtgt--acccccgtag---aaggag--agtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_antarcticum_GCA_002072345.1|EOG091N44M8 tccctccctcccctccacgagaccctcgctgcccatcccctcccctccctgggtctctgc -gcacgtcggaccggagccctccttaccccttccgttgctgtctcctcccccgctgccgtg -tccctctccgtagaagaagggattggtccgatggacatgatcggactc------------ +gcacgtcggaccggagccctccttaccccttccgttgctgtctcctccc---ccgctgcc +gtgtccctctccgtagaagaagggattggtccgatggacatgatcggactc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_biforme_FM169_GCA_000577785.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_brasilianum_GCA_000769745.1|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctattttcc--------------- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctattttcc------------------------------------------ +-------- >Penicillium_brasilianum_GCA_001048715.1|EOG091N44M8 ccccatccccccccctacgagtctctcgtctcccagagtctcccccccctctccgcccgg -gtgcgtccgaccggaccgcgtttcgccccctccgttgccgtctctccctctgccgctgtg -tccccaggtccccgccaagggg--agtccgacggacatgatcggtctc------------ +gtgcgtccgaccggaccgcgtttcgccccctccgttgccgtctctccct---ctgccgct +gtgtccccaggtccccgccaagggg--agtccgacggacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_brasilianum_GCA_002016555.1|EOG091N44M8 ccccatccccccccctacgagtctctcgtctcccagagcctcccccccctctccgcccgg -gtgcgtccgaccggaccgcgtttcgccccttccgttgccgtctctccctctgccgctgtg -tccccaggtccccgccaagggg--agtccgacggacatgatcggtctc------------ +gtgcgtccgaccggaccgcgtttcgccccttccgttgccgtctctccct---ctgccgct +gtgtccccaggtccccgccaagggg--agtccgacggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_brasilianum_GCA_004916855.1|EOG091N44M8 ccccatccccccccctacgagtctctcgtctcccagagcctcccccccctctccgcccgg -gtgcgtccgaccggaccgcgtttcgccccttccgttgccgtctctccctctgccgctgtg -tccccaggtccccgccaagggg--agtccgacggacatgatcggtctc------------ +gtgcgtccgaccggaccgcgtttcgccccttccgttgccgtctctccct---ctgccgct +gtgtccccaggtccccgccaagggg--agtccgacggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_camemberti_FM_013_GCA_000513335.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_capsulatum_GCA_000943765.1|EOG091N44M8 tccctccctcccctccacgagtccctcgctgcccatcccctccccctcctgggtctctgc -gcacgtcggaccggagcgctcctcaccccttccgttggtctctctctccccgccgccgtg -tccccctccgtagaagaagggattggtccgatggacatgatcggactc------------ +gcacgtcggaccggagcgctcctcaccccttccgttggtctctctctcc---ccgccgcc +gtgtccccctccgtagaagaagggattggtccgatggacatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_capsulatum_GCA_000943775.1|EOG091N44M8 tccctccctcccctccacgagtccctcgctgcccatcccctccccctcctgggtctctgc -gcacgtcggaccggagcgctcctcaccccttccgttggtctctctctccccgccgccgtg -tccccctccgtagaagaagggattggtccgatggacatgatcggactc------------ +gcacgtcggaccggagcgctcctcaccccttccgttggtctctctctcc---ccgccgcc +gtgtccccctccgtagaagaagggattggtccgatggacatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_chrysogenum_GCA_000710275.1|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_chrysogenum_GCA_000801355.1|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_chrysogenum_GCA_002080375.1|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_chrysogenum_KF-25_GCA_000816005.1|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_chrysogenum_NCPC10086_GCA_000523475.1|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_chrysogenum_NCPC10086_GCA_001773325.1|EOG091N44M8 tccctccctcccctccacgagaccctcgctgcccatcccctcccccccctgggtctctgc -gcacgtcggaccggagcgctcctcaccccttccgttggtgtctctccccccgccgccgtg -tccccctccgtagaagaagggaagggtccgacggacatgatcggactc------------ +gcacgtcggaccggagcgctcctcaccccttccgttggtgtctctcccc---ccgccgcc +gtgtccccctccgtagaagaagggaagggtccgacggacatgatcggactc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_citrinum_GCA_001399475.1|EOG091N44M8 ccccaccctgcctgccacgccgagctcgccgcctaggccctccccttcctctctgcccgc -gcgcgtccggacggagtgctctataccccttccgttgctgtctcccc--ctgctggtgta -cccctccccgtagaagaagggg--agtccgatggacatgctcggtctc------------ +gcgcgtccggacggagtgctctataccccttccgttgctgtctcccc-----ctgctggt +gtacccctccccgtagaagaagggg--agtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_citrinum_GCA_001950535.1|EOG091N44M8 ccccaccctgcctgccacgccgagctcgccgcctaggccctccccttcctctctgcccgc -gcgcgtccggacggagtgctctataccccttccgttgctgtctcccc--ctgctggtgta -cccctccccgtagaagaagggg--agtccgatggacatgctcggtctc------------ +gcgcgtccggacggagtgctctataccccttccgttgctgtctcccc-----ctgctggt +gtacccctccccgtagaagaagggg--agtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_commune_162_3FA|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_coprophilum_GCA_002072405.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcctagctcctcccccccctgggtctccgg -gcactcccggccggagcgcgtcttaccctttccgctgctgtctctctctccgctgccgtg -tccccctccgtagaaggtcgga--ggtccgatggatatgctcggtctc------------ +gcactcccggccggagcgcgtcttaccctttccgctgctgtctctctct---ccgctgcc +gtgtccccctccgtagaaggtcgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_decumbens_GCA_000226395.1|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_decumbens_GCA_002072245.1|EOG091N44M8 tcccctccccgccgctacgagtctctcgccgcccaggccctcccctctccctccgcccgc -ccacgtccgaccggagcgcgcttcaccccttcccttgctgtccctctccctgccggtgtc -cctacctccgtag---aagggg--agtccgatcgacatgattggtctc------------ +ccacgtccgaccggagcgcgcttcaccccttcccttgctgtccctctcc---ctgccggt +gtccctacctccgtag---aagggg--agtccgatcgacatgattggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_digitatum_Pd01-ZJU_GCA_000485865.1|EOG091N44M8 tcccccccgcccctctacgaggccctttccgaccagcccctccccctcctgggtctccgg -gcactcccggccggagcgctccttgccctctccgcttctccctctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatgtct -cctttttctcacgtacctcccc------------------gtccattcactatatgagct -gatctcaaacagagcagtcaaccgacatcaatacggcggccggtgtcgctccatcattca -tttgcacgggacgaatctgccatcgggtcgtcgatacgttacttagattcaaatggttcc -gtgccattcgcagatgagttactcgtagagagcgcgtcttattagccgtagaccacccta -taagtttgctttaattttgataggttgctgcctcagatgccaccactcggcgcgaggcgc -ccggccacctctaggcagcgactttttcgcgtatatgtagatcgtgtcgtctcgctcggt -ccttgccgattttgacccctcgtatctgtgaatagcctgtcttct--------------- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgcttctccctctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatg +tctcctttttctcacgtacctcccc----------------------------------- +-------------gtccattcactatatgagctgatctcaaacagagcagtcaaccgaca +tcaatacggcggccggtgtcgctccatcattcatttgcacgggacgaatctgccatcggg +tcgtcgatacgttacttagattcaaatggttccgtgccattcgcagatgagttactcgta +gagagcgcgtcttattagccgtagaccaccctataagtttgctttaattttgataggttg +ctgcctcagatgccaccactcggcgcgaggcgcccggccacctctaggcagcgacttttt +cgcgtatatgtagatcgtgtcgtctcgctcggtccttgccgattttgacccctcgtatct +gtgaatagcctgtcttct------------------------------------------ +-------- >Penicillium_digitatum_PDC_102_GCA_001307865.1|EOG091N44M8 tcccccccgcccctctacgaggccctttccgaccagcccctccccctcctgggtctccgg -gcactcccggccggagcgctccttgccctctccgcttctccctctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatgtct -cctttttctcacgtacctccccccctcaaggagtcc----ttccattcactatatgagct -gatctcaaacagagcagtcaaccgacatcaatacggcggccggtgtcgctccatcattca -tttgcacgggacgaatctgccatcgggtcgtcgatacgttacttagattcaaatggttcc -gtgccatccgcagatgagttactcgtagagagcgcgtcttattagccgtagaccacccta -taagtttgctttaattttgataggttgctgcctcagatgccaccactcggcgcgaggcgc -ccggccacctctaggcagcgactttttcgcgtatatgtagatcgtgtcgtctcgctcggt -ccttgccgattttgacccctcgtatctgtgaatagcctgtcttcttgattcgtagccgta -agttgcggcactaa--------------------- +gcactcccggccggagcgctccttgccctctccgcttctccctctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatg +tctcctttttctcacgtacctccccc-------cctcaagg------------------- +----agtcc----ttccattcactatatgagctgatctcaaacagagcagtcaaccgaca +tcaatacggcggccggtgtcgctccatcattcatttgcacgggacgaatctgccatcggg +tcgtcgatacgttacttagattcaaatggttccgtgccatccgcagatgagttactcgta +gagagcgcgtcttattagccgtagaccaccctataagtttgctttaattttgataggttg +ctgcctcagatgccaccactcggcgcgaggcgcccggccacctctaggcagcgacttttt +cgcgtatatgtagatcgtgtcgtctcgctcggtccttgccgattttgacccctcgtatct +gtgaatagcctgtcttcttgattcgtagccgtaagttgcggcactaa------------- +-------- >Penicillium_digitatum_PHI26_GCA_000315665.1|EOG091N44M8 tcccccccgcccctctacgaggccctttccgaccagcccctccccctcctgggtctccgg -gcactcccggccggagcgctccttgccctctccgcttctccctctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatgtct -cctttttctcacgtacctcccc------------------gtccattcactatatgagct -gatctcaaacagagcagtcaaccgacatcaatacggcggccggtgtcgctccatcattca -tttgcacgggacgaatctgccatcgggtcgtcgatacgttacttagattcaaatggttcc -gtgccatccgcagatgagttactcgtagagagcgcgtcttattagccgtagaccacccta -taagtttgctttaattttgataggttgctgcctcagatgccaccactcggcgcgaggcgc -ccggccacctctaggcagcgactttttcgcgtatatgtagatcgtgtcgtctcgctcggt -ccttgccgattttgacccctcgtatctgtgaatagcctgtcttcttgattcgtagccgta -agttgcggcactaa--------------------- +gcactcccggccggagcgctccttgccctctccgcttctccctctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatg +tctcctttttctcacgtacctcccc----------------------------------- +-------------gtccattcactatatgagctgatctcaaacagagcagtcaaccgaca +tcaatacggcggccggtgtcgctccatcattcatttgcacgggacgaatctgccatcggg +tcgtcgatacgttacttagattcaaatggttccgtgccatccgcagatgagttactcgta +gagagcgcgtcttattagccgtagaccaccctataagtttgctttaattttgataggttg +ctgcctcagatgccaccactcggcgcgaggcgcccggccacctctaggcagcgacttttt +cgcgtatatgtagatcgtgtcgtctcgctcggtccttgccgattttgacccctcgtatct +gtgaatagcctgtcttcttgattcgtagccgtaagttgcggcactaa------------- +-------- >Penicillium_expansum_GCA_000688875.1|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctactttcctgacccgtagctgt- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctactttcctgacccgtagctgt---------------------------- +-------- >Penicillium_expansum_GCA_000769735.1|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctattttcc--------------- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctattttcc------------------------------------------ +-------- >Penicillium_expansum_GCA_000769755.1|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctattttcctgacccgtagctgt- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctattttcctgacccgtagctgt---------------------------- +-------- >Penicillium_expansum_GCA_001750045.2|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctattttcctgacccgtagctgt- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctattttcctgacccgtagctgt---------------------------- +-------- >Penicillium_expansum_GCA_004302965.1|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctactttcctgacccgtagctgt- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctactttcctgacccgtagctgt---------------------------- +-------- >Penicillium_expansum_NRRL_62431_GCA_000584915.1|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctattttcctgacccgtagctgt- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctattttcctgacccgtagctgt---------------------------- +-------- >Penicillium_expansum_T01_GCA_001008385.1|EOG091N44M8 ttccccccgcccctccacgaggccctcgccgcccagcccctcccccccttgggtctgcgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatactcc -cctttcccccgcgtacctcccccatagggggcgttactctatacaccaacctcatgagtt -ggtcgtaaacggcgcagccaaccagcatcaatacggcggtcgtcgccgcctcatcattaa -cttgcacgggatgaacccgcatttgggtaatccatgcgtcacctgaactcggctggtttg -ttagtatctacggatgagttattggtggaatgtgagctttgtccgctgtggttcacccta -tacggttactttacctttgactaatcgttcacctagacaccactactcccagcgagagtc -ccggccacctatggacagtatctcctttgtttacatgcagcccatgccgtctcgaccgat -tcctgtcggctttaaccctttacttccgtggatagtctattttcc--------------- ------------------------------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtctccctccgtagaaggttgga--ggtccgatggacatgctcggaataatggaatac +tcccctttcccccgcgtacctccccctttctatatagggggaaaccggtcgtgccgacca +tccacgttactctatacaccaacctcatgagttggtcgtaaacggcgcagccaaccagca +tcaatacggcggtcgtcgccgcctcatcattaacttgcacgggatgaacccgcatttggg +taatccatgcgtcacctgaactcggctggtttgttagtatctacggatgagttattggtg +gaatgtgagctttgtccgctgtggttcaccctatacggttactttacctttgactaatcg +ttcacctagacaccactactcccagcgagagtcccggccacctatggacagtatctcctt +tgtttacatgcagcccatgccgtctcgaccgattcctgtcggctttaaccctttacttcc +gtggatagtctattttcc------------------------------------------ +-------- >Penicillium_expansum_YT02_GCA_002072455.1|EOG091N44M8 ccccacccccccctctacgagtcccttgcctctcagagcctccccctcctctccgcccgg -gtgcttccgaccggactgcttttctccctttccgccgct----ctcctcccgctgccgtg -tctctaggcccccgccaagggg--agtccgaccgacatgatcggactc------------ +gtgcttccgaccggactgcttttctccctttccgccgct----ctcctctccccgctgcc +gtgtctctaggcccccgccaagggg--agtccgaccgacatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_flavigenum_GCA_002072365.1|EOG091N44M8 ttccctccgcccctccacgaggccctcgccgcccagatcctcccctccctggctctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_freii_GCA_001513925.1|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccatcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_fuscoglaucum_FM041_GCA_000576735.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga------------ -----------aaactattcc---------------------------------------- +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga--------- +-------------aaactattcc------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_griseofulvum_GCA_001561935.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgactagctcctcccctctctgggtctccgg -gcactcccggccggagcgcgtcttacctttaccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggtcgga--ggtccgatggatatgctcggtctc------------ +gcactcccggccggagcgcgtcttacctttaccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggtcgga--ggtccgatggatatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_griseofulvum_GCA_001735785.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgactagctcctcccctctctgggtctccgg -gcactcccggccggagcgcgtcttacctttaccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggtcgga--ggtccgatggatatgctcggtctc------------ +gcactcccggccggagcgcgtcttacctttaccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggtcgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_italicum_GCA_000769765.1|EOG091N44M8 ttccccccgcccctccacgaggccctctccgcccagcccctccccttcctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggacatgctcggtctc------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_italicum_GCA_001008395.1|EOG091N44M8 ttccccccgcccctccacgaggccctctccgcccagcccctccccttcctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggaggga--ggtccgatggacatgctcggaatagtcgaatactcc -ccttcctcccgcgcacctccccc-----------------gcacatacgccacatgagct -ggtctcgaacggcgtagccaaccgggatcaatacggtggtcattgccgccccatctttaa -cttgcgcgggatgaatctaccctcgagtcattgatgcgccagctgaactcgactggtttg -gtggagtttgcggatgagttattgatgggatgtgagtcttgttcgccgtgaatcaatcta -tatggacactttactttcgactagccgctcacttagacgccactactcccagcgagaggc -ccggacacccctggacggcatcttattcgtttacaagcagcccgcgttatttcgctcgat -acctaccggttcttaccttttactcccttggacagctcattttcctgtcttgtagccgtc -aaccgcgacgataaagcgaagtgtttcccttggtg +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggaggga--ggtccgatggacatgctcggaatagtcgaatac +tccccttcctcccgcgcacctccccc---------------------------------- +-------------gcacatacgccacatgagctggtctcgaacggcgtagccaaccggga +tcaatacggtggtcattgccgccccatctttaacttgcgcgggatgaatctaccctcgag +tcattgatgcgccagctgaactcgactggtttggtggagtttgcggatgagttattgatg +ggatgtgagtcttgttcgccgtgaatcaatctatatggacactttactttcgactagccg +ctcacttagacgccactactcccagcgagaggcccggacacccctggacggcatcttatt +cgtttacaagcagcccgcgttatttcgctcgatacctaccggttcttaccttttactccc +ttggacagctcattttcctgtcttgtagccgtcaaccgcgacgataaagcgaagtgtttc +ccttggtg >Penicillium_italicum_GCA_002116305.1|EOG091N44M8 ttccccccgcccctccacgaggccctctccgcccagcccctccccttcctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggacatgctcggtctc------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggacatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_janthinellum_GCA_002369805.1|EOG091N44M8 ccccattcccccccctacgagtcccttgcctcccagagcctcctcctcctctccccccgg -gcgtgtccgaccggaccgcgtttcgccctctccgctgctgtgtctccctctgccgctgcg -tccccaggtcccagccaagggg--agtccgacggacatgctcggtctc------------ +gcgtgtccgaccggaccgcgtttcgccctctccgctgctgtgtctcccttgtctgccgct +gcgtccccaggtcccagccaagggg--agtccgacggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_nalgiovense_FM193_GCA_000577395.2|EOG091N44M8 ttccccccgcccctccacgaggccctcaccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_nalgiovense_GCA_002072425.1|EOG091N44M8 ttccccccgcccctccacgaggccctcaccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_nordicum_GCA_000315645.2|EOG091N44M8 tcccccccgcccctctacgaggccctttccgaccagcccctccccctcctgggtctccgg -gcactcccggccggagcgctccttgccctctccgcttctccctctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatgtct -cctttttctcacgtacctcccc------------------gtccattcactatatgagct -gatctcaaacagagcagtcaaccgacatcaatacggcggccggtgtcgctccatcattca -tttgcacgggacgaatctgccatcgggtcgtcgatacgttacttagattcaaatggttcc -gtgccatccgcagatgagttactcgtagagagcgcgtcttattagccgtagaccacccta -taagtttgctttaattttgataggttgctgcctcagatgccaccactcggcgcgaggcgc -ccggccacctctaggcagcgactttttcgcgtatatgtagatcgtgtcgtctcgctcggt -ccttgccgattttgacccctcgtatctgtgaatagcctgtcttcttgatg--------cg -ctggtgcgaagagc--------------------- +gcactcccggccggagcgctccttgccctctccgcttctccctctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggacatgctcgatgtt---tggatg +tctcctttttctcacgtacctcccc----------------------------------- +-------------gtccattcactatatgagctgatctcaaacagagcagtcaaccgaca +tcaatacggcggccggtgtcgctccatcattcatttgcacgggacgaatctgccatcggg +tcgtcgatacgttacttagattcaaatggttccgtgccatccgcagatgagttactcgta +gagagcgcgtcttattagccgtagaccaccctataagtttgctttaattttgataggttg +ctgcctcagatgccaccactcggcgcgaggcgcccggccacctctaggcagcgacttttt +cgcgtatatgtagatcgtgtcgtctcgctcggtccttgccgattttgacccctcgtatct +gtgaatagcctgtcttcttgatg--------cgctggtgcgaagagc------------- +-------- >Penicillium_nordicum_GCA_000733025.2|EOG091N44M8 ttcctcccccccctccctgaggcccactccgcccagcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgct---gtccctctctccgctgccgtg -tccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatactct -cttctctcccgtgtacctcccc-ccttactaaagctacagatacgtccattacatgaact -ggttgtaaatggcgctctcaaccagcaccaacacaacagtcgtcgccgccccatcattaa -cacccgcgggatgaatctgccttccagccatcgatgcgtcacctgaactcgaatggtttg -ggggtgcctgccagtaaggtgttggcgggatgtgagccttgttcgccccgtatcacccta -tacggttgctttacgttcgatcagctcttgacttcggcgctactactccttgtcaggggc -ccggccatctaggaacgacatctccttcgtccacgtgcagctcatgccgcctagcccgat -ccttgttagttttgatcttttacttccgcaggtagcccatttttttgactcgtagtcgcc -agtcgtcactgtaagatgcagcgtttcccccgatg +gcactcccggccggagcgctccttgccctctccgct---gtccctctct---ccgctgcc +gtgtccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatac +tctcttctctcccgtgtacctcccc-caatgccccttactacccgttccaagtggactgc +aagtaagctacagatacgtccattacatgaactggttgtaaatggcgctctcaaccagca +ccaacacaacagtcgtcgccgccccatcattaacacccgcgggatgaatctgccttccag +ccatcgatgcgtcacctgaactcgaatggtttgggggtgcctgccagtaaggtgttggcg +ggatgtgagccttgttcgccccgtatcaccctatacggttgctttacgttcgatcagctc +ttgacttcggcgctactactccttgtcaggggcccggccatctaggaacgacatctcctt +cgtccacgtgcagctcatgccgcctagcccgatccttgttagttttgatcttttacttcc +gcaggtagcccatttttttgactcgtagtcgccagtcgtcactgtaagatgcagcgtttc +ccccgatg >Penicillium_nordicum_GCA_001278595.1|EOG091N44M8 ttcctcccccccctccctgaggcccactccgcccagcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgct---gtccctctctccgctgccgtg -tccagctccgtagaaggtcgga--ggtccgatggatatgcttggaataagtgaatactct -cttctctcccgtgtacctcccct--------aagctacagatacgtccattacatgaact -ggttgtaaatggcgctctcaaccagcaccaacacaacagtcgtcgccgtcccatcattaa -cacccgcgggatgaatctgccttccagccatcgatgcgtcacctgaactcgaatggtttg -ggggtgcctgccagtaaggcgttggcgggatgtgagccttgttcgccacgtatcacccta -tacggttgctttacgttcgatcagctcttgacttcggcgctactactccttgtcaggggc -ccggccatctaggaacgacatctccttcgtccacgtgcagctcatgccgcctagcccgat -ccttgttagttttgatcttttacttccgcaggtagcccatttttttgactcgtagtcgcc -agtcgtcactgtaagatgcagcgtttcccccgatg +gcactcccggccggagcgctccttgccctctccgct---gtccctctct---ccgctgcc +gtgtccagctccgtagaaggtcgga--ggtccgatggatatgcttggaataagtgaatac +tctcttctctcccgtgtacctcccct---------------------------------- +----aagctacagatacgtccattacatgaactggttgtaaatggcgctctcaaccagca +ccaacacaacagtcgtcgccgtcccatcattaacacccgcgggatgaatctgccttccag +ccatcgatgcgtcacctgaactcgaatggtttgggggtgcctgccagtaaggcgttggcg +ggatgtgagccttgttcgccacgtatcaccctatacggttgctttacgttcgatcagctc +ttgacttcggcgctactactccttgtcaggggcccggccatctaggaacgacatctcctt +cgtccacgtgcagctcatgccgcctagcccgatccttgttagttttgatcttttacttcc +gcaggtagcccatttttttgactcgtagtcgccagtcgtcactgtaagatgcagcgtttc +ccccgatg >Penicillium_oxalicum_114-2_GCA_000346795.1|EOG091N44M8 ccccacccccccctctacgagtcccttgcctctcagagcctccccctcctctccgcccgg -gtgcttccgaccggactgcttttctccctttccgccgct----ctcctcccgctgccgtg -tctctaggcccccgccaagggg--agtccgaccgacatgatcggactc------------ +gtgcttccgaccggactgcttttctccctttccgccgct----ctcctctccccgctgcc +gtgtctctaggcccccgccaagggg--agtccgaccgacatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_oxalicum_GCA_001723175.2|EOG091N44M8 ccccacccccccctctacgagtcccttgcctctcagagcctccccctcctctccgcccgg -gtgcttccgaccggactgcttttctccctttccgccgct----ctcctcccgctgccgtg -tctctaggcccccgccaagggg--agtccgaccgacatgatcggactc------------ +gtgcttccgaccggactgcttttctccctttccgccgct----ctcctctccccgctgcc +gtgtctctaggcccccgccaagggg--agtccgaccgacatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_oxalicum_GCA_004153425.1|EOG091N44M8 ccccacccccccctctacgagtcccttgcctctcagagcctccccctcctctccgcccgg -gtgcttccgaccggactgcttttctccctttccgccgct----ctcctcccgctgccgtg -tctctaggcccccgccaagggg--agtccgaccgacatgatcggactc------------ +gtgcttccgaccggactgcttttctccctttccgccgct----ctcctctccccgctgcc +gtgtctctaggcccccgccaagggg--agtccgaccgacatgatcggactc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_oxalicum_GCA_004521935.1|EOG091N44M8 ccccacccccccctctacgagtcccttgcctctcagagcctccccctcctctccgcccgg -gtgcttccgaccggactgcttttctccctttccgccgct----ctcctcccgctgccgtg -tctctaggcccccgccaagggg--agtccgaccgacatgatcggactc------------ +gtgcttccgaccggactgcttttctccctttccgccgct----ctcctctccccgctgcc +gtgtctctaggcccccgccaagggg--agtccgaccgacatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_oxalicum_GCA_005546515.1|EOG091N44M8 ccccacccgcccctctacgagtcccttgcctctcagagcctccccctcctctccgcccgg -gtgcttccgaccggactgcttttctccctttccgccgct----ctcctcccgctgccgtg -tctctaggcccccgccaagggg--agtccgaccgacatgatcggactc------------ +gtgcttccgaccggactgcttttctccctttccgccgct----ctcctctccccgctgcc +gtgtctctaggcccccgccaagggg--agtccgaccgacatgatcggactc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_oxalicum_JU-A10-T_GCA_000383025.1|EOG091N44M8 ccccacccccccctctacgagtcccttgcctctcagagcctccccctcctctccgcccgg -gtgcttccgaccggactgcttttctccctttccgccgct----ctcctcccgctgccgtg -tctctaggcccccgccaagggg--agtccgaccgacatgatcggactc------------ +gtgcttccgaccggactgcttttctccctttccgccgct----ctcctctccccgctgcc +gtgtctctaggcccccgccaagggg--agtccgaccgacatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_paneum_FM227_GCA_000577715.1|EOG091N44M8 ttcctccctcccccgcacgacgacccctccgcctagcttctcccccccctgggtctgcgg -gcactccaggccggagcgctccttgccctctccgctggtgtgtcttct-ccgctgccctg -tccctctctgtagaagaagggaagggtccgatggatatgatcggactc------------ +gcactccaggccggagcgctccttgccctctccgctggtgtgtcttct----ccgctgcc +ctgtccctctctgtagaagaagggaagggtccgatggatatgatcggactc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_paxilli_ATCC_26601_GCA_000347475.1|EOG091N44M8 ccccaccctgccctccacgagtcccttgccgcccagcctgtccccctcctctccctccgc -gtgcgtccggacggagcgcgtttctccgtttccgttgctgtccctcc-cccggtggtctc -cctacctccgtagaaggaggga---gtccgacggacatgatcggtctt------------ +gtgcgtccggacggagcgcgtttctccgtttccgttgctgtccctcc-c---ccggtggt +ctccctacctccgtagaaggaggga---gtccgacggacatgatcggtctt--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_polonicum_GCA_002072265.1|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga------------ -----------aaactattct---------------------------------------- +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga--------- +-------------aaactattct------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_polonicum_GCA_003344595.1|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc------------ +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_roqueforti_FM164_GCA_000513255.1|EOG091N44M8 ttctccctgcccccccacgaggccctcgccgcctagctcctcccctccctgggtccgcgg -gcactccaagccggtgcgctccttgccctctccgtcggtctctctctctccgctgccgtg -tccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaataccat -tctctcttctgcgtacctccttt-----------------gtatacccgccacatgagcg -ggttgcaaatggcgcggccgaccaggatcaatacggtagccatcgccacctaaccattag -cctgcgcgggatgattccgtctccgggtcattgacgtgtcatccgagcccgaatatcttt -gtggtgtccgcggatgggtaatccaggcaaacctaatctcattcgacgtggatcgatccc -tgcggttattctgcatttgacaaactgctgattaagaagccattactcttaggttgaggt -ccagccactcatggatggtttccccttcgtattcacactccttatgcgctcgagctcgat -tcttgtcagtcctgaccttttaccctcgcggacagtttatttttttaactcgtagtcctg -ggcaaagacgctaaagcatagcatgtccctcgatg +gcactccaagccggtgcgctccttgccctctccgtcggtctctctctct---ccgctgcc +gtgtccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatac +cattctctcttctgcgtacctccttt---------------------------------- +-------------gtatacccgccacatgagcgggttgcaaatggcgcggccgaccagga +tcaatacggtagccatcgccacctaaccattagcctgcgcgggatgattccgtctccggg +tcattgacgtgtcatccgagcccgaatatctttgtggtgtccgcggatgggtaatccagg +caaacctaatctcattcgacgtggatcgatccctgcggttattctgcatttgacaaactg +ctgattaagaagccattactcttaggttgaggtccagccactcatggatggtttcccctt +cgtattcacactccttatgcgctcgagctcgattcttgtcagtcctgaccttttaccctc +gcggacagtttatttttttaactcgtagtcctgggcaaagacgctaaagcatagcatgtc +cctcgatg >Penicillium_roqueforti_GCA_000737485.2|EOG091N44M8 ttctccctgcccccccacgaggccctcgccgcctagctcctcccctccctgggtccgcgg -gcactccaagccggtgcgctccttgccctctccgtcggtctctctctctccgctgccgtg -tccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatactct -tctctcttctgcgtacctccttt-----------------ctatacccgccacatgagcg -ggttgcaaatggcgcggccgaccaggatcaatacggtagccatcgccacctaaccattag -cctgcgcgggatgattccgtctccgggtcattgacgtgtcatccgagcccgaatatcttt -gtggtgtccgcggatgggtaatccaggcaaacctaatctcattcgacgtggatcgatccc -tgcggttattctgcatttgacaaactgctgattaagaagccattactcttaggttgaggt -ccagccactcatggatggtttccccttcgtattcacactccttatgcgctcgagctcgat -tcttgtcagtcctgaccttttaccctcgcggacagtttatttttttaactcgtagtcctg -ggcaaagacgctaaagcatagcatgtccctcgatg +gcactccaagccggtgcgctccttgccctctccgtcggtctctctctct---ccgctgcc +gtgtccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatac +tcttctctcttctgcgtacctccttt---------------------------------- +-------------ctatacccgccacatgagcgggttgcaaatggcgcggccgaccagga +tcaatacggtagccatcgccacctaaccattagcctgcgcgggatgattccgtctccggg +tcattgacgtgtcatccgagcccgaatatctttgtggtgtccgcggatgggtaatccagg +caaacctaatctcattcgacgtggatcgatccctgcggttattctgcatttgacaaactg +ctgattaagaagccattactcttaggttgaggtccagccactcatggatggtttcccctt +cgtattcacactccttatgcgctcgagctcgattcttgtcagtcctgaccttttaccctc +gcggacagtttatttttttaactcgtagtcctgggcaaagacgctaaagcatagcatgtc +cctcgatg >Penicillium_roqueforti_GCA_001599855.1|EOG091N44M8 ttctccctgcccccccacgaggccctcgccgcctagctcctcccctccctgggtccgcgg -gcactccaagccggtgcgctccttgccctctccgtcggtctctctctctccgctgccgtg -tccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatactct -tctctcttctgcgtacctccttt-----------------ctatacccgccacatgagcg -ggttgcaaatggcgcggccgaccaggatcaatatggtagccatcgccacctaaccattag -cctgcgcgggatgattccgtctccgggtcattgacgtgtcatccgagcccgaatatcttt -gtggtgtccgcggatgggtaatccaggcaaacctaatctcattcgacgtggatcgatccc -tgcggttattctgcatttgacaaactgctgattaagaagccattactcttaggttgaggt -ccagccactcatggatggtttccccttcgtattcacactccttatgcgctcgagctcgat -tcttgtcagtcctgaccttttaccctcgcggacagtttatttttttaactcgtagtcctg -ggcaaagacgctaaagcatagcatgtccctcgatg +gcactccaagccggtgcgctccttgccctctccgtcggtctctctctct---ccgctgcc +gtgtccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatac +tcttctctcttctgcgtacctccttt---------------------------------- +-------------ctatacccgccacatgagcgggttgcaaatggcgcggccgaccagga +tcaatatggtagccatcgccacctaaccattagcctgcgcgggatgattccgtctccggg +tcattgacgtgtcatccgagcccgaatatctttgtggtgtccgcggatgggtaatccagg +caaacctaatctcattcgacgtggatcgatccctgcggttattctgcatttgacaaactg +ctgattaagaagccattactcttaggttgaggtccagccactcatggatggtttcccctt +cgtattcacactccttatgcgctcgagctcgattcttgtcagtcctgaccttttaccctc +gcggacagtttatttttttaactcgtagtcctgggcaaagacgctaaagcatagcatgtc +cctcgatg >Penicillium_roqueforti_GCA_001939915.1|EOG091N44M8 ttctccctgcccccccacgaggccctcgccgcctagctcctcccctccctgggtccgcgg -gcactccaagccggtgcgctccttgccctctccgtcggtctctctctctccgctgccgtg -tccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaataccat -tctctcttctgcgtacctcctt------------------gtatacccgccacatgagcg -ggttgcaaatggcgcggccgaccaggatcaatatggtagccatcgccacctaaccattag -cctgcgcgggatgattccgtctccgggtcattgacgtgtcatccgagcccgaatatcttt -gtggtgtccgcggatgggtaatccaggcaaacctaatctcattcgacgtggatcgatccc -tgcggttattctgcatttgacaaactgctgattaagaagccattactcttaggttgaggt -ccagccactcatggatggtttccccttcgtattcacactccttatgcgctcgagctcgat -tcttgtcagtcctgaccttttaccctcgcggacagtttatttttttaactcgtagtcctg -ggcaaagacgctaaagcatagcatgtccctcgatg +gcactccaagccggtgcgctccttgccctctccgtcggtctctctctct---ccgctgcc +gtgtccctctctgtagaagaaggga--gggattgcctcttca-aatctgcaatcgaatac +cattctctcttctgcgtacctcctt----------------------------------- +-------------gtatacccgccacatgagcgggttgcaaatggcgcggccgaccagga +tcaatatggtagccatcgccacctaaccattagcctgcgcgggatgattccgtctccggg +tcattgacgtgtcatccgagcccgaatatctttgtggtgtccgcggatgggtaatccagg +caaacctaatctcattcgacgtggatcgatccctgcggttattctgcatttgacaaactg +ctgattaagaagccattactcttaggttgaggtccagccactcatggatggtttcccctt +cgtattcacactccttatgcgctcgagctcgattcttgtcagtcctgaccttttaccctc +gcggacagtttatttttttaactcgtagtcctgggcaaagacgctaaagcatagcatgtc +cctcgatg >Penicillium_sclerotiorum_GCA_001750025.1|EOG091N44M8 tccctcccgcgcttccacgctcagctcgctgcctggagtctcccctccctctccgcccgc -ccatgtccggaacgagcgcgtttcaccccttccgttgctgtctctcctcgtggtgctccc -cccagctgcccccgccaagggg--agtccgacggacatgatcggtctc------------ +ccatgtccggaacgagcgcgtttcaccccttccgttgctgtctctcctc---gtggtgct +ccccccagctgcccccgccaagggg--agtccgacggacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_solitum_GCA_000952775.2|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga------------ -----------aaactattct---------------------------------------- +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga--------- +-------------aaactattct------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_solitum_GCA_001750005.1|EOG091N44M8 ttccttccccccctccacgaggcctgctccgcccatcccctcccctccctgggtctccgg -gcacgcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tacccctccgtagaaggccgga--ggtccgatggatatgctcggtgta------------ +gcacgcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtacccctccgtagaaggccgga--ggtccgatggatatgctcggtgta--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcggag----- +--------------------------------------------------------ag-- ------------------------------------------------------------ ----------------ttcggag-------------------------------------- ------------------------ag----------------------------------- ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_solitum_GCA_002072235.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctccccaccctgggtctccgg -gcacgcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_sp.12|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctccccaccctgggtctccgg -gcacgcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_sp._CF05_GCA_002916455.1|EOG091N44M8 ttccccccgcccctccacgaggccctcaccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- +------------------------------------------------ttcgat------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_sp._MA_6036_GCA_003138045.1|EOG091N44M8 tccctcccccccctccacgaggctctctccgcccagcccctcccccccctgggtctccgg -gcgctcccgacgcgagcccgtttcaccccttccgttgctgt----cctcctgccgctgcg -t--ctctccgtagaaggaaggg--agtccgatggacatgctcggaactcacgaatactct -ctcttcccctgtgtacctccccc-----------------ccccacccgccacggtcgtg -agctagcgctctaagtcgtcgttcgttgacgggcgacgcgtgtcccagcccggcatgctg -cctgtaaaacgcggaagtgtccctgtccgatgggtgccctccaggaggtagaactcccct -agcgcgttcgaggattgagtaccgatggtaattgaatactcaccatcgtgcactacatta -cacagccaccccagcttcgactagcagcaaactcgagcggcgtagtggccacccaagggc -gaaaatcccgataactagatcgttccccacctccgagctgcttgcgccgcctccccccgg -cttcttttgtctgttctccccgcctccttgggctactgactgagacggccaactagctgg -cgtaatgaaaatagagcgacatgcgctttcttggc +gcgctcccgacgcgagcccgtttcaccccttccgttgctgt----cctc---ctgccgct +gcgt--ctctccgtagaaggaaggg--agtccgatggacatgctcggaactcacgaatac +tctctcttcccctgtgtacctccccc---------------------------------- +-------------ccccacccgccacggtcgtgagctagcgctctaagtcgtcgttcgtt +gacgggcgacgcgtgtcccagcccggcatgctgcctgtaaaacgcggaagtgtccctgtc +cgatgggtgccctccaggaggtagaactcccctagcgcgttcgaggattgagtaccgatg +gtaattgaatactcaccatcgtgcactacattacacagccaccccagcttcgactagcag +caaactcgagcggcgtagtggccacccaagggcgaaaatcccgataactagatcgttccc +cacctccgagctgcttgcgccgcctccccccggcttcttttgtctgttctccccgcctcc +ttgggctactgactgagacggccaactagctggcgtaatgaaaatagagcgacatgcgct +ttcttggc >Penicillium_sp._MA_6040_GCA_003138025.1|EOG091N44M8 tcccctccgcccctccacgagtccctcgccgcccagatcctcccccccctgggtctccgg -gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctctccgctgccgtg -tccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc------------ +gcacgtccggccggagcgcgtcttaccctttccgttggtctccccctct---ccgctgcc +gtgtccagctgcgtagaagaagggatcggtccgatggacatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_sp.MB|EOG091N44M8 ttcctcccccccctccctgaggccctcgccgcccagcccctcccctccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga------------ -----------aaactacgtg---------------------------------------- +gcactcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggtcgga--ggtccgatggacatgctcgctgga--------- +-------------aaactacgtg------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_sp._MT2_MMC-2018_GCA_003852855.1|EOG091N44M8 ccccatcccctcccctacgagtcccttgcctcccagagcctccccctcctctccccccgg -gcgcgtccgaccggaccgcgtttcgccctctccgctgctgtgtctccttctgccgctgcg -tccccaggtccccgccaagggg--agtctgacggacatgctcggtctc------------ +gcgcgtccgaccggaccgcgtttcgccctctccgctgctgtgtctcctttgtctgccgct +gcgtccccaggtccccgccaagggg--agtctgacggacatgctcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_sp._occitanis_GCA_002382835.1|EOG091N44M8 cctagccccccgctccacgcctccttcgcctctcaaacctgagtctctcctgaggtccgg -ccctgccgggacggagtgtgtttttcccccagcgttgctgt--gtttttccaccgccccg -tgtctctgtgcagaagaagggg--aatccgacggacatgatcggtctt------------ +ccctgccgggacggagtgtgtttttcccccagcgttgctgt--gttttttgtccaccgcc +ccgtgtctctgtgcagaagaagggg--aatccgacggacatgatcggtctt--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_sp._occitanis_GCA_002382855.1|EOG091N44M8 cctagccccccgctccacgcctccttcgcctctcaaacctgagtctctcctgaggtccgg -ccctgccgggacggagtgtgtttttcccccagcgttgctgt--gtttttccaccgccccg -tgtctctgtgcagaagaagggg--aatccgacggacatgatcggtctt------------ +ccctgccgggacggagtgtgtttttcccccagcgttgctgt--gttttttgtccaccgcc +ccgtgtctctgtgcagaagaagggg--aatccgacggacatgatcggtctt--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgac------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_sp._SPG-F15_GCA_003800485.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctcccccccctgggtctccgg -gcacgcccggccggagcgctccttaccctctccgctgctgtccctctctccgctgccgtg -tccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga------------ -----------aaactattcc---------------------------------------- +gcacgcccggccggagcgctccttaccctctccgctgctgtccctctct---ccgctgcc +gtgtccccctccgtagaaggttgga--ggtccgatggatatgctcgctgga--------- +-------------aaactattcc------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_sp._SPG-F1_GCA_003800495.1|EOG091N44M8 ttcctcccccccctccacgaggccctctccgcccatcccctccccaccctgggtctccgg -gcacgcccggccggagcgctccttgccctctccgctgctgtccctctctccgctgccgtg -tccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc------------ +gcacgcccggccggagcgctccttgccctctccgctgctgtccctctct---ccgctgcc +gtgtccacctccgtagaaggttgga--ggtccgatggatatgctcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_sp._W3_MMC-2018_GCA_004959885.1|EOG091N44M8 ttcctttctccactgtaggccaactgcgccgcttatcccgagcctttactagagatgttt -tgactttgagattgagcctgttcagaggttactgttactttcccttc--gtgccgctctc -tctatccctgtag---aagagg--aatctgattgatatgttcggcgtcaatgactat--- -a--------------------c-------------------------------------- ------------------acattta--------ataagg---------------------- -------------cgggaaaggtggaattacactagataaac-aaaa-----caacgcctg -actgcacagaaactcagaacaagaatccacccaggaattaaatcaaggaa----c---aa -tata-----------gaagac----------------------ttcagctttaaacagct --gacccgtgtagcacctatactac-atgactgttggagtgagacccttg---tgtttc-- --ctccatacctcgttggaggtttg-t-a------gtttta----------agtta----- ---------------------------tccc----- +tgactttgagattgagcctgttcagaggttactgttactttcccttc-----gtgccgct +ctctctatccctgtag---aagagg--aatctgattgatatgttcggcgtcaatgactat +---a--------------------c----------------------------------- +--------------------------------------------------acattta--- +-----ataagg----------------------------------cgggaaaggtggaat +tacactagataaac-aaaa-----caacgcctgactgcacagaaactcagaacaagaatc +cacccaggaattaaatcaaggaa----c---aatata-----------gaagac------ +----------------ttcagctttaaacagct-gacccgtgtagcacctatactac-at +gactgttggagtgagacccttg---tgtttc---ctccatacctcgttggaggtttg-t- +a------gtttta----------agtta-------------------------------t +ccc----- >Penicillium_steckii_GCA_002072375.1|EOG091N44M8 ccccaccctgcctgccacgccgagctcgccgcccaggctgtcccctccctctctgcccgc -gcgcgtccggacggagtgctctacaccccttccgttgctgtcccccc--ccgctggtgta -cccctccccgtagaagaagggg--agtccgatggacatgctcgtgatg------------ -----a------------------------------------------------------- +gcgcgtccggacggagtgctctacaccccttccgttgctgtcccccc-----ccgctggt +gtacccctccccgtagaagaagggg--agtccgatggacatgctcgtgatg--------- +-------a---------------------------------------------------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------tggtgc------ ------------------------------------------------------------ ----------------tggtgc--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- >Penicillium_subrubescens_GCA_001908125.1|EOG091N44M8 ccccatccccccccctacgagtcccttgcttcccagagcctcccccccctctccgcccgg -gcgcgtccgaccggaccgcgtttcaccctcagcgctgctgtgtcttcccctgccgctgcg -tccccaggtccccgccaagggg--agtccgactgacatgatcggtctc------------ +gcgcgtccgaccggaccgcgtttcaccctcagcgctgctgtgtcttccctgtctgccgct +gcgtccccaggtccccgccaagggg--agtccgactgacatgatcggtctc--------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ----------------ttcgac--------------------------------------- +------------------------------------------------ttcgac------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +------------------------------------------------------------ +-------- >Penicillium_verrucosum_GCA_000970515.2|EOG091N44M8 ttcctcccccccctccctgaggcccactccgcccagcccctcccccccctgggtctccgg -gcactcccggccggagcgctccttgccctctccgct---gtccctctctccgctgccgtg -tccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatactct -cttctctcccgcgtacctccccctcttactaaagctacagatacgcccattatatgaact -ggttgtaaatggcgctctcaaccagcactaacacaactgtcgtcgccgccccatcattaa -cacccgcgggatgaacctgccttccagccatcgatgcgtcacctgaactcgaatggtttg -ggggtgcctgccagtaaggtgttggcgggatgtgagccttgttcgccacgtattacccta -tacggttgctttacgttcgattagctcttgacttcggcgctactactccttgataggggc -ccgaccatctaggaacgacatctccttcgtccacgtgcagttcatgccgcctagcccgat -ccttgttagttttgatcttttacttccgtaggtagcctattcttttgactcgtagtcgcc -agtcgtcactgcaaggtgcagcgtttcccccgatg +gcactcccggccggagcgctccttgccctctccgct---gtccctctct---ccgctgcc +gtgtccagctccgtagaaggtcgga--ggtccgatggatatgctcggaataagtgaatac +tctcttctctcccgcgtacctccccccaatgcatcttactacccgtcccaagtggactgc +aagtaagctacagatacgcccattatatgaactggttgtaaatggcgctctcaaccagca +ctaacacaactgtcgtcgccgccccatcattaacacccgcgggatgaacctgccttccag +ccatcgatgcgtcacctgaactcgaatggtttgggggtgcctgccagtaaggtgttggcg +ggatgtgagccttgttcgccacgtattaccctatacggttgctttacgttcgattagctc +ttgacttcggcgctactactccttgataggggcccgaccatctaggaacgacatctcctt +cgtccacgtgcagttcatgccgcctagcccgatccttgttagttttgatcttttacttcc +gtaggtagcctattcttttgactcgtagtcgccagtcgtcactgcaaggtgcagcgtttc +ccccgatg >Penicillium_vulpinum_GCA_002072255.1|EOG091N44M8 ttcctcccccccctctacgaggctctcgccgcctagcttctcccctccctgggtctccgc -gcactcccggccgcagcgtgtcttaccctttccgctgctgtctctctctccggcggtccc -cccccctccgtagaaggaggga--ggtccgacggatatgatcggtctc------------ +gcactcccggccgcagcgtgtcttaccctttccgctgctgtctctctct---ccggcggt +ccccccccctccgtagaaggaggga--ggtccgacggatatgatcggtctc--------- +------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------------------------------ +------------------------------------------------ttcgat------ ------------------------------------------------------------ ----------------ttcgat--------------------------------------- ------------------------------------------------------------ ------------------------------------------------------------ ------------------------------------ +-------- diff --git a/tests/integration/expected/EOG091N44M8_nt.fa.clipkit.log b/tests/integration/expected/EOG091N44M8_nt.fa.clipkit.log index 12f1a47..bf61c87 100644 --- a/tests/integration/expected/EOG091N44M8_nt.fa.clipkit.log +++ b/tests/integration/expected/EOG091N44M8_nt.fa.clipkit.log @@ -205,48 +205,48 @@ 205 keep singleton 0.0 206 keep constant 0.0 207 keep parsimony-informative 0.0 -208 keep parsimony-informative 0.05982905982905983 -209 keep parsimony-informative 0.05982905982905983 -210 keep parsimony-informative 0.05982905982905983 -211 trim constant 0.9829059829059829 -212 trim other 0.9829059829059829 -213 trim other 0.9829059829059829 -214 keep constant 0.05982905982905983 -215 keep parsimony-informative 0.05982905982905983 -216 keep parsimony-informative 0.05982905982905983 -217 trim other 0.9914529914529915 -218 trim other 0.9914529914529915 -219 trim other 0.9914529914529915 -220 trim constant 0.9401709401709402 -221 trim parsimony-informative 0.9401709401709402 -222 trim parsimony-informative 0.9401709401709402 -223 keep constant 0.08547008547008547 -224 keep parsimony-informative 0.08547008547008547 -225 keep parsimony-informative 0.08547008547008547 -226 trim constant 0.9829059829059829 -227 trim constant 0.9829059829059829 -228 trim constant 0.9829059829059829 -229 keep constant 0.03418803418803419 -230 keep parsimony-informative 0.03418803418803419 -231 keep parsimony-informative 0.03418803418803419 -232 keep singleton 0.02564102564102564 -233 keep constant 0.02564102564102564 -234 keep parsimony-informative 0.02564102564102564 -235 keep singleton 0.02564102564102564 -236 keep constant 0.02564102564102564 -237 keep parsimony-informative 0.02564102564102564 -238 keep singleton 0.07692307692307693 -239 keep constant 0.07692307692307693 -240 keep parsimony-informative 0.07692307692307693 -241 keep constant 0.11965811965811966 -242 keep constant 0.11965811965811966 -243 keep parsimony-informative 0.11965811965811966 -244 keep constant 0.8803418803418803 -245 keep singleton 0.8803418803418803 -246 keep parsimony-informative 0.8803418803418803 -247 keep constant 0.8803418803418803 -248 keep parsimony-informative 0.8803418803418803 -249 keep parsimony-informative 0.8803418803418803 +208 keep parsimony-informative 0.0598 +209 keep parsimony-informative 0.0598 +210 keep parsimony-informative 0.0598 +211 trim constant 0.9829 +212 trim other 0.9829 +213 trim other 0.9829 +214 keep constant 0.0598 +215 keep parsimony-informative 0.0598 +216 keep parsimony-informative 0.0598 +217 trim other 0.9915 +218 trim other 0.9915 +219 trim other 0.9915 +220 trim constant 0.9402 +221 trim parsimony-informative 0.9402 +222 trim parsimony-informative 0.9402 +223 keep constant 0.0855 +224 keep parsimony-informative 0.0855 +225 keep parsimony-informative 0.0855 +226 trim constant 0.9829 +227 trim constant 0.9829 +228 trim constant 0.9829 +229 keep constant 0.0342 +230 keep parsimony-informative 0.0342 +231 keep parsimony-informative 0.0342 +232 keep singleton 0.0256 +233 keep constant 0.0256 +234 keep parsimony-informative 0.0256 +235 keep singleton 0.0256 +236 keep constant 0.0256 +237 keep parsimony-informative 0.0256 +238 keep singleton 0.0769 +239 keep constant 0.0769 +240 keep parsimony-informative 0.0769 +241 keep constant 0.1197 +242 keep constant 0.1197 +243 keep parsimony-informative 0.1197 +244 keep constant 0.8803 +245 keep singleton 0.8803 +246 keep parsimony-informative 0.8803 +247 keep constant 0.8803 +248 keep parsimony-informative 0.8803 +249 keep parsimony-informative 0.8803 250 keep constant 0.0 251 keep parsimony-informative 0.0 252 keep parsimony-informative 0.0 @@ -262,9 +262,9 @@ 262 keep singleton 0.0 263 keep parsimony-informative 0.0 264 keep parsimony-informative 0.0 -265 keep singleton 0.017094017094017096 -266 keep parsimony-informative 0.017094017094017096 -267 keep parsimony-informative 0.017094017094017096 +265 keep singleton 0.0171 +266 keep parsimony-informative 0.0171 +267 keep parsimony-informative 0.0171 268 keep constant 0.0 269 keep parsimony-informative 0.0 270 keep parsimony-informative 0.0 @@ -274,9 +274,9 @@ 274 keep parsimony-informative 0.0 275 keep constant 0.0 276 keep parsimony-informative 0.0 -277 keep constant 0.7521367521367521 -278 keep constant 0.7521367521367521 -279 keep singleton 0.7521367521367521 +277 keep constant 0.7521 +278 keep constant 0.7521 +279 keep singleton 0.7521 280 keep parsimony-informative 0.0 281 keep constant 0.0 282 keep parsimony-informative 0.0 @@ -286,18 +286,18 @@ 286 keep constant 0.0 287 keep parsimony-informative 0.0 288 keep parsimony-informative 0.0 -289 keep parsimony-informative 0.02564102564102564 -290 keep parsimony-informative 0.02564102564102564 -291 keep parsimony-informative 0.02564102564102564 -292 trim parsimony-informative 0.9487179487179487 -293 trim parsimony-informative 0.9487179487179487 -294 trim parsimony-informative 0.9487179487179487 -295 trim constant 0.9487179487179487 -296 trim constant 0.9487179487179487 -297 trim parsimony-informative 0.9487179487179487 -298 trim singleton 0.9487179487179487 -299 trim constant 0.9487179487179487 -300 trim constant 0.9487179487179487 +289 keep parsimony-informative 0.0256 +290 keep parsimony-informative 0.0256 +291 keep parsimony-informative 0.0256 +292 trim parsimony-informative 0.9487 +293 trim parsimony-informative 0.9487 +294 trim parsimony-informative 0.9487 +295 trim constant 0.9487 +296 trim constant 0.9487 +297 trim parsimony-informative 0.9487 +298 trim singleton 0.9487 +299 trim constant 0.9487 +300 trim constant 0.9487 301 keep parsimony-informative 0.0 302 keep parsimony-informative 0.0 303 keep parsimony-informative 0.0 @@ -310,12 +310,12 @@ 310 keep parsimony-informative 0.0 311 keep singleton 0.0 312 keep singleton 0.0 -313 keep constant 0.8376068376068376 -314 keep parsimony-informative 0.8376068376068376 -315 keep parsimony-informative 0.8376068376068376 -316 keep parsimony-informative 0.008547008547008548 -317 keep singleton 0.008547008547008548 -318 keep singleton 0.008547008547008548 +313 keep constant 0.8376 +314 keep parsimony-informative 0.8376 +315 keep parsimony-informative 0.8376 +316 keep parsimony-informative 0.0085 +317 keep singleton 0.0085 +318 keep singleton 0.0085 319 keep constant 0.0 320 keep constant 0.0 321 keep parsimony-informative 0.0 @@ -337,2742 +337,2742 @@ 337 keep parsimony-informative 0.0 338 keep parsimony-informative 0.0 339 keep parsimony-informative 0.0 -340 keep constant 0.042735042735042736 -341 keep constant 0.042735042735042736 -342 keep parsimony-informative 0.042735042735042736 +340 keep constant 0.0427 +341 keep constant 0.0427 +342 keep parsimony-informative 0.0427 343 keep parsimony-informative 0.0 344 keep constant 0.0 345 keep parsimony-informative 0.0 -346 trim constant 0.9487179487179487 -347 trim constant 0.9487179487179487 -348 trim constant 0.9487179487179487 -349 trim other 0.9914529914529915 -350 trim other 0.9914529914529915 -351 trim other 0.9914529914529915 -352 trim other 0.9914529914529915 -353 trim other 0.9914529914529915 -354 trim other 0.9914529914529915 -355 trim other 0.9914529914529915 -356 trim other 0.9914529914529915 -357 trim other 0.9914529914529915 -358 trim other 0.9914529914529915 -359 trim other 0.9914529914529915 -360 trim other 0.9914529914529915 -361 trim constant 0.9487179487179487 -362 trim constant 0.9487179487179487 -363 trim singleton 0.9487179487179487 -364 trim singleton 0.9487179487179487 -365 trim singleton 0.9487179487179487 -366 trim constant 0.9487179487179487 -367 trim other 0.9914529914529915 -368 trim other 0.9914529914529915 -369 trim other 0.9914529914529915 -370 trim other 0.9914529914529915 -371 trim other 0.9914529914529915 -372 trim other 0.9914529914529915 -373 trim other 0.9914529914529915 -374 trim other 0.9914529914529915 -375 trim other 0.9914529914529915 -376 trim other 0.9914529914529915 -377 trim other 0.9914529914529915 -378 trim other 0.9914529914529915 -379 trim other 0.9914529914529915 -380 trim other 0.9914529914529915 -381 trim other 0.9914529914529915 -382 trim other 0.9914529914529915 -383 trim other 0.9914529914529915 -384 trim other 0.9914529914529915 -385 trim other 0.9914529914529915 -386 trim other 0.9914529914529915 -387 trim other 0.9914529914529915 -388 trim other 0.9914529914529915 -389 trim other 0.9914529914529915 -390 trim other 0.9914529914529915 -391 trim other 0.9914529914529915 -392 trim other 0.9914529914529915 -393 trim other 0.9914529914529915 -394 trim other 0.9914529914529915 -395 trim other 0.9914529914529915 -396 trim other 0.9914529914529915 -397 trim other 0.9914529914529915 -398 trim other 0.9914529914529915 -399 trim other 0.9914529914529915 -400 trim other 0.9914529914529915 -401 trim other 0.9914529914529915 -402 trim other 0.9914529914529915 -403 trim other 0.9914529914529915 -404 trim other 0.9914529914529915 -405 trim other 0.9914529914529915 -406 trim other 0.9914529914529915 -407 trim other 0.9914529914529915 -408 trim other 0.9914529914529915 -409 trim other 0.9914529914529915 -410 trim other 0.9914529914529915 -411 trim other 0.9914529914529915 -412 trim other 0.9914529914529915 -413 trim other 0.9914529914529915 -414 trim other 0.9914529914529915 -415 trim other 0.9914529914529915 -416 trim other 0.9914529914529915 -417 trim other 0.9914529914529915 -418 trim other 0.9914529914529915 -419 trim other 0.9914529914529915 -420 trim other 0.9914529914529915 -421 trim other 0.9914529914529915 -422 trim other 0.9914529914529915 -423 trim other 0.9914529914529915 -424 trim other 0.9914529914529915 -425 trim other 0.9914529914529915 -426 trim other 0.9914529914529915 -427 trim other 0.9914529914529915 -428 trim other 0.9914529914529915 -429 trim other 0.9914529914529915 -430 trim other 0.9914529914529915 -431 trim other 0.9914529914529915 -432 trim other 0.9914529914529915 -433 trim other 0.9914529914529915 -434 trim other 0.9914529914529915 -435 trim other 0.9914529914529915 -436 trim other 0.9914529914529915 -437 trim other 0.9914529914529915 -438 trim other 0.9914529914529915 -439 trim other 0.9914529914529915 -440 trim other 0.9914529914529915 -441 trim other 0.9914529914529915 -442 trim other 0.9914529914529915 -443 trim other 0.9914529914529915 -444 trim other 0.9914529914529915 -445 trim other 0.9914529914529915 -446 trim other 0.9914529914529915 -447 trim other 0.9914529914529915 -448 trim other 0.9914529914529915 -449 trim other 0.9914529914529915 -450 trim other 0.9914529914529915 -451 trim other 0.9914529914529915 -452 trim other 0.9914529914529915 -453 trim other 0.9914529914529915 -454 trim other 0.9914529914529915 -455 trim other 0.9914529914529915 -456 trim other 0.9914529914529915 -457 trim other 0.9914529914529915 -458 trim other 0.9914529914529915 -459 trim other 0.9914529914529915 -460 trim other 0.9914529914529915 -461 trim other 0.9914529914529915 -462 trim other 0.9914529914529915 -463 trim other 0.9914529914529915 -464 trim other 0.9914529914529915 -465 trim other 0.9914529914529915 -466 trim other 0.9914529914529915 -467 trim other 0.9914529914529915 -468 trim other 0.9914529914529915 -469 trim other 0.9914529914529915 -470 trim other 0.9914529914529915 -471 trim other 0.9914529914529915 -472 trim other 0.9914529914529915 -473 trim other 0.9914529914529915 -474 trim other 0.9914529914529915 -475 trim other 0.9914529914529915 -476 trim other 0.9914529914529915 -477 trim other 0.9914529914529915 -478 trim other 0.9914529914529915 -479 trim other 0.9914529914529915 -480 trim other 0.9914529914529915 -481 trim other 0.9914529914529915 -482 trim other 0.9914529914529915 -483 trim other 0.9914529914529915 -484 trim other 0.9914529914529915 -485 trim other 0.9914529914529915 -486 trim other 0.9914529914529915 -487 trim other 0.9914529914529915 -488 trim other 0.9914529914529915 -489 trim other 0.9914529914529915 -490 trim other 0.9914529914529915 -491 trim other 0.9914529914529915 -492 trim other 0.9914529914529915 -493 trim other 0.9914529914529915 -494 trim other 0.9914529914529915 -495 trim other 0.9914529914529915 -496 trim other 0.9914529914529915 -497 trim other 0.9914529914529915 -498 trim other 0.9914529914529915 -499 trim other 0.9914529914529915 -500 trim other 0.9914529914529915 -501 trim other 0.9914529914529915 -502 trim other 0.9914529914529915 -503 trim other 0.9914529914529915 -504 trim other 0.9914529914529915 -505 trim other 0.9914529914529915 -506 trim other 0.9914529914529915 -507 trim other 0.9914529914529915 -508 trim other 0.9914529914529915 -509 trim other 0.9914529914529915 -510 trim other 0.9914529914529915 -511 trim other 0.9914529914529915 -512 trim other 0.9914529914529915 -513 trim other 0.9914529914529915 -514 trim other 0.9914529914529915 -515 trim other 0.9914529914529915 -516 trim other 0.9914529914529915 -517 trim other 0.9914529914529915 -518 trim other 0.9914529914529915 -519 trim other 0.9914529914529915 -520 trim other 0.9914529914529915 -521 trim other 0.9914529914529915 -522 trim other 0.9914529914529915 -523 trim other 0.9914529914529915 -524 trim other 0.9914529914529915 -525 trim other 0.9914529914529915 -526 trim other 0.9914529914529915 -527 trim other 0.9914529914529915 -528 trim other 0.9914529914529915 -529 trim other 0.9914529914529915 -530 trim other 0.9914529914529915 -531 trim other 0.9914529914529915 -532 trim other 0.9914529914529915 -533 trim other 0.9914529914529915 -534 trim other 0.9914529914529915 -535 trim other 0.9914529914529915 -536 trim other 0.9914529914529915 -537 trim other 0.9914529914529915 -538 trim other 0.9914529914529915 -539 trim other 0.9914529914529915 -540 trim other 0.9914529914529915 -541 trim other 0.9914529914529915 -542 trim other 0.9914529914529915 -543 trim other 0.9914529914529915 -544 trim other 0.9914529914529915 -545 trim other 0.9914529914529915 -546 trim other 0.9914529914529915 -547 trim other 0.9914529914529915 -548 trim other 0.9914529914529915 -549 trim other 0.9914529914529915 -550 trim other 0.9914529914529915 -551 trim other 0.9914529914529915 -552 trim other 0.9914529914529915 -553 trim other 0.9914529914529915 -554 trim other 0.9914529914529915 -555 trim other 0.9914529914529915 -556 trim other 0.9914529914529915 -557 trim other 0.9914529914529915 -558 trim other 0.9914529914529915 -559 trim other 0.9914529914529915 -560 trim other 0.9914529914529915 -561 trim other 0.9914529914529915 -562 trim other 0.9914529914529915 -563 trim other 0.9914529914529915 -564 trim other 0.9914529914529915 -565 trim other 0.9914529914529915 -566 trim other 0.9914529914529915 -567 trim other 0.9914529914529915 -568 trim other 0.9914529914529915 -569 trim other 0.9914529914529915 -570 trim other 0.9914529914529915 -571 trim other 0.9914529914529915 -572 trim other 0.9914529914529915 -573 trim other 0.9914529914529915 -574 trim other 0.9914529914529915 -575 trim other 0.9914529914529915 -576 trim other 0.9914529914529915 -577 trim other 0.9914529914529915 -578 trim other 0.9914529914529915 -579 trim other 0.9914529914529915 -580 trim other 0.9914529914529915 -581 trim other 0.9914529914529915 -582 trim other 0.9914529914529915 -583 trim other 0.9914529914529915 -584 trim other 0.9914529914529915 -585 trim other 0.9914529914529915 -586 trim other 0.9914529914529915 -587 trim other 0.9914529914529915 -588 trim other 0.9914529914529915 -589 trim other 0.9914529914529915 -590 trim other 0.9914529914529915 -591 trim other 0.9914529914529915 -592 trim other 0.9914529914529915 -593 trim other 0.9914529914529915 -594 trim other 0.9914529914529915 -595 trim other 0.9914529914529915 -596 trim other 0.9914529914529915 -597 trim other 0.9914529914529915 -598 trim other 0.9914529914529915 -599 trim other 0.9914529914529915 -600 trim other 0.9914529914529915 -601 trim other 0.9914529914529915 -602 trim other 0.9914529914529915 -603 trim other 0.9914529914529915 -604 trim other 0.9914529914529915 -605 trim other 0.9914529914529915 -606 trim other 0.9914529914529915 -607 trim singleton 0.9487179487179487 -608 trim constant 0.9487179487179487 -609 trim singleton 0.9487179487179487 +346 trim constant 0.9487 +347 trim constant 0.9487 +348 trim constant 0.9487 +349 trim other 0.9915 +350 trim other 0.9915 +351 trim other 0.9915 +352 trim other 0.9915 +353 trim other 0.9915 +354 trim other 0.9915 +355 trim other 0.9915 +356 trim other 0.9915 +357 trim other 0.9915 +358 trim other 0.9915 +359 trim other 0.9915 +360 trim other 0.9915 +361 trim constant 0.9487 +362 trim constant 0.9487 +363 trim singleton 0.9487 +364 trim singleton 0.9487 +365 trim singleton 0.9487 +366 trim constant 0.9487 +367 trim other 0.9915 +368 trim other 0.9915 +369 trim other 0.9915 +370 trim other 0.9915 +371 trim other 0.9915 +372 trim other 0.9915 +373 trim other 0.9915 +374 trim other 0.9915 +375 trim other 0.9915 +376 trim other 0.9915 +377 trim other 0.9915 +378 trim other 0.9915 +379 trim other 0.9915 +380 trim other 0.9915 +381 trim other 0.9915 +382 trim other 0.9915 +383 trim other 0.9915 +384 trim other 0.9915 +385 trim other 0.9915 +386 trim other 0.9915 +387 trim other 0.9915 +388 trim other 0.9915 +389 trim other 0.9915 +390 trim other 0.9915 +391 trim other 0.9915 +392 trim other 0.9915 +393 trim other 0.9915 +394 trim other 0.9915 +395 trim other 0.9915 +396 trim other 0.9915 +397 trim other 0.9915 +398 trim other 0.9915 +399 trim other 0.9915 +400 trim other 0.9915 +401 trim other 0.9915 +402 trim other 0.9915 +403 trim other 0.9915 +404 trim other 0.9915 +405 trim other 0.9915 +406 trim other 0.9915 +407 trim other 0.9915 +408 trim other 0.9915 +409 trim other 0.9915 +410 trim other 0.9915 +411 trim other 0.9915 +412 trim other 0.9915 +413 trim other 0.9915 +414 trim other 0.9915 +415 trim other 0.9915 +416 trim other 0.9915 +417 trim other 0.9915 +418 trim other 0.9915 +419 trim other 0.9915 +420 trim other 0.9915 +421 trim other 0.9915 +422 trim other 0.9915 +423 trim other 0.9915 +424 trim other 0.9915 +425 trim other 0.9915 +426 trim other 0.9915 +427 trim other 0.9915 +428 trim other 0.9915 +429 trim other 0.9915 +430 trim other 0.9915 +431 trim other 0.9915 +432 trim other 0.9915 +433 trim other 0.9915 +434 trim other 0.9915 +435 trim other 0.9915 +436 trim other 0.9915 +437 trim other 0.9915 +438 trim other 0.9915 +439 trim other 0.9915 +440 trim other 0.9915 +441 trim other 0.9915 +442 trim other 0.9915 +443 trim other 0.9915 +444 trim other 0.9915 +445 trim other 0.9915 +446 trim other 0.9915 +447 trim other 0.9915 +448 trim other 0.9915 +449 trim other 0.9915 +450 trim other 0.9915 +451 trim other 0.9915 +452 trim other 0.9915 +453 trim other 0.9915 +454 trim other 0.9915 +455 trim other 0.9915 +456 trim other 0.9915 +457 trim other 0.9915 +458 trim other 0.9915 +459 trim other 0.9915 +460 trim other 0.9915 +461 trim other 0.9915 +462 trim other 0.9915 +463 trim other 0.9915 +464 trim other 0.9915 +465 trim other 0.9915 +466 trim other 0.9915 +467 trim other 0.9915 +468 trim other 0.9915 +469 trim other 0.9915 +470 trim other 0.9915 +471 trim other 0.9915 +472 trim other 0.9915 +473 trim other 0.9915 +474 trim other 0.9915 +475 trim other 0.9915 +476 trim other 0.9915 +477 trim other 0.9915 +478 trim other 0.9915 +479 trim other 0.9915 +480 trim other 0.9915 +481 trim other 0.9915 +482 trim other 0.9915 +483 trim other 0.9915 +484 trim other 0.9915 +485 trim other 0.9915 +486 trim other 0.9915 +487 trim other 0.9915 +488 trim other 0.9915 +489 trim other 0.9915 +490 trim other 0.9915 +491 trim other 0.9915 +492 trim other 0.9915 +493 trim other 0.9915 +494 trim other 0.9915 +495 trim other 0.9915 +496 trim other 0.9915 +497 trim other 0.9915 +498 trim other 0.9915 +499 trim other 0.9915 +500 trim other 0.9915 +501 trim other 0.9915 +502 trim other 0.9915 +503 trim other 0.9915 +504 trim other 0.9915 +505 trim other 0.9915 +506 trim other 0.9915 +507 trim other 0.9915 +508 trim other 0.9915 +509 trim other 0.9915 +510 trim other 0.9915 +511 trim other 0.9915 +512 trim other 0.9915 +513 trim other 0.9915 +514 trim other 0.9915 +515 trim other 0.9915 +516 trim other 0.9915 +517 trim other 0.9915 +518 trim other 0.9915 +519 trim other 0.9915 +520 trim other 0.9915 +521 trim other 0.9915 +522 trim other 0.9915 +523 trim other 0.9915 +524 trim other 0.9915 +525 trim other 0.9915 +526 trim other 0.9915 +527 trim other 0.9915 +528 trim other 0.9915 +529 trim other 0.9915 +530 trim other 0.9915 +531 trim other 0.9915 +532 trim other 0.9915 +533 trim other 0.9915 +534 trim other 0.9915 +535 trim other 0.9915 +536 trim other 0.9915 +537 trim other 0.9915 +538 trim other 0.9915 +539 trim other 0.9915 +540 trim other 0.9915 +541 trim other 0.9915 +542 trim other 0.9915 +543 trim other 0.9915 +544 trim other 0.9915 +545 trim other 0.9915 +546 trim other 0.9915 +547 trim other 0.9915 +548 trim other 0.9915 +549 trim other 0.9915 +550 trim other 0.9915 +551 trim other 0.9915 +552 trim other 0.9915 +553 trim other 0.9915 +554 trim other 0.9915 +555 trim other 0.9915 +556 trim other 0.9915 +557 trim other 0.9915 +558 trim other 0.9915 +559 trim other 0.9915 +560 trim other 0.9915 +561 trim other 0.9915 +562 trim other 0.9915 +563 trim other 0.9915 +564 trim other 0.9915 +565 trim other 0.9915 +566 trim other 0.9915 +567 trim other 0.9915 +568 trim other 0.9915 +569 trim other 0.9915 +570 trim other 0.9915 +571 trim other 0.9915 +572 trim other 0.9915 +573 trim other 0.9915 +574 trim other 0.9915 +575 trim other 0.9915 +576 trim other 0.9915 +577 trim other 0.9915 +578 trim other 0.9915 +579 trim other 0.9915 +580 trim other 0.9915 +581 trim other 0.9915 +582 trim other 0.9915 +583 trim other 0.9915 +584 trim other 0.9915 +585 trim other 0.9915 +586 trim other 0.9915 +587 trim other 0.9915 +588 trim other 0.9915 +589 trim other 0.9915 +590 trim other 0.9915 +591 trim other 0.9915 +592 trim other 0.9915 +593 trim other 0.9915 +594 trim other 0.9915 +595 trim other 0.9915 +596 trim other 0.9915 +597 trim other 0.9915 +598 trim other 0.9915 +599 trim other 0.9915 +600 trim other 0.9915 +601 trim other 0.9915 +602 trim other 0.9915 +603 trim other 0.9915 +604 trim other 0.9915 +605 trim other 0.9915 +606 trim other 0.9915 +607 trim singleton 0.9487 +608 trim constant 0.9487 +609 trim singleton 0.9487 610 keep parsimony-informative 0.0 611 keep parsimony-informative 0.0 612 keep parsimony-informative 0.0 613 keep parsimony-informative 0.0 614 keep parsimony-informative 0.0 615 keep parsimony-informative 0.0 -616 keep constant 0.8461538461538461 -617 keep constant 0.8461538461538461 -618 keep constant 0.8461538461538461 -619 keep constant 0.8461538461538461 -620 keep constant 0.8461538461538461 -621 keep constant 0.8461538461538461 -622 keep constant 0.8034188034188035 -623 keep constant 0.8034188034188035 -624 keep constant 0.8034188034188035 -625 keep constant 0.8034188034188035 -626 keep constant 0.8034188034188035 -627 keep constant 0.8034188034188035 -628 keep constant 0.8034188034188035 -629 keep constant 0.8034188034188035 -630 keep constant 0.8034188034188035 -631 keep constant 0.8034188034188035 -632 keep constant 0.8034188034188035 -633 keep constant 0.8034188034188035 -634 keep parsimony-informative 0.7948717948717948 -635 keep parsimony-informative 0.7948717948717948 -636 keep parsimony-informative 0.7948717948717948 -637 keep parsimony-informative 0.7606837606837606 -638 keep parsimony-informative 0.7606837606837606 -639 keep parsimony-informative 0.7606837606837606 -640 keep parsimony-informative 0.7606837606837606 -641 keep parsimony-informative 0.7606837606837606 -642 keep parsimony-informative 0.7606837606837606 -643 keep constant 0.7692307692307693 -644 keep constant 0.7692307692307693 -645 keep constant 0.7692307692307693 -646 keep constant 0.7692307692307693 -647 keep constant 0.7692307692307693 -648 keep constant 0.7692307692307693 -649 keep constant 0.7692307692307693 -650 keep constant 0.7692307692307693 -651 keep constant 0.7692307692307693 -652 keep constant 0.7692307692307693 -653 keep constant 0.7692307692307693 -654 keep constant 0.7692307692307693 -655 trim constant 0.9829059829059829 -656 trim constant 0.9829059829059829 -657 trim constant 0.9829059829059829 -658 keep constant 0.7692307692307693 -659 keep constant 0.7692307692307693 -660 keep parsimony-informative 0.7692307692307693 -661 keep constant 0.7692307692307693 -662 keep constant 0.7692307692307693 -663 keep parsimony-informative 0.7692307692307693 -664 keep constant 0.7692307692307693 -665 keep constant 0.7692307692307693 -666 keep constant 0.7692307692307693 -667 keep constant 0.7692307692307693 -668 keep constant 0.7692307692307693 -669 keep constant 0.7692307692307693 -670 keep constant 0.7692307692307693 -671 keep constant 0.7692307692307693 -672 keep constant 0.7692307692307693 -673 keep constant 0.7692307692307693 -674 keep constant 0.7692307692307693 -675 keep constant 0.7692307692307693 -676 keep constant 0.7692307692307693 -677 keep constant 0.7692307692307693 -678 keep constant 0.7692307692307693 -679 keep constant 0.7692307692307693 -680 keep constant 0.7692307692307693 -681 keep constant 0.7692307692307693 -682 keep constant 0.7692307692307693 -683 keep constant 0.7692307692307693 -684 keep constant 0.7692307692307693 -685 keep constant 0.7692307692307693 -686 keep constant 0.7692307692307693 -687 keep constant 0.7692307692307693 -688 keep constant 0.7692307692307693 -689 keep constant 0.7692307692307693 -690 keep constant 0.7692307692307693 -691 keep constant 0.7692307692307693 -692 keep constant 0.7692307692307693 -693 keep constant 0.7692307692307693 -694 keep constant 0.7692307692307693 -695 keep constant 0.7692307692307693 -696 keep parsimony-informative 0.7692307692307693 -697 keep constant 0.7692307692307693 -698 keep constant 0.7692307692307693 -699 keep constant 0.7692307692307693 -700 keep singleton 0.7606837606837606 -701 keep constant 0.7606837606837606 -702 keep constant 0.7606837606837606 -703 keep singleton 0.7606837606837606 -704 keep constant 0.7606837606837606 -705 keep parsimony-informative 0.7606837606837606 -706 keep constant 0.7692307692307693 -707 keep constant 0.7692307692307693 -708 keep parsimony-informative 0.7692307692307693 -709 keep constant 0.7692307692307693 -710 keep constant 0.7692307692307693 -711 keep singleton 0.7692307692307693 -712 keep constant 0.7692307692307693 -713 keep constant 0.7692307692307693 -714 keep constant 0.7692307692307693 -715 keep constant 0.7692307692307693 -716 keep constant 0.7692307692307693 -717 keep constant 0.7692307692307693 -718 keep constant 0.7606837606837606 -719 keep constant 0.7606837606837606 -720 keep constant 0.7606837606837606 -721 keep singleton 0.7606837606837606 -722 keep constant 0.7606837606837606 -723 keep singleton 0.7606837606837606 -724 keep singleton 0.7606837606837606 -725 keep singleton 0.7606837606837606 -726 keep singleton 0.7606837606837606 -727 keep constant 0.7606837606837606 -728 keep constant 0.7606837606837606 -729 keep singleton 0.7606837606837606 -730 keep constant 0.7606837606837606 -731 keep constant 0.7606837606837606 -732 keep constant 0.7606837606837606 -733 keep constant 0.7692307692307693 -734 keep constant 0.7692307692307693 -735 keep parsimony-informative 0.7692307692307693 -736 keep constant 0.7692307692307693 -737 keep constant 0.7692307692307693 -738 keep constant 0.7692307692307693 -739 keep constant 0.7692307692307693 -740 keep constant 0.7692307692307693 -741 keep constant 0.7692307692307693 -742 keep constant 0.7692307692307693 -743 keep constant 0.7692307692307693 -744 keep constant 0.7692307692307693 -745 keep constant 0.7692307692307693 -746 keep constant 0.7692307692307693 -747 keep constant 0.7692307692307693 -748 keep constant 0.7692307692307693 -749 keep constant 0.7692307692307693 -750 keep constant 0.7692307692307693 -751 keep constant 0.7692307692307693 -752 keep constant 0.7692307692307693 -753 keep constant 0.7692307692307693 -754 keep constant 0.7606837606837606 -755 keep constant 0.7606837606837606 -756 keep singleton 0.7606837606837606 -757 keep singleton 0.7606837606837606 -758 keep singleton 0.7606837606837606 -759 keep constant 0.7606837606837606 -760 keep constant 0.7692307692307693 -761 keep constant 0.7692307692307693 -762 keep constant 0.7692307692307693 -763 keep constant 0.7692307692307693 -764 keep constant 0.7692307692307693 -765 keep constant 0.7692307692307693 -766 keep constant 0.7692307692307693 -767 keep constant 0.7692307692307693 -768 keep singleton 0.7692307692307693 -769 keep constant 0.7692307692307693 -770 keep constant 0.7692307692307693 -771 keep constant 0.7692307692307693 -772 keep constant 0.7692307692307693 -773 keep constant 0.7692307692307693 -774 keep constant 0.7692307692307693 -775 keep constant 0.7692307692307693 -776 keep constant 0.7692307692307693 -777 keep constant 0.7692307692307693 -778 keep constant 0.7692307692307693 -779 keep constant 0.7692307692307693 -780 keep constant 0.7692307692307693 -781 keep constant 0.7692307692307693 -782 keep constant 0.7692307692307693 -783 keep singleton 0.7692307692307693 -784 keep constant 0.7692307692307693 -785 keep constant 0.7692307692307693 -786 keep constant 0.7692307692307693 -787 keep constant 0.7692307692307693 -788 keep constant 0.7692307692307693 -789 keep constant 0.7692307692307693 -790 keep constant 0.7692307692307693 -791 keep constant 0.7692307692307693 -792 keep singleton 0.7692307692307693 -793 keep constant 0.7692307692307693 -794 keep constant 0.7692307692307693 -795 keep parsimony-informative 0.7692307692307693 -796 keep constant 0.7692307692307693 -797 keep constant 0.7692307692307693 -798 keep constant 0.7692307692307693 -799 keep constant 0.7692307692307693 -800 keep constant 0.7692307692307693 -801 keep constant 0.7692307692307693 -802 keep constant 0.7692307692307693 -803 keep constant 0.7692307692307693 -804 keep constant 0.7692307692307693 -805 keep constant 0.7692307692307693 -806 keep constant 0.7692307692307693 -807 keep constant 0.7692307692307693 -808 keep singleton 0.7521367521367521 -809 keep singleton 0.7521367521367521 -810 keep singleton 0.7521367521367521 -811 keep singleton 0.7521367521367521 -812 keep singleton 0.7521367521367521 -813 keep singleton 0.7521367521367521 -814 keep singleton 0.7521367521367521 -815 keep singleton 0.7521367521367521 -816 keep parsimony-informative 0.7521367521367521 -817 keep singleton 0.7521367521367521 -818 keep constant 0.7521367521367521 -819 keep singleton 0.7521367521367521 -820 keep constant 0.7692307692307693 -821 keep constant 0.7692307692307693 -822 keep constant 0.7692307692307693 -823 keep constant 0.7692307692307693 -824 keep constant 0.7692307692307693 -825 keep constant 0.7692307692307693 -826 keep constant 0.7692307692307693 -827 keep constant 0.7692307692307693 -828 keep constant 0.7692307692307693 -829 keep constant 0.7606837606837606 -830 keep constant 0.7606837606837606 -831 keep constant 0.7606837606837606 -832 keep constant 0.7606837606837606 -833 keep constant 0.7606837606837606 -834 keep constant 0.7606837606837606 -835 keep singleton 0.7606837606837606 -836 keep constant 0.7606837606837606 -837 keep singleton 0.7606837606837606 -838 keep constant 0.7606837606837606 -839 keep singleton 0.7606837606837606 -840 keep singleton 0.7606837606837606 -841 keep constant 0.7606837606837606 -842 keep singleton 0.7606837606837606 -843 keep singleton 0.7606837606837606 -844 keep singleton 0.7606837606837606 -845 keep singleton 0.7606837606837606 -846 keep singleton 0.7606837606837606 -847 keep constant 0.7606837606837606 -848 keep constant 0.7606837606837606 -849 keep singleton 0.7606837606837606 -850 keep constant 0.7692307692307693 -851 keep constant 0.7692307692307693 -852 keep parsimony-informative 0.7692307692307693 -853 keep constant 0.7692307692307693 -854 keep constant 0.7692307692307693 -855 keep constant 0.7692307692307693 -856 keep constant 0.7692307692307693 -857 keep constant 0.7692307692307693 -858 keep constant 0.7692307692307693 -859 keep constant 0.7692307692307693 -860 keep constant 0.7692307692307693 -861 keep constant 0.7692307692307693 -862 keep constant 0.7692307692307693 -863 keep constant 0.7692307692307693 -864 keep constant 0.7692307692307693 -865 keep constant 0.7692307692307693 -866 keep constant 0.7692307692307693 -867 keep constant 0.7692307692307693 -868 keep constant 0.7692307692307693 -869 keep constant 0.7692307692307693 -870 keep constant 0.7692307692307693 -871 keep constant 0.7692307692307693 -872 keep constant 0.7692307692307693 -873 keep parsimony-informative 0.7692307692307693 -874 keep constant 0.7692307692307693 -875 keep constant 0.7692307692307693 -876 keep constant 0.7692307692307693 -877 keep constant 0.7692307692307693 -878 keep constant 0.7692307692307693 -879 keep constant 0.7692307692307693 -880 keep constant 0.7692307692307693 -881 keep constant 0.7692307692307693 -882 keep constant 0.7692307692307693 -883 keep constant 0.7692307692307693 -884 keep constant 0.7692307692307693 -885 keep parsimony-informative 0.7692307692307693 -886 keep constant 0.7692307692307693 -887 keep constant 0.7692307692307693 -888 keep constant 0.7692307692307693 -889 keep constant 0.7692307692307693 -890 keep constant 0.7692307692307693 -891 keep constant 0.7692307692307693 -892 keep constant 0.7692307692307693 -893 keep constant 0.7692307692307693 -894 keep constant 0.7692307692307693 -895 keep constant 0.7692307692307693 -896 keep constant 0.7692307692307693 -897 keep constant 0.7692307692307693 -898 keep constant 0.7692307692307693 -899 keep constant 0.7692307692307693 -900 keep constant 0.7692307692307693 -901 keep constant 0.7692307692307693 -902 keep constant 0.7692307692307693 -903 keep parsimony-informative 0.7692307692307693 -904 keep constant 0.7692307692307693 -905 keep constant 0.7692307692307693 -906 keep constant 0.7692307692307693 -907 keep constant 0.7692307692307693 -908 keep constant 0.7692307692307693 -909 keep constant 0.7692307692307693 -910 keep constant 0.7692307692307693 -911 keep constant 0.7692307692307693 -912 keep constant 0.7692307692307693 -913 keep constant 0.7692307692307693 -914 keep constant 0.7692307692307693 -915 keep constant 0.7692307692307693 -916 keep constant 0.7692307692307693 -917 keep constant 0.7692307692307693 -918 keep constant 0.7692307692307693 -919 keep constant 0.7692307692307693 -920 keep constant 0.7692307692307693 -921 keep constant 0.7692307692307693 -922 keep constant 0.7692307692307693 -923 keep constant 0.7692307692307693 -924 keep singleton 0.7692307692307693 -925 keep constant 0.7692307692307693 -926 keep constant 0.7692307692307693 -927 keep constant 0.7692307692307693 -928 keep constant 0.7692307692307693 -929 keep constant 0.7692307692307693 -930 keep parsimony-informative 0.7692307692307693 -931 keep parsimony-informative 0.6666666666666666 -932 keep constant 0.6666666666666666 -933 keep parsimony-informative 0.6666666666666666 -934 keep parsimony-informative 0.6666666666666666 -935 keep constant 0.6666666666666666 -936 keep parsimony-informative 0.6666666666666666 -937 keep parsimony-informative 0.6666666666666666 -938 keep constant 0.6666666666666666 -939 keep parsimony-informative 0.6666666666666666 -940 keep constant 0.6666666666666666 -941 keep constant 0.6666666666666666 -942 keep parsimony-informative 0.6666666666666666 -943 keep parsimony-informative 0.6666666666666666 -944 keep parsimony-informative 0.6666666666666666 -945 keep parsimony-informative 0.6666666666666666 -946 keep constant 0.7692307692307693 -947 keep constant 0.7692307692307693 -948 keep constant 0.7692307692307693 -949 keep constant 0.7692307692307693 -950 keep constant 0.7692307692307693 -951 keep constant 0.7692307692307693 -952 keep constant 0.7692307692307693 -953 keep constant 0.7692307692307693 -954 keep constant 0.7692307692307693 -955 keep constant 0.7692307692307693 -956 keep constant 0.7692307692307693 -957 keep constant 0.7692307692307693 -958 keep constant 0.7692307692307693 -959 keep constant 0.7692307692307693 -960 keep constant 0.7692307692307693 -961 keep constant 0.7692307692307693 -962 keep constant 0.7692307692307693 -963 keep constant 0.7692307692307693 -964 keep constant 0.7692307692307693 -965 keep constant 0.7692307692307693 -966 keep constant 0.7692307692307693 -967 keep constant 0.7692307692307693 -968 keep constant 0.7692307692307693 -969 keep constant 0.7692307692307693 -970 keep constant 0.7692307692307693 -971 keep constant 0.7692307692307693 -972 keep constant 0.7692307692307693 -973 keep constant 0.7692307692307693 -974 keep constant 0.7692307692307693 -975 keep constant 0.7692307692307693 -976 keep constant 0.7692307692307693 -977 keep constant 0.7692307692307693 -978 keep constant 0.7692307692307693 -979 keep constant 0.7692307692307693 -980 keep constant 0.7692307692307693 -981 keep constant 0.7692307692307693 -982 keep constant 0.7692307692307693 -983 keep constant 0.7692307692307693 -984 keep constant 0.7692307692307693 -985 keep constant 0.7692307692307693 -986 keep constant 0.7692307692307693 -987 keep constant 0.7692307692307693 -988 keep constant 0.7692307692307693 -989 keep constant 0.7692307692307693 -990 keep parsimony-informative 0.7692307692307693 -991 keep constant 0.7692307692307693 -992 keep constant 0.7692307692307693 -993 keep constant 0.7692307692307693 -994 keep constant 0.7606837606837606 -995 keep constant 0.7606837606837606 -996 keep constant 0.7606837606837606 -997 keep parsimony-informative 0.7606837606837606 -998 keep constant 0.7606837606837606 -999 keep singleton 0.7606837606837606 -1000 keep constant 0.7692307692307693 -1001 keep constant 0.7692307692307693 -1002 keep constant 0.7692307692307693 -1003 keep constant 0.7692307692307693 -1004 keep constant 0.7692307692307693 -1005 keep constant 0.7692307692307693 -1006 keep constant 0.7692307692307693 -1007 keep constant 0.7692307692307693 -1008 keep constant 0.7692307692307693 -1009 keep constant 0.7692307692307693 -1010 keep constant 0.7692307692307693 -1011 keep constant 0.7692307692307693 -1012 keep constant 0.7692307692307693 -1013 keep constant 0.7692307692307693 -1014 keep constant 0.7692307692307693 -1015 keep constant 0.7692307692307693 -1016 keep constant 0.7692307692307693 -1017 keep constant 0.7692307692307693 -1018 keep constant 0.7692307692307693 -1019 keep constant 0.7692307692307693 -1020 keep constant 0.7692307692307693 -1021 keep constant 0.7692307692307693 -1022 keep constant 0.7692307692307693 -1023 keep constant 0.7692307692307693 -1024 keep constant 0.7692307692307693 -1025 keep constant 0.7692307692307693 -1026 keep constant 0.7692307692307693 -1027 keep singleton 0.7692307692307693 -1028 keep singleton 0.7692307692307693 -1029 keep singleton 0.7692307692307693 -1030 keep singleton 0.7606837606837606 -1031 keep singleton 0.7606837606837606 -1032 keep singleton 0.7606837606837606 -1033 keep constant 0.7692307692307693 -1034 keep constant 0.7692307692307693 -1035 keep singleton 0.7692307692307693 -1036 keep constant 0.7692307692307693 -1037 keep singleton 0.7692307692307693 -1038 keep singleton 0.7692307692307693 -1039 keep singleton 0.7692307692307693 -1040 keep singleton 0.7692307692307693 -1041 keep singleton 0.7692307692307693 -1042 keep constant 0.7692307692307693 -1043 keep constant 0.7692307692307693 -1044 keep constant 0.7692307692307693 -1045 keep constant 0.8205128205128205 -1046 keep constant 0.8205128205128205 -1047 keep constant 0.8205128205128205 -1048 keep constant 0.8205128205128205 -1049 keep constant 0.8205128205128205 -1050 keep parsimony-informative 0.8205128205128205 -1051 keep constant 0.8376068376068376 -1052 keep constant 0.8376068376068376 -1053 keep constant 0.8376068376068376 -1054 keep constant 0.8376068376068376 -1055 keep constant 0.8376068376068376 -1056 keep singleton 0.8376068376068376 -1057 keep constant 0.8376068376068376 -1058 keep constant 0.8376068376068376 -1059 keep constant 0.8376068376068376 -1060 keep constant 0.8376068376068376 -1061 keep constant 0.8376068376068376 -1062 keep constant 0.8376068376068376 -1063 keep constant 0.8376068376068376 -1064 keep constant 0.8376068376068376 -1065 keep constant 0.8376068376068376 -1066 keep constant 0.8376068376068376 -1067 keep constant 0.8376068376068376 -1068 keep constant 0.8376068376068376 -1069 keep constant 0.8717948717948718 -1070 keep constant 0.8717948717948718 -1071 keep constant 0.8717948717948718 -1072 keep constant 0.8717948717948718 -1073 keep constant 0.8717948717948718 -1074 keep constant 0.8717948717948718 -1075 keep constant 0.8717948717948718 -1076 keep constant 0.8717948717948718 -1077 keep constant 0.8717948717948718 -1078 keep constant 0.8717948717948718 -1079 keep constant 0.8717948717948718 -1080 keep constant 0.8717948717948718 -1081 keep constant 0.8717948717948718 -1082 keep constant 0.8717948717948718 -1083 keep constant 0.8717948717948718 -1084 keep constant 0.8803418803418803 -1085 keep constant 0.8803418803418803 -1086 keep singleton 0.8803418803418803 -1087 trim constant 0.9487179487179487 -1088 trim constant 0.9487179487179487 -1089 trim constant 0.9487179487179487 -1090 trim constant 0.9487179487179487 -1091 trim constant 0.9487179487179487 -1092 trim constant 0.9487179487179487 -1093 trim constant 0.9487179487179487 -1094 trim constant 0.9487179487179487 -1095 trim constant 0.9487179487179487 -1096 trim constant 0.9487179487179487 -1097 trim constant 0.9487179487179487 -1098 trim constant 0.9487179487179487 -1099 trim constant 0.9487179487179487 -1100 trim constant 0.9487179487179487 -1101 trim constant 0.9487179487179487 -1102 trim constant 0.9487179487179487 -1103 trim constant 0.9487179487179487 -1104 trim constant 0.9487179487179487 -1105 trim constant 0.9487179487179487 -1106 trim constant 0.9487179487179487 -1107 trim constant 0.9487179487179487 -1108 trim constant 0.9316239316239316 -1109 trim constant 0.9316239316239316 -1110 trim constant 0.9316239316239316 -1111 trim constant 0.9316239316239316 -1112 trim constant 0.9316239316239316 -1113 trim constant 0.9316239316239316 -1114 keep parsimony-informative 0.8888888888888888 -1115 keep constant 0.8888888888888888 -1116 keep parsimony-informative 0.8888888888888888 -1117 keep parsimony-informative 0.8888888888888888 -1118 keep parsimony-informative 0.8888888888888888 -1119 keep constant 0.8888888888888888 -1120 keep parsimony-informative 0.8888888888888888 -1121 keep constant 0.8888888888888888 -1122 keep parsimony-informative 0.8888888888888888 -1123 keep constant 0.8888888888888888 -1124 keep constant 0.8888888888888888 -1125 keep parsimony-informative 0.8888888888888888 -1126 keep parsimony-informative 0.8888888888888888 -1127 keep constant 0.8888888888888888 -1128 keep parsimony-informative 0.8888888888888888 -1129 keep parsimony-informative 0.8888888888888888 -1130 keep constant 0.8888888888888888 -1131 keep parsimony-informative 0.8888888888888888 -1132 keep parsimony-informative 0.8888888888888888 -1133 keep parsimony-informative 0.8888888888888888 -1134 keep constant 0.8888888888888888 -1135 keep parsimony-informative 0.8888888888888888 -1136 keep parsimony-informative 0.8888888888888888 -1137 keep parsimony-informative 0.8888888888888888 -1138 trim constant 0.9572649572649573 -1139 trim constant 0.9572649572649573 -1140 trim constant 0.9572649572649573 -1141 trim constant 0.9572649572649573 -1142 trim constant 0.9572649572649573 -1143 trim constant 0.9572649572649573 -1144 trim constant 0.9572649572649573 -1145 trim constant 0.9572649572649573 -1146 trim constant 0.9572649572649573 -1147 trim constant 0.9572649572649573 -1148 trim constant 0.9572649572649573 -1149 trim constant 0.9572649572649573 -1150 trim constant 0.9572649572649573 -1151 trim constant 0.9572649572649573 -1152 trim constant 0.9572649572649573 -1153 keep constant 0.8803418803418803 -1154 keep constant 0.8803418803418803 -1155 keep parsimony-informative 0.8803418803418803 -1156 keep constant 0.8803418803418803 -1157 keep constant 0.8803418803418803 -1158 keep constant 0.8803418803418803 -1159 keep constant 0.8803418803418803 -1160 keep constant 0.8803418803418803 -1161 keep parsimony-informative 0.8803418803418803 -1162 keep parsimony-informative 0.8803418803418803 -1163 keep parsimony-informative 0.8803418803418803 -1164 keep parsimony-informative 0.8803418803418803 -1165 keep parsimony-informative 0.8803418803418803 -1166 keep constant 0.8803418803418803 -1167 keep parsimony-informative 0.8803418803418803 -1168 trim constant 0.9316239316239316 -1169 trim constant 0.9316239316239316 -1170 trim constant 0.9316239316239316 -1171 trim constant 0.9316239316239316 -1172 trim constant 0.9316239316239316 -1173 trim constant 0.9316239316239316 -1174 trim constant 0.9316239316239316 -1175 trim constant 0.9316239316239316 -1176 trim constant 0.9316239316239316 -1177 trim constant 0.9316239316239316 -1178 trim constant 0.9316239316239316 -1179 trim constant 0.9316239316239316 -1180 trim constant 0.9316239316239316 -1181 trim constant 0.9316239316239316 -1182 trim constant 0.9316239316239316 -1183 trim constant 0.9316239316239316 -1184 trim constant 0.9316239316239316 -1185 trim constant 0.9316239316239316 -1186 trim constant 0.9316239316239316 -1187 trim constant 0.9316239316239316 -1188 trim constant 0.9316239316239316 -1189 trim constant 0.9316239316239316 -1190 trim constant 0.9316239316239316 -1191 trim constant 0.9316239316239316 -1192 trim constant 0.9230769230769231 -1193 trim constant 0.9230769230769231 -1194 trim singleton 0.9230769230769231 -1195 trim constant 0.9230769230769231 -1196 trim constant 0.9230769230769231 -1197 trim singleton 0.9230769230769231 -1198 trim singleton 0.9230769230769231 -1199 trim singleton 0.9230769230769231 -1200 trim constant 0.9230769230769231 -1201 trim singleton 0.9230769230769231 -1202 trim constant 0.9230769230769231 -1203 trim singleton 0.9230769230769231 -1204 trim constant 0.9230769230769231 -1205 trim singleton 0.9230769230769231 -1206 trim singleton 0.9230769230769231 -1207 trim singleton 0.9230769230769231 -1208 trim constant 0.9230769230769231 -1209 trim constant 0.9230769230769231 -1210 keep singleton 0.8717948717948718 -1211 keep constant 0.8717948717948718 -1212 keep parsimony-informative 0.8717948717948718 -1213 keep parsimony-informative 0.8717948717948718 -1214 keep singleton 0.8717948717948718 -1215 keep constant 0.8717948717948718 -1216 keep parsimony-informative 0.8717948717948718 -1217 keep constant 0.8717948717948718 -1218 keep parsimony-informative 0.8717948717948718 -1219 keep parsimony-informative 0.8717948717948718 -1220 keep constant 0.8717948717948718 -1221 keep parsimony-informative 0.8717948717948718 -1222 keep parsimony-informative 0.8717948717948718 -1223 keep parsimony-informative 0.8717948717948718 -1224 keep singleton 0.8717948717948718 -1225 keep constant 0.8803418803418803 -1226 keep parsimony-informative 0.8803418803418803 -1227 keep parsimony-informative 0.8803418803418803 -1228 keep parsimony-informative 0.8803418803418803 -1229 keep constant 0.8803418803418803 -1230 keep parsimony-informative 0.8803418803418803 -1231 keep constant 0.8803418803418803 -1232 keep parsimony-informative 0.8803418803418803 -1233 keep constant 0.8803418803418803 -1234 keep constant 0.8803418803418803 -1235 keep constant 0.8803418803418803 -1236 keep parsimony-informative 0.8803418803418803 -1237 keep constant 0.8803418803418803 -1238 keep constant 0.8803418803418803 -1239 keep parsimony-informative 0.8803418803418803 -1240 keep parsimony-informative 0.8803418803418803 -1241 keep constant 0.8803418803418803 -1242 keep parsimony-informative 0.8803418803418803 -1243 keep constant 0.8803418803418803 -1244 keep constant 0.8803418803418803 -1245 keep parsimony-informative 0.8803418803418803 -1246 keep parsimony-informative 0.8803418803418803 -1247 keep parsimony-informative 0.8803418803418803 -1248 keep parsimony-informative 0.8803418803418803 -1249 keep parsimony-informative 0.8803418803418803 -1250 keep parsimony-informative 0.8803418803418803 -1251 keep parsimony-informative 0.8803418803418803 -1252 trim constant 0.9487179487179487 -1253 trim constant 0.9487179487179487 -1254 trim constant 0.9487179487179487 -1255 trim constant 0.9487179487179487 -1256 trim constant 0.9487179487179487 -1257 trim constant 0.9487179487179487 -1258 trim constant 0.9487179487179487 -1259 trim constant 0.9487179487179487 -1260 trim constant 0.9487179487179487 -1261 trim constant 0.9487179487179487 -1262 trim constant 0.9487179487179487 -1263 trim constant 0.9487179487179487 -1264 trim constant 0.9487179487179487 -1265 trim constant 0.9487179487179487 -1266 trim constant 0.9487179487179487 -1267 keep constant 0.8803418803418803 -1268 keep parsimony-informative 0.8803418803418803 -1269 keep constant 0.8803418803418803 -1270 keep parsimony-informative 0.8803418803418803 -1271 keep constant 0.8803418803418803 -1272 keep constant 0.8803418803418803 -1273 keep constant 0.8803418803418803 -1274 keep constant 0.8803418803418803 -1275 keep parsimony-informative 0.8803418803418803 -1276 keep parsimony-informative 0.8803418803418803 -1277 keep parsimony-informative 0.8803418803418803 -1278 keep constant 0.8803418803418803 -1279 keep parsimony-informative 0.8803418803418803 -1280 keep constant 0.8803418803418803 -1281 keep parsimony-informative 0.8803418803418803 -1282 keep parsimony-informative 0.8632478632478633 -1283 keep singleton 0.8632478632478633 -1284 keep parsimony-informative 0.8632478632478633 -1285 keep parsimony-informative 0.8632478632478633 -1286 keep parsimony-informative 0.8632478632478633 -1287 keep parsimony-informative 0.8632478632478633 -1288 keep constant 0.8632478632478633 -1289 keep constant 0.8632478632478633 -1290 keep singleton 0.8632478632478633 -1291 trim constant 0.9316239316239316 -1292 trim constant 0.9316239316239316 -1293 trim constant 0.9316239316239316 -1294 trim constant 0.9316239316239316 -1295 trim constant 0.9316239316239316 -1296 trim constant 0.9316239316239316 -1297 trim constant 0.9316239316239316 -1298 trim constant 0.9316239316239316 -1299 trim constant 0.9316239316239316 -1300 keep constant 0.8717948717948718 -1301 keep constant 0.8717948717948718 -1302 keep parsimony-informative 0.8717948717948718 -1303 trim constant 0.9316239316239316 -1304 trim constant 0.9316239316239316 -1305 trim constant 0.9316239316239316 -1306 trim constant 0.9316239316239316 -1307 trim constant 0.9316239316239316 -1308 trim constant 0.9316239316239316 -1309 trim constant 0.9316239316239316 -1310 trim constant 0.9316239316239316 -1311 trim constant 0.9316239316239316 -1312 keep constant 0.8717948717948718 -1313 keep constant 0.8717948717948718 -1314 keep constant 0.8717948717948718 -1315 keep constant 0.8717948717948718 -1316 keep constant 0.8717948717948718 -1317 keep parsimony-informative 0.8717948717948718 -1318 trim constant 0.9316239316239316 -1319 trim constant 0.9316239316239316 -1320 trim constant 0.9316239316239316 -1321 trim constant 0.9316239316239316 -1322 trim constant 0.9316239316239316 -1323 trim constant 0.9316239316239316 -1324 trim constant 0.9316239316239316 -1325 trim constant 0.9316239316239316 -1326 trim constant 0.9316239316239316 -1327 trim constant 0.9316239316239316 -1328 trim constant 0.9316239316239316 -1329 trim constant 0.9316239316239316 -1330 trim constant 0.9316239316239316 -1331 trim constant 0.9316239316239316 -1332 trim constant 0.9316239316239316 -1333 trim constant 0.9316239316239316 -1334 trim constant 0.9316239316239316 -1335 trim constant 0.9316239316239316 -1336 keep parsimony-informative 0.8717948717948718 -1337 keep constant 0.8717948717948718 -1338 keep parsimony-informative 0.8717948717948718 -1339 keep parsimony-informative 0.7692307692307693 -1340 keep constant 0.7692307692307693 -1341 keep parsimony-informative 0.7692307692307693 -1342 keep parsimony-informative 0.7692307692307693 -1343 keep constant 0.7692307692307693 -1344 keep constant 0.7692307692307693 -1345 keep constant 0.7692307692307693 -1346 keep constant 0.7692307692307693 -1347 keep parsimony-informative 0.7692307692307693 -1348 keep constant 0.7692307692307693 -1349 keep constant 0.7692307692307693 -1350 keep parsimony-informative 0.7692307692307693 -1351 keep constant 0.7692307692307693 -1352 keep constant 0.7692307692307693 -1353 keep constant 0.7692307692307693 -1354 keep constant 0.7692307692307693 -1355 keep constant 0.7692307692307693 -1356 keep parsimony-informative 0.7692307692307693 -1357 keep constant 0.7692307692307693 -1358 keep constant 0.7692307692307693 -1359 keep singleton 0.7692307692307693 -1360 keep constant 0.7692307692307693 -1361 keep constant 0.7692307692307693 -1362 keep parsimony-informative 0.7692307692307693 -1363 keep parsimony-informative 0.7692307692307693 -1364 keep constant 0.7692307692307693 -1365 keep parsimony-informative 0.7692307692307693 -1366 keep constant 0.7692307692307693 -1367 keep constant 0.7692307692307693 -1368 keep parsimony-informative 0.7692307692307693 -1369 keep parsimony-informative 0.7692307692307693 -1370 keep parsimony-informative 0.7692307692307693 -1371 keep singleton 0.7692307692307693 -1372 keep constant 0.7692307692307693 -1373 keep constant 0.7692307692307693 -1374 keep parsimony-informative 0.7692307692307693 -1375 keep constant 0.7692307692307693 -1376 keep constant 0.7692307692307693 -1377 keep constant 0.7692307692307693 -1378 keep constant 0.7692307692307693 -1379 keep constant 0.7692307692307693 -1380 keep constant 0.7692307692307693 -1381 keep constant 0.7692307692307693 -1382 keep constant 0.7692307692307693 -1383 keep parsimony-informative 0.7692307692307693 -1384 keep parsimony-informative 0.7692307692307693 -1385 keep constant 0.7692307692307693 -1386 keep parsimony-informative 0.7692307692307693 -1387 keep constant 0.7692307692307693 -1388 keep constant 0.7692307692307693 -1389 keep parsimony-informative 0.7692307692307693 -1390 keep constant 0.7692307692307693 -1391 keep parsimony-informative 0.7692307692307693 -1392 keep parsimony-informative 0.7692307692307693 -1393 keep constant 0.7692307692307693 -1394 keep constant 0.7692307692307693 -1395 keep parsimony-informative 0.7692307692307693 -1396 keep constant 0.7692307692307693 -1397 keep constant 0.7692307692307693 -1398 keep constant 0.7692307692307693 -1399 keep constant 0.7692307692307693 -1400 keep constant 0.7692307692307693 -1401 keep parsimony-informative 0.7692307692307693 -1402 keep constant 0.7692307692307693 -1403 keep constant 0.7692307692307693 -1404 keep constant 0.7692307692307693 -1405 keep parsimony-informative 0.7692307692307693 -1406 keep constant 0.7692307692307693 -1407 keep parsimony-informative 0.7692307692307693 -1408 keep constant 0.7692307692307693 -1409 keep constant 0.7692307692307693 -1410 keep parsimony-informative 0.7692307692307693 -1411 keep constant 0.7692307692307693 -1412 keep constant 0.7692307692307693 -1413 keep singleton 0.7692307692307693 -1414 keep constant 0.7692307692307693 -1415 keep constant 0.7692307692307693 -1416 keep parsimony-informative 0.7692307692307693 -1417 keep constant 0.7692307692307693 -1418 keep constant 0.7692307692307693 -1419 keep parsimony-informative 0.7692307692307693 -1420 keep constant 0.7692307692307693 -1421 keep constant 0.7692307692307693 -1422 keep constant 0.7692307692307693 -1423 keep parsimony-informative 0.7692307692307693 -1424 keep parsimony-informative 0.7692307692307693 -1425 keep parsimony-informative 0.7692307692307693 -1426 keep constant 0.7692307692307693 -1427 keep constant 0.7692307692307693 -1428 keep parsimony-informative 0.7692307692307693 -1429 keep singleton 0.7692307692307693 -1430 keep constant 0.7692307692307693 -1431 keep parsimony-informative 0.7692307692307693 -1432 keep constant 0.7692307692307693 -1433 keep constant 0.7692307692307693 -1434 keep singleton 0.7692307692307693 -1435 keep constant 0.7692307692307693 -1436 keep constant 0.7692307692307693 -1437 keep parsimony-informative 0.7692307692307693 -1438 keep constant 0.7692307692307693 -1439 keep constant 0.7692307692307693 -1440 keep constant 0.7692307692307693 -1441 keep parsimony-informative 0.7692307692307693 -1442 keep parsimony-informative 0.7692307692307693 -1443 keep parsimony-informative 0.7692307692307693 -1444 keep constant 0.7692307692307693 -1445 keep constant 0.7692307692307693 -1446 keep constant 0.7692307692307693 -1447 keep constant 0.7692307692307693 -1448 keep constant 0.7692307692307693 -1449 keep constant 0.7692307692307693 -1450 keep constant 0.7692307692307693 -1451 keep constant 0.7692307692307693 -1452 keep constant 0.7692307692307693 -1453 keep constant 0.7692307692307693 -1454 keep constant 0.7692307692307693 -1455 keep parsimony-informative 0.7692307692307693 -1456 keep constant 0.7692307692307693 -1457 keep constant 0.7692307692307693 -1458 keep parsimony-informative 0.7692307692307693 -1459 keep constant 0.7692307692307693 -1460 keep constant 0.7692307692307693 -1461 keep singleton 0.7692307692307693 -1462 keep singleton 0.7606837606837606 -1463 keep constant 0.7606837606837606 -1464 keep parsimony-informative 0.7606837606837606 -1465 keep singleton 0.7606837606837606 -1466 keep singleton 0.7606837606837606 -1467 keep parsimony-informative 0.7606837606837606 -1468 keep singleton 0.7606837606837606 -1469 keep singleton 0.7606837606837606 -1470 keep parsimony-informative 0.7606837606837606 -1471 keep constant 0.7606837606837606 -1472 keep constant 0.7606837606837606 -1473 keep parsimony-informative 0.7606837606837606 -1474 keep constant 0.7606837606837606 -1475 keep singleton 0.7606837606837606 -1476 keep parsimony-informative 0.7606837606837606 -1477 keep constant 0.7606837606837606 -1478 keep singleton 0.7606837606837606 -1479 keep singleton 0.7606837606837606 -1480 keep singleton 0.7606837606837606 -1481 keep singleton 0.7606837606837606 -1482 keep parsimony-informative 0.7606837606837606 -1483 keep singleton 0.7606837606837606 -1484 keep singleton 0.7606837606837606 -1485 keep singleton 0.7606837606837606 -1486 keep constant 0.7606837606837606 -1487 keep constant 0.7606837606837606 -1488 keep parsimony-informative 0.7606837606837606 -1489 keep constant 0.7692307692307693 -1490 keep constant 0.7692307692307693 -1491 keep constant 0.7692307692307693 -1492 keep parsimony-informative 0.7692307692307693 -1493 keep constant 0.7692307692307693 -1494 keep parsimony-informative 0.7692307692307693 -1495 keep singleton 0.7692307692307693 -1496 keep constant 0.7692307692307693 -1497 keep constant 0.7692307692307693 -1498 keep constant 0.7692307692307693 -1499 keep constant 0.7692307692307693 -1500 keep constant 0.7692307692307693 -1501 keep constant 0.7692307692307693 -1502 keep constant 0.7692307692307693 -1503 keep constant 0.7692307692307693 -1504 keep constant 0.7692307692307693 -1505 keep constant 0.7692307692307693 -1506 keep singleton 0.7692307692307693 -1507 keep constant 0.7692307692307693 -1508 keep constant 0.7692307692307693 -1509 keep parsimony-informative 0.7692307692307693 -1510 keep constant 0.7692307692307693 -1511 keep constant 0.7692307692307693 -1512 keep parsimony-informative 0.7692307692307693 -1513 keep constant 0.7692307692307693 -1514 keep constant 0.7692307692307693 -1515 keep constant 0.7692307692307693 -1516 keep constant 0.7692307692307693 -1517 keep constant 0.7692307692307693 -1518 keep singleton 0.7692307692307693 -1519 keep constant 0.7692307692307693 -1520 keep constant 0.7692307692307693 -1521 keep parsimony-informative 0.7692307692307693 -1522 keep constant 0.7692307692307693 -1523 keep constant 0.7692307692307693 -1524 keep parsimony-informative 0.7692307692307693 -1525 keep parsimony-informative 0.7692307692307693 -1526 keep constant 0.7692307692307693 -1527 keep parsimony-informative 0.7692307692307693 -1528 keep parsimony-informative 0.7606837606837606 -1529 keep singleton 0.7606837606837606 -1530 keep parsimony-informative 0.7606837606837606 -1531 keep singleton 0.7606837606837606 -1532 keep singleton 0.7606837606837606 -1533 keep parsimony-informative 0.7606837606837606 -1534 keep constant 0.7606837606837606 -1535 keep constant 0.7606837606837606 -1536 keep singleton 0.7606837606837606 -1537 keep singleton 0.7606837606837606 -1538 keep constant 0.7606837606837606 -1539 keep parsimony-informative 0.7606837606837606 -1540 keep constant 0.7606837606837606 -1541 keep singleton 0.7606837606837606 -1542 keep parsimony-informative 0.7606837606837606 -1543 keep constant 0.7606837606837606 -1544 keep constant 0.7606837606837606 -1545 keep parsimony-informative 0.7606837606837606 -1546 keep constant 0.7692307692307693 -1547 keep parsimony-informative 0.7692307692307693 -1548 keep parsimony-informative 0.7692307692307693 -1549 keep constant 0.7692307692307693 -1550 keep constant 0.7692307692307693 -1551 keep parsimony-informative 0.7692307692307693 -1552 keep constant 0.7692307692307693 -1553 keep constant 0.7692307692307693 -1554 keep parsimony-informative 0.7692307692307693 -1555 keep constant 0.7692307692307693 -1556 keep constant 0.7692307692307693 -1557 keep parsimony-informative 0.7692307692307693 -1558 keep constant 0.7692307692307693 -1559 keep constant 0.7692307692307693 -1560 keep singleton 0.7692307692307693 -1561 keep constant 0.7692307692307693 -1562 keep constant 0.7692307692307693 -1563 keep singleton 0.7692307692307693 -1564 keep parsimony-informative 0.7692307692307693 -1565 keep constant 0.7692307692307693 -1566 keep parsimony-informative 0.7692307692307693 -1567 keep constant 0.7692307692307693 -1568 keep parsimony-informative 0.7692307692307693 -1569 keep parsimony-informative 0.7692307692307693 -1570 keep constant 0.7692307692307693 -1571 keep constant 0.7692307692307693 -1572 keep constant 0.7692307692307693 -1573 keep constant 0.7692307692307693 -1574 keep constant 0.7692307692307693 -1575 keep parsimony-informative 0.7692307692307693 -1576 keep constant 0.7692307692307693 -1577 keep constant 0.7692307692307693 -1578 keep parsimony-informative 0.7692307692307693 -1579 keep constant 0.7692307692307693 -1580 keep constant 0.7692307692307693 -1581 keep constant 0.7692307692307693 -1582 keep constant 0.7692307692307693 -1583 keep constant 0.7692307692307693 -1584 keep parsimony-informative 0.7692307692307693 -1585 keep constant 0.7692307692307693 -1586 keep constant 0.7692307692307693 -1587 keep parsimony-informative 0.7692307692307693 -1588 keep parsimony-informative 0.7692307692307693 -1589 keep parsimony-informative 0.7692307692307693 -1590 keep parsimony-informative 0.7692307692307693 -1591 keep constant 0.7692307692307693 -1592 keep constant 0.7692307692307693 -1593 keep parsimony-informative 0.7692307692307693 -1594 keep constant 0.7692307692307693 -1595 keep constant 0.7692307692307693 -1596 keep constant 0.7692307692307693 -1597 keep constant 0.7692307692307693 -1598 keep constant 0.7692307692307693 -1599 keep parsimony-informative 0.7692307692307693 -1600 keep singleton 0.7692307692307693 -1601 keep constant 0.7692307692307693 -1602 keep parsimony-informative 0.7692307692307693 -1603 keep constant 0.7692307692307693 -1604 keep parsimony-informative 0.7692307692307693 -1605 keep parsimony-informative 0.7692307692307693 -1606 keep constant 0.7692307692307693 -1607 keep constant 0.7692307692307693 -1608 keep singleton 0.7692307692307693 -1609 keep constant 0.7692307692307693 -1610 keep constant 0.7692307692307693 -1611 keep parsimony-informative 0.7692307692307693 -1612 keep singleton 0.7692307692307693 -1613 keep parsimony-informative 0.7692307692307693 -1614 keep parsimony-informative 0.7692307692307693 -1615 keep constant 0.7692307692307693 -1616 keep constant 0.7692307692307693 -1617 keep singleton 0.7692307692307693 -1618 keep constant 0.7692307692307693 -1619 keep parsimony-informative 0.7692307692307693 -1620 keep parsimony-informative 0.7692307692307693 -1621 keep parsimony-informative 0.7692307692307693 -1622 keep constant 0.7692307692307693 -1623 keep constant 0.7692307692307693 -1624 keep constant 0.7692307692307693 -1625 keep constant 0.7692307692307693 -1626 keep singleton 0.7692307692307693 -1627 keep constant 0.7692307692307693 -1628 keep constant 0.7692307692307693 -1629 keep singleton 0.7692307692307693 -1630 keep constant 0.7692307692307693 -1631 keep constant 0.7692307692307693 -1632 keep parsimony-informative 0.7692307692307693 -1633 keep parsimony-informative 0.7692307692307693 -1634 keep parsimony-informative 0.7692307692307693 -1635 keep parsimony-informative 0.7692307692307693 -1636 keep parsimony-informative 0.7692307692307693 -1637 keep constant 0.7692307692307693 -1638 keep parsimony-informative 0.7692307692307693 -1639 keep constant 0.7692307692307693 -1640 keep constant 0.7692307692307693 -1641 keep parsimony-informative 0.7692307692307693 -1642 keep singleton 0.7606837606837606 -1643 keep constant 0.7606837606837606 -1644 keep parsimony-informative 0.7606837606837606 -1645 keep singleton 0.7606837606837606 -1646 keep constant 0.7606837606837606 -1647 keep singleton 0.7606837606837606 -1648 keep constant 0.7606837606837606 -1649 keep constant 0.7606837606837606 -1650 keep parsimony-informative 0.7606837606837606 -1651 keep singleton 0.7606837606837606 -1652 keep constant 0.7606837606837606 -1653 keep constant 0.7606837606837606 -1654 keep singleton 0.7606837606837606 -1655 keep singleton 0.7606837606837606 -1656 keep singleton 0.7606837606837606 -1657 keep parsimony-informative 0.7606837606837606 -1658 keep singleton 0.7606837606837606 -1659 keep constant 0.7606837606837606 -1660 keep parsimony-informative 0.7606837606837606 -1661 keep parsimony-informative 0.7606837606837606 -1662 keep parsimony-informative 0.7606837606837606 -1663 keep constant 0.7606837606837606 -1664 keep constant 0.7606837606837606 -1665 keep parsimony-informative 0.7606837606837606 -1666 keep singleton 0.7606837606837606 -1667 keep constant 0.7606837606837606 -1668 keep parsimony-informative 0.7606837606837606 -1669 keep singleton 0.7606837606837606 -1670 keep singleton 0.7606837606837606 -1671 keep parsimony-informative 0.7606837606837606 -1672 keep singleton 0.7606837606837606 -1673 keep singleton 0.7606837606837606 -1674 keep parsimony-informative 0.7606837606837606 -1675 keep constant 0.7606837606837606 -1676 keep constant 0.7606837606837606 -1677 keep parsimony-informative 0.7606837606837606 -1678 keep parsimony-informative 0.7606837606837606 -1679 keep constant 0.7606837606837606 -1680 keep parsimony-informative 0.7606837606837606 -1681 keep singleton 0.7606837606837606 -1682 keep constant 0.7606837606837606 -1683 keep singleton 0.7606837606837606 -1684 keep singleton 0.7606837606837606 -1685 keep singleton 0.7606837606837606 -1686 keep parsimony-informative 0.7606837606837606 -1687 keep constant 0.7606837606837606 -1688 keep constant 0.7606837606837606 -1689 keep singleton 0.7606837606837606 -1690 keep singleton 0.7606837606837606 -1691 keep singleton 0.7606837606837606 -1692 keep singleton 0.7606837606837606 -1693 keep singleton 0.7606837606837606 -1694 keep singleton 0.7606837606837606 -1695 keep parsimony-informative 0.7606837606837606 -1696 keep constant 0.7606837606837606 -1697 keep singleton 0.7606837606837606 -1698 keep parsimony-informative 0.7606837606837606 -1699 keep constant 0.7606837606837606 -1700 keep constant 0.7606837606837606 -1701 keep parsimony-informative 0.7606837606837606 -1702 keep singleton 0.7606837606837606 -1703 keep parsimony-informative 0.7606837606837606 -1704 keep parsimony-informative 0.7606837606837606 -1705 keep singleton 0.7606837606837606 -1706 keep parsimony-informative 0.7606837606837606 -1707 keep singleton 0.7606837606837606 -1708 keep singleton 0.7606837606837606 -1709 keep constant 0.7606837606837606 -1710 keep parsimony-informative 0.7606837606837606 -1711 keep parsimony-informative 0.7606837606837606 -1712 keep parsimony-informative 0.7606837606837606 -1713 keep singleton 0.7606837606837606 -1714 keep constant 0.7606837606837606 -1715 keep constant 0.7606837606837606 -1716 keep parsimony-informative 0.7606837606837606 -1717 keep singleton 0.7606837606837606 -1718 keep constant 0.7606837606837606 -1719 keep singleton 0.7606837606837606 -1720 keep singleton 0.7606837606837606 -1721 keep singleton 0.7606837606837606 -1722 keep parsimony-informative 0.7606837606837606 -1723 keep constant 0.7606837606837606 -1724 keep parsimony-informative 0.7606837606837606 -1725 keep singleton 0.7606837606837606 -1726 keep singleton 0.7606837606837606 -1727 keep singleton 0.7606837606837606 -1728 keep parsimony-informative 0.7606837606837606 -1729 keep singleton 0.7606837606837606 -1730 keep constant 0.7606837606837606 -1731 keep singleton 0.7606837606837606 -1732 keep singleton 0.7606837606837606 -1733 keep singleton 0.7606837606837606 -1734 keep parsimony-informative 0.7606837606837606 -1735 keep constant 0.7606837606837606 -1736 keep constant 0.7606837606837606 -1737 keep singleton 0.7606837606837606 -1738 keep parsimony-informative 0.7606837606837606 -1739 keep singleton 0.7606837606837606 -1740 keep singleton 0.7606837606837606 -1741 keep constant 0.7692307692307693 -1742 keep constant 0.7692307692307693 -1743 keep singleton 0.7692307692307693 -1744 keep constant 0.7692307692307693 -1745 keep constant 0.7692307692307693 -1746 keep singleton 0.7692307692307693 -1747 keep constant 0.7692307692307693 -1748 keep constant 0.7692307692307693 -1749 keep singleton 0.7692307692307693 -1750 keep singleton 0.7692307692307693 -1751 keep constant 0.7692307692307693 -1752 keep parsimony-informative 0.7692307692307693 -1753 keep constant 0.7692307692307693 -1754 keep constant 0.7692307692307693 -1755 keep singleton 0.7692307692307693 -1756 keep constant 0.7692307692307693 -1757 keep constant 0.7692307692307693 -1758 keep constant 0.7692307692307693 -1759 keep parsimony-informative 0.7606837606837606 -1760 keep singleton 0.7606837606837606 -1761 keep parsimony-informative 0.7606837606837606 -1762 keep constant 0.7606837606837606 -1763 keep constant 0.7606837606837606 -1764 keep constant 0.7606837606837606 -1765 keep constant 0.7606837606837606 -1766 keep constant 0.7606837606837606 -1767 keep parsimony-informative 0.7606837606837606 -1768 keep singleton 0.7606837606837606 -1769 keep parsimony-informative 0.7606837606837606 -1770 keep singleton 0.7606837606837606 -1771 keep parsimony-informative 0.7692307692307693 -1772 keep constant 0.7692307692307693 -1773 keep parsimony-informative 0.7692307692307693 -1774 keep constant 0.7692307692307693 -1775 keep singleton 0.7692307692307693 -1776 keep singleton 0.7692307692307693 -1777 keep constant 0.7692307692307693 -1778 keep constant 0.7692307692307693 -1779 keep parsimony-informative 0.7692307692307693 -1780 keep constant 0.7692307692307693 -1781 keep parsimony-informative 0.7692307692307693 -1782 keep parsimony-informative 0.7692307692307693 -1783 keep parsimony-informative 0.7606837606837606 -1784 keep parsimony-informative 0.7606837606837606 -1785 keep singleton 0.7606837606837606 -1786 keep constant 0.7606837606837606 -1787 keep constant 0.7606837606837606 -1788 keep parsimony-informative 0.7606837606837606 -1789 keep constant 0.7606837606837606 -1790 keep singleton 0.7606837606837606 -1791 keep parsimony-informative 0.7606837606837606 -1792 keep singleton 0.7606837606837606 -1793 keep singleton 0.7606837606837606 -1794 keep parsimony-informative 0.7606837606837606 -1795 keep constant 0.7606837606837606 -1796 keep singleton 0.7606837606837606 -1797 keep parsimony-informative 0.7606837606837606 -1798 keep constant 0.7606837606837606 -1799 keep singleton 0.7606837606837606 -1800 keep constant 0.7606837606837606 -1801 keep constant 0.7606837606837606 -1802 keep singleton 0.7606837606837606 -1803 keep parsimony-informative 0.7606837606837606 -1804 keep constant 0.7606837606837606 -1805 keep constant 0.7606837606837606 -1806 keep parsimony-informative 0.7606837606837606 -1807 keep singleton 0.7606837606837606 -1808 keep singleton 0.7606837606837606 -1809 keep parsimony-informative 0.7606837606837606 -1810 keep singleton 0.7606837606837606 -1811 keep constant 0.7606837606837606 -1812 keep singleton 0.7606837606837606 -1813 keep singleton 0.7606837606837606 -1814 keep singleton 0.7606837606837606 -1815 keep parsimony-informative 0.7606837606837606 -1816 keep singleton 0.7606837606837606 -1817 keep constant 0.7606837606837606 -1818 keep parsimony-informative 0.7606837606837606 -1819 keep constant 0.7606837606837606 -1820 keep constant 0.7606837606837606 -1821 keep parsimony-informative 0.7606837606837606 -1822 keep singleton 0.7606837606837606 -1823 keep singleton 0.7606837606837606 -1824 keep singleton 0.7606837606837606 -1825 keep constant 0.7606837606837606 -1826 keep singleton 0.7606837606837606 -1827 keep parsimony-informative 0.7606837606837606 -1828 keep constant 0.7606837606837606 -1829 keep constant 0.7606837606837606 -1830 keep parsimony-informative 0.7606837606837606 -1831 keep singleton 0.7606837606837606 -1832 keep constant 0.7606837606837606 -1833 keep parsimony-informative 0.7606837606837606 -1834 keep singleton 0.7606837606837606 -1835 keep singleton 0.7606837606837606 -1836 keep parsimony-informative 0.7606837606837606 -1837 keep constant 0.7606837606837606 -1838 keep singleton 0.7606837606837606 -1839 keep parsimony-informative 0.7606837606837606 -1840 keep singleton 0.7606837606837606 -1841 keep singleton 0.7606837606837606 -1842 keep singleton 0.7606837606837606 -1843 keep parsimony-informative 0.7606837606837606 -1844 keep singleton 0.7606837606837606 -1845 keep parsimony-informative 0.7606837606837606 -1846 keep singleton 0.7606837606837606 -1847 keep singleton 0.7606837606837606 -1848 keep singleton 0.7606837606837606 -1849 keep singleton 0.7606837606837606 -1850 keep constant 0.7606837606837606 -1851 keep singleton 0.7606837606837606 -1852 trim other 0.9914529914529915 -1853 trim other 0.9914529914529915 -1854 trim other 0.9914529914529915 -1855 trim other 0.9914529914529915 -1856 trim other 0.9914529914529915 -1857 trim other 0.9914529914529915 -1858 trim other 0.9914529914529915 -1859 trim other 0.9914529914529915 -1860 trim other 0.9914529914529915 -1861 trim other 0.9914529914529915 -1862 trim other 0.9914529914529915 -1863 trim other 0.9914529914529915 -1864 trim other 0.9914529914529915 -1865 trim other 0.9914529914529915 -1866 trim other 0.9914529914529915 -1867 trim other 0.9914529914529915 -1868 trim other 0.9914529914529915 -1869 trim other 0.9914529914529915 -1870 trim other 0.9914529914529915 -1871 trim other 0.9914529914529915 -1872 trim other 0.9914529914529915 -1873 trim other 0.9914529914529915 -1874 trim other 0.9914529914529915 -1875 trim other 0.9914529914529915 -1876 trim other 0.9914529914529915 -1877 trim other 0.9914529914529915 -1878 trim other 0.9914529914529915 -1879 keep parsimony-informative 0.7606837606837606 -1880 keep constant 0.7606837606837606 -1881 keep parsimony-informative 0.7606837606837606 -1882 keep constant 0.7606837606837606 -1883 keep singleton 0.7606837606837606 -1884 keep constant 0.7606837606837606 -1885 keep singleton 0.7606837606837606 -1886 keep constant 0.7606837606837606 -1887 keep singleton 0.7606837606837606 -1888 keep parsimony-informative 0.7606837606837606 -1889 keep singleton 0.7606837606837606 -1890 keep singleton 0.7606837606837606 -1891 keep singleton 0.7606837606837606 -1892 keep singleton 0.7606837606837606 -1893 keep singleton 0.7606837606837606 -1894 keep constant 0.7606837606837606 -1895 keep singleton 0.7606837606837606 -1896 keep singleton 0.7606837606837606 -1897 keep parsimony-informative 0.7606837606837606 -1898 keep singleton 0.7606837606837606 -1899 keep parsimony-informative 0.7606837606837606 -1900 keep constant 0.7606837606837606 -1901 keep parsimony-informative 0.7606837606837606 -1902 keep parsimony-informative 0.7606837606837606 -1903 keep singleton 0.7606837606837606 -1904 keep constant 0.7606837606837606 -1905 keep singleton 0.7606837606837606 -1906 keep singleton 0.7606837606837606 -1907 keep singleton 0.7606837606837606 -1908 keep parsimony-informative 0.7606837606837606 -1909 keep parsimony-informative 0.7606837606837606 -1910 keep parsimony-informative 0.7606837606837606 -1911 keep constant 0.7606837606837606 -1912 keep parsimony-informative 0.7606837606837606 -1913 keep parsimony-informative 0.7606837606837606 -1914 keep parsimony-informative 0.7606837606837606 -1915 keep singleton 0.7606837606837606 -1916 keep parsimony-informative 0.7606837606837606 -1917 keep singleton 0.7606837606837606 -1918 keep singleton 0.7606837606837606 -1919 keep singleton 0.7606837606837606 -1920 keep parsimony-informative 0.7606837606837606 -1921 keep constant 0.7606837606837606 -1922 keep constant 0.7606837606837606 -1923 keep parsimony-informative 0.7606837606837606 -1924 keep parsimony-informative 0.7606837606837606 -1925 keep parsimony-informative 0.7606837606837606 -1926 keep parsimony-informative 0.7606837606837606 -1927 keep parsimony-informative 0.7606837606837606 -1928 keep parsimony-informative 0.7606837606837606 -1929 keep parsimony-informative 0.7606837606837606 -1930 keep parsimony-informative 0.7606837606837606 -1931 keep singleton 0.7606837606837606 -1932 keep parsimony-informative 0.7606837606837606 -1933 keep parsimony-informative 0.7606837606837606 -1934 keep constant 0.7606837606837606 -1935 keep singleton 0.7606837606837606 -1936 keep constant 0.7606837606837606 -1937 keep singleton 0.7606837606837606 -1938 keep singleton 0.7606837606837606 -1939 keep parsimony-informative 0.7606837606837606 -1940 keep singleton 0.7606837606837606 -1941 keep constant 0.7606837606837606 -1942 keep constant 0.7606837606837606 -1943 keep singleton 0.7606837606837606 -1944 keep parsimony-informative 0.7606837606837606 -1945 keep constant 0.7606837606837606 -1946 keep singleton 0.7606837606837606 -1947 keep singleton 0.7606837606837606 -1948 keep singleton 0.7606837606837606 -1949 keep parsimony-informative 0.7606837606837606 -1950 keep parsimony-informative 0.7606837606837606 -1951 keep constant 0.7606837606837606 -1952 keep constant 0.7606837606837606 -1953 keep parsimony-informative 0.7606837606837606 -1954 keep constant 0.7606837606837606 -1955 keep constant 0.7606837606837606 -1956 keep parsimony-informative 0.7606837606837606 -1957 keep constant 0.7606837606837606 -1958 keep constant 0.7606837606837606 -1959 keep singleton 0.7606837606837606 -1960 keep singleton 0.7606837606837606 -1961 keep singleton 0.7606837606837606 -1962 keep parsimony-informative 0.7606837606837606 -1963 keep singleton 0.7606837606837606 -1964 keep constant 0.7606837606837606 -1965 keep parsimony-informative 0.7606837606837606 -1966 keep parsimony-informative 0.7606837606837606 -1967 keep constant 0.7606837606837606 -1968 keep parsimony-informative 0.7606837606837606 -1969 keep singleton 0.7606837606837606 -1970 keep constant 0.7606837606837606 -1971 keep parsimony-informative 0.7606837606837606 -1972 keep parsimony-informative 0.7606837606837606 -1973 keep singleton 0.7606837606837606 -1974 keep parsimony-informative 0.7606837606837606 -1975 keep constant 0.7606837606837606 -1976 keep constant 0.7606837606837606 -1977 keep singleton 0.7606837606837606 -1978 keep constant 0.7606837606837606 -1979 keep constant 0.7606837606837606 -1980 keep parsimony-informative 0.7606837606837606 -1981 keep constant 0.7606837606837606 -1982 keep constant 0.7606837606837606 -1983 keep parsimony-informative 0.7606837606837606 -1984 keep constant 0.7692307692307693 -1985 keep constant 0.7692307692307693 -1986 keep parsimony-informative 0.7692307692307693 -1987 keep constant 0.7692307692307693 -1988 keep constant 0.7692307692307693 -1989 keep constant 0.7692307692307693 -1990 keep constant 0.7692307692307693 -1991 keep parsimony-informative 0.7692307692307693 -1992 keep constant 0.7692307692307693 -1993 keep constant 0.7692307692307693 -1994 keep constant 0.7692307692307693 -1995 keep parsimony-informative 0.7692307692307693 -1996 keep constant 0.7692307692307693 -1997 keep constant 0.7692307692307693 -1998 keep parsimony-informative 0.7692307692307693 -1999 keep constant 0.7692307692307693 -2000 keep constant 0.7692307692307693 -2001 keep constant 0.7692307692307693 -2002 keep constant 0.7606837606837606 -2003 keep constant 0.7606837606837606 -2004 keep parsimony-informative 0.7606837606837606 -2005 keep constant 0.7692307692307693 -2006 keep constant 0.7692307692307693 -2007 keep constant 0.7692307692307693 -2008 keep constant 0.7692307692307693 -2009 keep parsimony-informative 0.7692307692307693 -2010 keep parsimony-informative 0.7692307692307693 -2011 keep constant 0.7692307692307693 -2012 keep constant 0.7692307692307693 -2013 keep parsimony-informative 0.7692307692307693 -2014 keep parsimony-informative 0.7606837606837606 -2015 keep singleton 0.7606837606837606 -2016 keep singleton 0.7606837606837606 -2017 keep parsimony-informative 0.7606837606837606 -2018 keep constant 0.7606837606837606 -2019 keep parsimony-informative 0.7606837606837606 -2020 keep parsimony-informative 0.7606837606837606 -2021 keep singleton 0.7606837606837606 -2022 keep parsimony-informative 0.7606837606837606 -2023 keep constant 0.7606837606837606 -2024 keep constant 0.7606837606837606 -2025 keep parsimony-informative 0.7606837606837606 -2026 keep parsimony-informative 0.7692307692307693 -2027 keep constant 0.7692307692307693 -2028 keep parsimony-informative 0.7692307692307693 -2029 keep parsimony-informative 0.7692307692307693 -2030 keep constant 0.7692307692307693 -2031 keep parsimony-informative 0.7692307692307693 -2032 keep constant 0.7692307692307693 -2033 keep constant 0.7692307692307693 -2034 keep parsimony-informative 0.7692307692307693 -2035 keep constant 0.7692307692307693 -2036 keep constant 0.7692307692307693 -2037 keep constant 0.7692307692307693 -2038 keep constant 0.7692307692307693 -2039 keep constant 0.7692307692307693 -2040 keep parsimony-informative 0.7692307692307693 -2041 keep constant 0.7692307692307693 -2042 keep constant 0.7692307692307693 -2043 keep parsimony-informative 0.7692307692307693 -2044 keep constant 0.7692307692307693 -2045 keep constant 0.7692307692307693 -2046 keep constant 0.7692307692307693 -2047 keep parsimony-informative 0.7692307692307693 -2048 keep constant 0.7692307692307693 -2049 keep singleton 0.7692307692307693 -2050 keep parsimony-informative 0.7692307692307693 -2051 keep constant 0.7692307692307693 -2052 keep singleton 0.7692307692307693 -2053 keep constant 0.7692307692307693 -2054 keep constant 0.7692307692307693 -2055 keep parsimony-informative 0.7692307692307693 -2056 keep constant 0.7692307692307693 -2057 keep constant 0.7692307692307693 -2058 keep constant 0.7692307692307693 -2059 keep constant 0.7692307692307693 -2060 keep constant 0.7692307692307693 -2061 keep parsimony-informative 0.7692307692307693 -2062 keep constant 0.7692307692307693 -2063 keep constant 0.7692307692307693 -2064 keep singleton 0.7692307692307693 -2065 keep parsimony-informative 0.10256410256410256 -2066 keep parsimony-informative 0.10256410256410256 -2067 keep parsimony-informative 0.10256410256410256 -2068 keep parsimony-informative 0.10256410256410256 -2069 keep parsimony-informative 0.10256410256410256 -2070 keep parsimony-informative 0.10256410256410256 -2071 keep singleton 0.7606837606837606 -2072 keep constant 0.7606837606837606 -2073 keep parsimony-informative 0.7606837606837606 -2074 keep constant 0.7692307692307693 -2075 keep constant 0.7692307692307693 -2076 keep parsimony-informative 0.7692307692307693 -2077 keep constant 0.7692307692307693 -2078 keep constant 0.7692307692307693 -2079 keep parsimony-informative 0.7692307692307693 -2080 keep constant 0.7692307692307693 -2081 keep constant 0.7692307692307693 -2082 keep constant 0.7692307692307693 -2083 keep constant 0.7692307692307693 -2084 keep constant 0.7692307692307693 -2085 keep parsimony-informative 0.7692307692307693 -2086 keep constant 0.7692307692307693 -2087 keep constant 0.7692307692307693 -2088 keep parsimony-informative 0.7692307692307693 -2089 keep constant 0.7692307692307693 -2090 keep constant 0.7692307692307693 -2091 keep singleton 0.7692307692307693 -2092 keep constant 0.7692307692307693 -2093 keep constant 0.7692307692307693 -2094 keep parsimony-informative 0.7692307692307693 -2095 keep constant 0.7692307692307693 -2096 keep constant 0.7692307692307693 -2097 keep constant 0.7692307692307693 -2098 keep constant 0.7692307692307693 -2099 keep constant 0.7692307692307693 -2100 keep constant 0.7692307692307693 -2101 keep constant 0.7692307692307693 -2102 keep constant 0.7692307692307693 -2103 keep constant 0.7692307692307693 -2104 keep constant 0.7692307692307693 -2105 keep constant 0.7692307692307693 -2106 keep singleton 0.7692307692307693 -2107 keep constant 0.7692307692307693 -2108 keep constant 0.7692307692307693 -2109 keep parsimony-informative 0.7692307692307693 -2110 keep parsimony-informative 0.7692307692307693 -2111 keep constant 0.7692307692307693 -2112 keep parsimony-informative 0.7692307692307693 -2113 keep constant 0.7692307692307693 -2114 keep constant 0.7692307692307693 -2115 keep constant 0.7692307692307693 -2116 keep constant 0.7692307692307693 -2117 keep constant 0.7692307692307693 -2118 keep constant 0.7692307692307693 -2119 keep constant 0.7692307692307693 -2120 keep constant 0.7692307692307693 -2121 keep constant 0.7692307692307693 -2122 keep parsimony-informative 0.7692307692307693 -2123 keep constant 0.7692307692307693 -2124 keep parsimony-informative 0.7692307692307693 -2125 keep constant 0.7692307692307693 -2126 keep constant 0.7692307692307693 -2127 keep singleton 0.7692307692307693 -2128 keep constant 0.7692307692307693 -2129 keep constant 0.7692307692307693 -2130 keep parsimony-informative 0.7692307692307693 -2131 keep constant 0.7692307692307693 -2132 keep constant 0.7692307692307693 -2133 keep parsimony-informative 0.7692307692307693 -2134 keep constant 0.7692307692307693 -2135 keep constant 0.7692307692307693 -2136 keep constant 0.7692307692307693 -2137 keep constant 0.7692307692307693 -2138 keep constant 0.7692307692307693 -2139 keep singleton 0.7692307692307693 -2140 keep singleton 0.7692307692307693 -2141 keep constant 0.7692307692307693 -2142 keep parsimony-informative 0.7692307692307693 -2143 keep singleton 0.7692307692307693 -2144 keep constant 0.7692307692307693 -2145 keep parsimony-informative 0.7692307692307693 -2146 keep singleton 0.7692307692307693 -2147 keep constant 0.7692307692307693 -2148 keep parsimony-informative 0.7692307692307693 -2149 keep constant 0.7692307692307693 -2150 keep constant 0.7692307692307693 -2151 keep parsimony-informative 0.7692307692307693 -2152 keep constant 0.7692307692307693 -2153 keep constant 0.7692307692307693 -2154 keep singleton 0.7692307692307693 -2155 keep constant 0.7692307692307693 -2156 keep constant 0.7692307692307693 -2157 keep constant 0.7692307692307693 -2158 keep constant 0.7692307692307693 -2159 keep constant 0.7692307692307693 -2160 keep parsimony-informative 0.7692307692307693 -2161 keep constant 0.7692307692307693 -2162 keep constant 0.7692307692307693 -2163 keep singleton 0.7692307692307693 -2164 keep constant 0.7692307692307693 -2165 keep constant 0.7692307692307693 -2166 keep parsimony-informative 0.7692307692307693 -2167 keep constant 0.7692307692307693 -2168 keep constant 0.7692307692307693 -2169 keep parsimony-informative 0.7692307692307693 -2170 keep constant 0.7692307692307693 -2171 keep constant 0.7692307692307693 -2172 keep parsimony-informative 0.7692307692307693 -2173 keep constant 0.7692307692307693 -2174 keep constant 0.7692307692307693 -2175 keep parsimony-informative 0.7692307692307693 -2176 keep constant 0.7606837606837606 -2177 keep constant 0.7606837606837606 -2178 keep singleton 0.7606837606837606 -2179 keep constant 0.7606837606837606 -2180 keep singleton 0.7606837606837606 -2181 keep parsimony-informative 0.7606837606837606 -2182 keep singleton 0.7606837606837606 -2183 keep singleton 0.7606837606837606 -2184 keep parsimony-informative 0.7606837606837606 -2185 keep singleton 0.7606837606837606 -2186 keep singleton 0.7606837606837606 -2187 keep singleton 0.7606837606837606 -2188 keep parsimony-informative 0.7606837606837606 -2189 keep singleton 0.7606837606837606 -2190 keep parsimony-informative 0.7606837606837606 -2191 keep singleton 0.7606837606837606 -2192 keep singleton 0.7606837606837606 -2193 keep parsimony-informative 0.7606837606837606 -2194 keep constant 0.7606837606837606 -2195 keep constant 0.7606837606837606 -2196 keep singleton 0.7606837606837606 -2197 keep singleton 0.7606837606837606 -2198 keep constant 0.7606837606837606 -2199 keep singleton 0.7606837606837606 -2200 keep singleton 0.7606837606837606 -2201 keep singleton 0.7606837606837606 -2202 keep singleton 0.7606837606837606 -2203 keep singleton 0.7606837606837606 -2204 keep singleton 0.7606837606837606 -2205 keep singleton 0.7606837606837606 -2206 keep singleton 0.7606837606837606 -2207 keep singleton 0.7606837606837606 -2208 keep parsimony-informative 0.7606837606837606 -2209 keep singleton 0.7606837606837606 -2210 keep singleton 0.7606837606837606 -2211 keep parsimony-informative 0.7606837606837606 -2212 keep constant 0.7606837606837606 -2213 keep constant 0.7606837606837606 -2214 keep parsimony-informative 0.7606837606837606 -2215 keep constant 0.7606837606837606 -2216 keep constant 0.7606837606837606 -2217 keep parsimony-informative 0.7606837606837606 -2218 keep singleton 0.7606837606837606 -2219 keep constant 0.7606837606837606 -2220 keep parsimony-informative 0.7606837606837606 -2221 keep singleton 0.7606837606837606 -2222 keep singleton 0.7606837606837606 -2223 keep parsimony-informative 0.7606837606837606 -2224 keep singleton 0.7606837606837606 -2225 keep singleton 0.7606837606837606 -2226 keep parsimony-informative 0.7606837606837606 -2227 keep constant 0.7606837606837606 -2228 keep singleton 0.7606837606837606 -2229 keep singleton 0.7606837606837606 -2230 keep singleton 0.7606837606837606 -2231 keep singleton 0.7606837606837606 -2232 keep parsimony-informative 0.7606837606837606 -2233 keep constant 0.7606837606837606 -2234 keep singleton 0.7606837606837606 -2235 keep parsimony-informative 0.7606837606837606 -2236 keep parsimony-informative 0.7606837606837606 -2237 keep constant 0.7606837606837606 -2238 keep constant 0.7606837606837606 -2239 keep parsimony-informative 0.7606837606837606 -2240 keep singleton 0.7606837606837606 -2241 keep singleton 0.7606837606837606 -2242 keep constant 0.7606837606837606 -2243 keep constant 0.7606837606837606 -2244 keep parsimony-informative 0.7606837606837606 -2245 keep constant 0.7692307692307693 -2246 keep constant 0.7692307692307693 -2247 keep constant 0.7692307692307693 -2248 keep singleton 0.7692307692307693 -2249 keep constant 0.7692307692307693 -2250 keep parsimony-informative 0.7692307692307693 -2251 keep constant 0.7606837606837606 -2252 keep constant 0.7606837606837606 -2253 keep constant 0.7606837606837606 -2254 keep singleton 0.7606837606837606 -2255 keep singleton 0.7606837606837606 -2256 keep constant 0.7606837606837606 -2257 keep constant 0.7606837606837606 -2258 keep constant 0.7606837606837606 -2259 keep singleton 0.7606837606837606 -2260 keep singleton 0.7606837606837606 -2261 keep singleton 0.7606837606837606 -2262 keep singleton 0.7606837606837606 -2263 keep constant 0.7606837606837606 -2264 keep singleton 0.7606837606837606 -2265 keep parsimony-informative 0.7606837606837606 -2266 keep singleton 0.7606837606837606 -2267 keep constant 0.7606837606837606 -2268 keep singleton 0.7606837606837606 -2269 keep singleton 0.7606837606837606 -2270 keep singleton 0.7606837606837606 -2271 keep parsimony-informative 0.7606837606837606 -2272 keep singleton 0.7606837606837606 -2273 keep constant 0.7606837606837606 -2274 keep parsimony-informative 0.7606837606837606 -2275 keep constant 0.7606837606837606 -2276 keep singleton 0.7606837606837606 -2277 keep parsimony-informative 0.7606837606837606 -2278 keep singleton 0.7606837606837606 -2279 keep constant 0.7606837606837606 -2280 keep parsimony-informative 0.7606837606837606 -2281 keep singleton 0.7606837606837606 -2282 keep singleton 0.7606837606837606 -2283 keep parsimony-informative 0.7606837606837606 -2284 keep singleton 0.7606837606837606 -2285 keep singleton 0.7606837606837606 -2286 keep parsimony-informative 0.7606837606837606 -2287 keep singleton 0.7606837606837606 -2288 keep singleton 0.7606837606837606 -2289 keep constant 0.7606837606837606 -2290 keep singleton 0.7606837606837606 -2291 keep singleton 0.7606837606837606 -2292 keep constant 0.7606837606837606 -2293 keep constant 0.7606837606837606 -2294 keep constant 0.7606837606837606 -2295 keep parsimony-informative 0.7606837606837606 -2296 keep singleton 0.7606837606837606 -2297 keep singleton 0.7606837606837606 -2298 keep singleton 0.7606837606837606 -2299 keep singleton 0.7606837606837606 -2300 keep singleton 0.7606837606837606 -2301 keep singleton 0.7606837606837606 -2302 keep constant 0.7606837606837606 -2303 keep singleton 0.7606837606837606 -2304 keep parsimony-informative 0.7606837606837606 -2305 keep constant 0.7606837606837606 -2306 keep singleton 0.7606837606837606 -2307 keep parsimony-informative 0.7606837606837606 -2308 keep singleton 0.7606837606837606 -2309 keep singleton 0.7606837606837606 -2310 keep constant 0.7606837606837606 -2311 keep parsimony-informative 0.7606837606837606 -2312 keep singleton 0.7606837606837606 -2313 keep singleton 0.7606837606837606 -2314 keep singleton 0.7606837606837606 -2315 keep constant 0.7606837606837606 -2316 keep singleton 0.7606837606837606 -2317 keep singleton 0.7606837606837606 -2318 keep parsimony-informative 0.7606837606837606 -2319 keep parsimony-informative 0.7606837606837606 -2320 keep singleton 0.7606837606837606 -2321 keep singleton 0.7606837606837606 -2322 keep singleton 0.7606837606837606 -2323 keep singleton 0.7606837606837606 -2324 keep parsimony-informative 0.7606837606837606 -2325 keep singleton 0.7606837606837606 -2326 keep constant 0.7606837606837606 -2327 keep constant 0.7606837606837606 -2328 keep parsimony-informative 0.7606837606837606 -2329 keep singleton 0.7606837606837606 -2330 keep singleton 0.7606837606837606 -2331 keep singleton 0.7606837606837606 -2332 keep singleton 0.7606837606837606 -2333 keep singleton 0.7606837606837606 -2334 keep singleton 0.7606837606837606 -2335 keep constant 0.7606837606837606 -2336 keep constant 0.7606837606837606 -2337 keep parsimony-informative 0.7606837606837606 -2338 keep parsimony-informative 0.7606837606837606 -2339 keep singleton 0.7606837606837606 -2340 keep parsimony-informative 0.7606837606837606 -2341 keep singleton 0.7606837606837606 -2342 keep constant 0.7606837606837606 -2343 keep parsimony-informative 0.7606837606837606 -2344 keep constant 0.7606837606837606 -2345 keep constant 0.7606837606837606 -2346 keep parsimony-informative 0.7606837606837606 -2347 keep singleton 0.7606837606837606 -2348 keep singleton 0.7606837606837606 -2349 keep parsimony-informative 0.7606837606837606 -2350 keep singleton 0.7606837606837606 -2351 keep constant 0.7606837606837606 -2352 keep parsimony-informative 0.7606837606837606 -2353 keep singleton 0.7521367521367521 -2354 keep singleton 0.7521367521367521 -2355 keep parsimony-informative 0.7521367521367521 -2356 keep singleton 0.7606837606837606 -2357 keep constant 0.7606837606837606 -2358 keep parsimony-informative 0.7606837606837606 -2359 keep singleton 0.7606837606837606 -2360 keep constant 0.7606837606837606 -2361 keep singleton 0.7606837606837606 -2362 keep singleton 0.7606837606837606 -2363 keep singleton 0.7606837606837606 -2364 keep singleton 0.7606837606837606 -2365 keep singleton 0.7606837606837606 -2366 keep singleton 0.7606837606837606 -2367 keep parsimony-informative 0.7606837606837606 -2368 keep constant 0.7606837606837606 -2369 keep singleton 0.7606837606837606 -2370 keep parsimony-informative 0.7606837606837606 -2371 keep singleton 0.7606837606837606 -2372 keep singleton 0.7606837606837606 -2373 keep singleton 0.7606837606837606 -2374 keep constant 0.7606837606837606 -2375 keep constant 0.7606837606837606 -2376 keep constant 0.7606837606837606 -2377 keep singleton 0.7606837606837606 -2378 keep singleton 0.7606837606837606 -2379 keep parsimony-informative 0.7606837606837606 -2380 keep constant 0.7606837606837606 -2381 keep singleton 0.7606837606837606 -2382 keep parsimony-informative 0.7606837606837606 -2383 keep constant 0.7606837606837606 -2384 keep constant 0.7606837606837606 -2385 keep parsimony-informative 0.7606837606837606 -2386 keep singleton 0.7606837606837606 -2387 keep singleton 0.7606837606837606 -2388 keep singleton 0.7606837606837606 -2389 keep singleton 0.7606837606837606 -2390 keep constant 0.7606837606837606 -2391 keep singleton 0.7606837606837606 -2392 keep singleton 0.7606837606837606 -2393 keep singleton 0.7606837606837606 -2394 keep constant 0.7606837606837606 -2395 keep singleton 0.7606837606837606 -2396 keep singleton 0.7606837606837606 -2397 keep parsimony-informative 0.7606837606837606 -2398 keep singleton 0.7606837606837606 -2399 keep singleton 0.7606837606837606 -2400 keep singleton 0.7606837606837606 -2401 keep singleton 0.7606837606837606 -2402 keep singleton 0.7606837606837606 -2403 keep parsimony-informative 0.7606837606837606 -2404 keep constant 0.7606837606837606 -2405 keep singleton 0.7606837606837606 -2406 keep parsimony-informative 0.7606837606837606 -2407 keep constant 0.7606837606837606 -2408 keep singleton 0.7606837606837606 -2409 keep parsimony-informative 0.7606837606837606 -2410 keep constant 0.7606837606837606 -2411 keep constant 0.7606837606837606 -2412 keep parsimony-informative 0.7606837606837606 -2413 keep singleton 0.7606837606837606 -2414 keep singleton 0.7606837606837606 -2415 keep parsimony-informative 0.7606837606837606 -2416 keep singleton 0.7606837606837606 -2417 keep constant 0.7606837606837606 -2418 keep singleton 0.7606837606837606 -2419 keep constant 0.7606837606837606 -2420 keep singleton 0.7606837606837606 -2421 keep parsimony-informative 0.7606837606837606 -2422 keep singleton 0.7606837606837606 -2423 keep singleton 0.7606837606837606 -2424 keep constant 0.7606837606837606 -2425 keep singleton 0.7606837606837606 -2426 keep singleton 0.7606837606837606 -2427 keep parsimony-informative 0.7606837606837606 -2428 keep constant 0.7606837606837606 -2429 keep parsimony-informative 0.7606837606837606 -2430 keep parsimony-informative 0.7606837606837606 -2431 keep singleton 0.7606837606837606 -2432 keep singleton 0.7606837606837606 -2433 keep parsimony-informative 0.7606837606837606 -2434 keep singleton 0.7606837606837606 -2435 keep singleton 0.7606837606837606 -2436 keep singleton 0.7606837606837606 -2437 keep constant 0.7606837606837606 -2438 keep constant 0.7606837606837606 -2439 keep parsimony-informative 0.7606837606837606 -2440 keep singleton 0.7606837606837606 -2441 keep singleton 0.7606837606837606 -2442 keep parsimony-informative 0.7606837606837606 -2443 keep constant 0.7606837606837606 -2444 keep singleton 0.7606837606837606 -2445 keep parsimony-informative 0.7606837606837606 -2446 keep parsimony-informative 0.7606837606837606 -2447 keep constant 0.7606837606837606 -2448 keep parsimony-informative 0.7606837606837606 -2449 keep singleton 0.7606837606837606 -2450 keep singleton 0.7606837606837606 -2451 keep parsimony-informative 0.7606837606837606 -2452 keep parsimony-informative 0.7606837606837606 -2453 keep constant 0.7606837606837606 -2454 keep parsimony-informative 0.7606837606837606 -2455 keep constant 0.7692307692307693 -2456 keep constant 0.7692307692307693 -2457 keep singleton 0.7692307692307693 -2458 keep constant 0.7692307692307693 -2459 keep constant 0.7692307692307693 -2460 keep singleton 0.7692307692307693 -2461 keep constant 0.7692307692307693 -2462 keep constant 0.7692307692307693 -2463 keep parsimony-informative 0.7692307692307693 -2464 keep constant 0.7692307692307693 -2465 keep constant 0.7692307692307693 -2466 keep parsimony-informative 0.7692307692307693 -2467 keep constant 0.7692307692307693 -2468 keep constant 0.7692307692307693 -2469 keep parsimony-informative 0.7692307692307693 -2470 keep constant 0.7692307692307693 -2471 keep constant 0.7692307692307693 -2472 keep constant 0.7692307692307693 -2473 keep parsimony-informative 0.7606837606837606 -2474 keep constant 0.7606837606837606 -2475 keep parsimony-informative 0.7606837606837606 -2476 keep singleton 0.7606837606837606 -2477 keep constant 0.7606837606837606 -2478 keep parsimony-informative 0.7606837606837606 -2479 keep singleton 0.7606837606837606 -2480 keep singleton 0.7606837606837606 -2481 keep parsimony-informative 0.7606837606837606 -2482 keep constant 0.7606837606837606 -2483 keep constant 0.7606837606837606 -2484 keep parsimony-informative 0.7606837606837606 -2485 keep parsimony-informative 0.7606837606837606 -2486 keep constant 0.7606837606837606 -2487 keep singleton 0.7606837606837606 -2488 keep constant 0.7606837606837606 -2489 keep constant 0.7606837606837606 -2490 keep singleton 0.7606837606837606 -2491 keep constant 0.7692307692307693 -2492 keep singleton 0.7692307692307693 -2493 keep parsimony-informative 0.7692307692307693 -2494 keep constant 0.7692307692307693 -2495 keep constant 0.7692307692307693 -2496 keep constant 0.7692307692307693 -2497 keep constant 0.7692307692307693 -2498 keep constant 0.7692307692307693 -2499 keep parsimony-informative 0.7692307692307693 -2500 keep constant 0.7692307692307693 -2501 keep constant 0.7692307692307693 -2502 keep parsimony-informative 0.7692307692307693 -2503 keep constant 0.7692307692307693 -2504 keep singleton 0.7692307692307693 -2505 keep constant 0.7692307692307693 -2506 keep constant 0.7606837606837606 -2507 keep constant 0.7606837606837606 -2508 keep parsimony-informative 0.7606837606837606 -2509 keep singleton 0.7606837606837606 -2510 keep singleton 0.7606837606837606 -2511 keep parsimony-informative 0.7606837606837606 -2512 keep parsimony-informative 0.7606837606837606 -2513 keep constant 0.7606837606837606 -2514 keep parsimony-informative 0.7606837606837606 -2515 keep singleton 0.7606837606837606 -2516 keep singleton 0.7606837606837606 -2517 keep parsimony-informative 0.7606837606837606 -2518 keep singleton 0.7606837606837606 -2519 keep constant 0.7606837606837606 -2520 keep singleton 0.7606837606837606 -2521 trim other 0.9914529914529915 -2522 trim other 0.9914529914529915 -2523 trim other 0.9914529914529915 -2524 keep singleton 0.7606837606837606 -2525 keep singleton 0.7606837606837606 -2526 keep parsimony-informative 0.7606837606837606 -2527 keep constant 0.7606837606837606 -2528 keep constant 0.7606837606837606 -2529 keep parsimony-informative 0.7606837606837606 -2530 keep constant 0.7606837606837606 -2531 keep constant 0.7606837606837606 -2532 keep constant 0.7606837606837606 -2533 keep constant 0.7606837606837606 -2534 keep constant 0.7606837606837606 -2535 keep singleton 0.7606837606837606 -2536 keep singleton 0.7606837606837606 -2537 keep constant 0.7606837606837606 -2538 keep parsimony-informative 0.7606837606837606 -2539 keep constant 0.7606837606837606 -2540 keep singleton 0.7606837606837606 -2541 keep parsimony-informative 0.7606837606837606 -2542 keep constant 0.7606837606837606 -2543 keep constant 0.7606837606837606 -2544 keep parsimony-informative 0.7606837606837606 -2545 trim other 0.9914529914529915 -2546 trim other 0.9914529914529915 -2547 trim other 0.9914529914529915 -2548 trim other 0.9914529914529915 -2549 trim other 0.9914529914529915 -2550 trim other 0.9914529914529915 -2551 trim other 0.9914529914529915 -2552 trim other 0.9914529914529915 -2553 trim other 0.9914529914529915 -2554 trim other 0.9914529914529915 -2555 trim other 0.9914529914529915 -2556 trim other 0.9914529914529915 -2557 trim other 0.9914529914529915 -2558 trim other 0.9914529914529915 -2559 trim other 0.9914529914529915 -2560 trim other 0.9914529914529915 -2561 trim other 0.9914529914529915 -2562 trim other 0.9914529914529915 -2563 trim other 0.9914529914529915 -2564 trim other 0.9914529914529915 -2565 trim other 0.9914529914529915 -2566 keep singleton 0.7606837606837606 -2567 keep constant 0.7606837606837606 -2568 keep parsimony-informative 0.7606837606837606 -2569 keep singleton 0.7606837606837606 -2570 keep constant 0.7606837606837606 -2571 keep parsimony-informative 0.7606837606837606 -2572 keep constant 0.7606837606837606 -2573 keep constant 0.7606837606837606 -2574 keep parsimony-informative 0.7606837606837606 -2575 keep singleton 0.7606837606837606 -2576 keep parsimony-informative 0.7606837606837606 -2577 keep parsimony-informative 0.7606837606837606 -2578 trim other 0.9914529914529915 -2579 trim other 0.9914529914529915 -2580 trim other 0.9914529914529915 -2581 trim other 0.9914529914529915 -2582 trim other 0.9914529914529915 -2583 trim other 0.9914529914529915 -2584 trim other 0.9914529914529915 -2585 trim other 0.9914529914529915 -2586 trim other 0.9914529914529915 -2587 trim other 0.9914529914529915 -2588 trim other 0.9914529914529915 -2589 trim other 0.9914529914529915 -2590 trim other 0.9914529914529915 -2591 trim other 0.9914529914529915 -2592 trim other 0.9914529914529915 -2593 trim other 0.9914529914529915 -2594 trim other 0.9914529914529915 -2595 trim other 0.9914529914529915 -2596 trim other 0.9914529914529915 -2597 trim other 0.9914529914529915 -2598 trim other 0.9914529914529915 -2599 trim other 0.9914529914529915 -2600 trim other 0.9914529914529915 -2601 trim other 0.9914529914529915 -2602 trim other 0.9914529914529915 -2603 trim other 0.9914529914529915 -2604 trim other 0.9914529914529915 -2605 trim other 0.9914529914529915 -2606 trim other 0.9914529914529915 -2607 trim other 0.9914529914529915 -2608 trim other 0.9914529914529915 -2609 trim other 0.9914529914529915 -2610 trim other 0.9914529914529915 -2611 trim other 0.9914529914529915 -2612 trim other 0.9914529914529915 -2613 trim other 0.9914529914529915 -2614 trim other 0.9914529914529915 -2615 trim other 0.9914529914529915 -2616 trim other 0.9914529914529915 -2617 trim other 0.9914529914529915 -2618 trim other 0.9914529914529915 -2619 trim other 0.9914529914529915 -2620 keep singleton 0.7606837606837606 -2621 keep constant 0.7606837606837606 -2622 keep singleton 0.7606837606837606 -2623 keep constant 0.7606837606837606 -2624 keep constant 0.7606837606837606 -2625 keep parsimony-informative 0.7606837606837606 -2626 keep singleton 0.7606837606837606 -2627 keep singleton 0.7606837606837606 -2628 keep singleton 0.7606837606837606 -2629 keep constant 0.7606837606837606 -2630 keep constant 0.7606837606837606 -2631 keep singleton 0.7606837606837606 -2632 keep singleton 0.7606837606837606 -2633 keep constant 0.7606837606837606 -2634 keep parsimony-informative 0.7606837606837606 -2635 keep singleton 0.7606837606837606 -2636 keep singleton 0.7606837606837606 -2637 keep parsimony-informative 0.7606837606837606 -2638 keep constant 0.7606837606837606 -2639 keep constant 0.7606837606837606 -2640 keep singleton 0.7606837606837606 -2641 keep constant 0.7606837606837606 -2642 keep constant 0.7606837606837606 -2643 keep constant 0.7606837606837606 -2644 trim other 0.9914529914529915 -2645 trim other 0.9914529914529915 -2646 trim other 0.9914529914529915 -2647 trim other 0.9914529914529915 -2648 trim other 0.9914529914529915 -2649 trim other 0.9914529914529915 -2650 trim other 0.9914529914529915 -2651 trim other 0.9914529914529915 -2652 trim other 0.9914529914529915 -2653 keep singleton 0.7606837606837606 -2654 keep constant 0.7606837606837606 -2655 keep parsimony-informative 0.7606837606837606 -2656 keep singleton 0.7606837606837606 -2657 keep singleton 0.7606837606837606 -2658 keep singleton 0.7606837606837606 -2659 keep constant 0.7606837606837606 -2660 keep constant 0.7606837606837606 -2661 keep parsimony-informative 0.7606837606837606 -2662 keep constant 0.7606837606837606 -2663 keep constant 0.7606837606837606 -2664 keep singleton 0.7606837606837606 -2665 keep singleton 0.7606837606837606 -2666 keep constant 0.7606837606837606 -2667 keep singleton 0.7606837606837606 -2668 keep constant 0.7606837606837606 -2669 keep singleton 0.7606837606837606 -2670 keep singleton 0.7606837606837606 -2671 keep singleton 0.7606837606837606 -2672 keep singleton 0.7606837606837606 -2673 keep parsimony-informative 0.7606837606837606 -2674 keep singleton 0.7606837606837606 -2675 keep singleton 0.7606837606837606 -2676 keep parsimony-informative 0.7606837606837606 -2677 keep constant 0.7606837606837606 -2678 keep constant 0.7606837606837606 -2679 keep parsimony-informative 0.7606837606837606 -2680 keep singleton 0.7606837606837606 -2681 keep constant 0.7606837606837606 -2682 keep singleton 0.7606837606837606 -2683 keep constant 0.7692307692307693 -2684 keep constant 0.7692307692307693 -2685 keep parsimony-informative 0.7692307692307693 -2686 keep constant 0.7692307692307693 -2687 keep constant 0.7692307692307693 -2688 keep constant 0.7692307692307693 -2689 keep constant 0.7606837606837606 -2690 keep constant 0.7606837606837606 -2691 keep parsimony-informative 0.7606837606837606 -2692 keep constant 0.7692307692307693 -2693 keep constant 0.7692307692307693 -2694 keep parsimony-informative 0.7692307692307693 -2695 keep constant 0.7606837606837606 -2696 keep singleton 0.7606837606837606 -2697 keep singleton 0.7606837606837606 -2698 keep constant 0.7606837606837606 -2699 keep singleton 0.7606837606837606 -2700 keep parsimony-informative 0.7606837606837606 -2701 keep constant 0.7606837606837606 -2702 keep constant 0.7606837606837606 -2703 keep constant 0.7606837606837606 -2704 keep constant 0.7692307692307693 -2705 keep constant 0.7692307692307693 -2706 keep constant 0.7692307692307693 -2707 keep constant 0.7692307692307693 -2708 keep constant 0.7692307692307693 -2709 keep parsimony-informative 0.7692307692307693 -2710 keep constant 0.7692307692307693 -2711 keep constant 0.7692307692307693 -2712 keep parsimony-informative 0.7692307692307693 -2713 keep constant 0.7692307692307693 -2714 keep constant 0.7692307692307693 -2715 keep parsimony-informative 0.7692307692307693 -2716 keep constant 0.7692307692307693 -2717 keep constant 0.7692307692307693 -2718 keep parsimony-informative 0.7692307692307693 -2719 keep constant 0.7692307692307693 -2720 keep constant 0.7692307692307693 -2721 keep constant 0.7692307692307693 -2722 keep parsimony-informative 0.7692307692307693 -2723 keep parsimony-informative 0.7692307692307693 -2724 keep singleton 0.7692307692307693 -2725 keep singleton 0.7606837606837606 -2726 keep constant 0.7606837606837606 -2727 keep parsimony-informative 0.7606837606837606 -2728 keep singleton 0.7606837606837606 -2729 keep constant 0.7606837606837606 -2730 keep constant 0.7606837606837606 -2731 keep constant 0.7606837606837606 -2732 keep constant 0.7606837606837606 -2733 keep parsimony-informative 0.7606837606837606 -2734 keep singleton 0.7606837606837606 -2735 keep constant 0.7606837606837606 -2736 keep parsimony-informative 0.7606837606837606 -2737 keep singleton 0.7606837606837606 -2738 keep singleton 0.7606837606837606 -2739 keep singleton 0.7606837606837606 -2740 keep constant 0.7606837606837606 -2741 keep singleton 0.7606837606837606 -2742 keep parsimony-informative 0.7606837606837606 -2743 keep parsimony-informative 0.7606837606837606 -2744 keep constant 0.7606837606837606 -2745 keep parsimony-informative 0.7606837606837606 -2746 keep constant 0.7606837606837606 -2747 keep constant 0.7606837606837606 -2748 keep singleton 0.7606837606837606 -2749 keep constant 0.7692307692307693 -2750 keep constant 0.7692307692307693 -2751 keep parsimony-informative 0.7692307692307693 -2752 keep constant 0.7692307692307693 -2753 keep constant 0.7692307692307693 -2754 keep parsimony-informative 0.7692307692307693 -2755 keep constant 0.7692307692307693 -2756 keep constant 0.7692307692307693 -2757 keep parsimony-informative 0.7692307692307693 -2758 keep constant 0.7692307692307693 -2759 keep constant 0.7692307692307693 -2760 keep parsimony-informative 0.7692307692307693 -2761 keep constant 0.7692307692307693 -2762 keep constant 0.7692307692307693 -2763 keep singleton 0.7692307692307693 -2764 keep constant 0.7692307692307693 -2765 keep constant 0.7692307692307693 -2766 keep parsimony-informative 0.7692307692307693 -2767 keep constant 0.7692307692307693 -2768 keep constant 0.7692307692307693 -2769 keep constant 0.7692307692307693 -2770 keep constant 0.7692307692307693 -2771 keep constant 0.7692307692307693 -2772 keep constant 0.7692307692307693 -2773 keep constant 0.8034188034188035 -2774 keep constant 0.8034188034188035 -2775 keep parsimony-informative 0.8034188034188035 -2776 keep constant 0.8034188034188035 -2777 keep constant 0.8034188034188035 -2778 keep singleton 0.8034188034188035 -2779 keep parsimony-informative 0.8034188034188035 -2780 keep constant 0.8034188034188035 -2781 keep parsimony-informative 0.8034188034188035 -2782 keep constant 0.8034188034188035 -2783 keep constant 0.8034188034188035 -2784 keep parsimony-informative 0.8034188034188035 -2785 keep constant 0.8034188034188035 -2786 keep constant 0.8034188034188035 -2787 keep parsimony-informative 0.8034188034188035 -2788 keep singleton 0.8034188034188035 -2789 keep constant 0.8034188034188035 -2790 keep parsimony-informative 0.8034188034188035 -2791 keep singleton 0.8034188034188035 -2792 keep singleton 0.8034188034188035 -2793 keep parsimony-informative 0.8034188034188035 -2794 keep singleton 0.8034188034188035 -2795 keep constant 0.8034188034188035 -2796 keep constant 0.8034188034188035 -2797 keep constant 0.8034188034188035 -2798 keep constant 0.8034188034188035 -2799 keep parsimony-informative 0.8034188034188035 -2800 keep parsimony-informative 0.8034188034188035 -2801 keep constant 0.8034188034188035 -2802 keep parsimony-informative 0.8034188034188035 -2803 keep constant 0.8034188034188035 -2804 keep singleton 0.8034188034188035 -2805 keep singleton 0.8034188034188035 -2806 keep constant 0.811965811965812 -2807 keep constant 0.811965811965812 -2808 keep singleton 0.811965811965812 -2809 keep constant 0.811965811965812 -2810 keep constant 0.811965811965812 -2811 keep parsimony-informative 0.811965811965812 -2812 keep constant 0.811965811965812 -2813 keep constant 0.811965811965812 -2814 keep constant 0.811965811965812 -2815 keep constant 0.811965811965812 -2816 keep constant 0.811965811965812 -2817 keep parsimony-informative 0.811965811965812 -2818 keep constant 0.811965811965812 -2819 keep constant 0.811965811965812 -2820 keep singleton 0.811965811965812 -2821 keep constant 0.811965811965812 -2822 keep constant 0.811965811965812 -2823 keep parsimony-informative 0.811965811965812 -2824 keep constant 0.811965811965812 -2825 keep constant 0.811965811965812 -2826 keep constant 0.811965811965812 -2827 keep singleton 0.8034188034188035 -2828 keep singleton 0.8034188034188035 -2829 keep constant 0.8034188034188035 -2830 keep singleton 0.8034188034188035 -2831 keep singleton 0.8034188034188035 -2832 keep singleton 0.8034188034188035 -2833 keep singleton 0.8034188034188035 -2834 keep singleton 0.8034188034188035 -2835 keep singleton 0.8034188034188035 -2836 keep constant 0.8034188034188035 -2837 keep constant 0.8034188034188035 -2838 keep parsimony-informative 0.8034188034188035 -2839 keep singleton 0.8461538461538461 -2840 keep singleton 0.8461538461538461 -2841 keep singleton 0.8461538461538461 -2842 keep singleton 0.8461538461538461 -2843 keep parsimony-informative 0.8461538461538461 -2844 keep parsimony-informative 0.8461538461538461 -2845 keep singleton 0.8461538461538461 -2846 keep parsimony-informative 0.8461538461538461 -2847 keep parsimony-informative 0.8461538461538461 -2848 keep singleton 0.8461538461538461 -2849 keep parsimony-informative 0.8461538461538461 -2850 keep parsimony-informative 0.8461538461538461 -2851 keep singleton 0.8461538461538461 -2852 keep singleton 0.8461538461538461 -2853 keep singleton 0.8461538461538461 -2854 keep singleton 0.8461538461538461 -2855 keep singleton 0.8461538461538461 -2856 keep parsimony-informative 0.8461538461538461 -2857 keep parsimony-informative 0.8461538461538461 -2858 keep constant 0.8461538461538461 -2859 keep parsimony-informative 0.8461538461538461 -2860 keep singleton 0.8461538461538461 -2861 keep singleton 0.8461538461538461 -2862 keep singleton 0.8461538461538461 -2863 keep constant 0.8461538461538461 -2864 keep parsimony-informative 0.8461538461538461 -2865 keep singleton 0.8461538461538461 -2866 keep singleton 0.8461538461538461 -2867 keep parsimony-informative 0.8461538461538461 -2868 keep parsimony-informative 0.8461538461538461 -2869 keep singleton 0.8461538461538461 -2870 keep singleton 0.8461538461538461 -2871 keep parsimony-informative 0.8461538461538461 -2872 keep parsimony-informative 0.8461538461538461 -2873 keep constant 0.8461538461538461 -2874 keep constant 0.8461538461538461 -2875 keep singleton 0.8461538461538461 -2876 keep singleton 0.8461538461538461 -2877 keep parsimony-informative 0.8461538461538461 -2878 keep constant 0.8461538461538461 -2879 keep constant 0.8461538461538461 -2880 keep constant 0.8461538461538461 -2881 keep singleton 0.8461538461538461 -2882 keep singleton 0.8461538461538461 -2883 keep singleton 0.8461538461538461 -2884 keep singleton 0.8461538461538461 -2885 keep constant 0.8461538461538461 -2886 keep singleton 0.8461538461538461 -2887 keep parsimony-informative 0.8717948717948718 -2888 keep constant 0.8717948717948718 -2889 keep constant 0.8717948717948718 -2890 keep constant 0.8717948717948718 -2891 keep singleton 0.8717948717948718 -2892 keep parsimony-informative 0.8717948717948718 -2893 keep constant 0.8717948717948718 -2894 keep constant 0.8717948717948718 -2895 keep parsimony-informative 0.8717948717948718 -2896 keep parsimony-informative 0.8717948717948718 -2897 keep constant 0.8717948717948718 -2898 keep parsimony-informative 0.8717948717948718 -2899 keep parsimony-informative 0.8717948717948718 -2900 keep parsimony-informative 0.8717948717948718 -2901 keep parsimony-informative 0.8717948717948718 -2902 keep constant 0.8717948717948718 -2903 keep constant 0.8717948717948718 -2904 keep constant 0.8717948717948718 -2905 keep constant 0.8717948717948718 -2906 keep constant 0.8717948717948718 -2907 keep parsimony-informative 0.8717948717948718 -2908 keep constant 0.8717948717948718 -2909 keep constant 0.8717948717948718 -2910 keep parsimony-informative 0.8717948717948718 -2911 keep constant 0.8717948717948718 -2912 keep constant 0.8717948717948718 -2913 keep constant 0.8717948717948718 -2914 keep constant 0.8717948717948718 -2915 keep constant 0.8717948717948718 -2916 keep parsimony-informative 0.8717948717948718 -2917 keep constant 0.8717948717948718 -2918 keep constant 0.8717948717948718 -2919 keep parsimony-informative 0.8717948717948718 -2920 keep constant 0.8717948717948718 -2921 keep constant 0.8717948717948718 -2922 keep constant 0.8717948717948718 -2923 keep constant 0.8717948717948718 -2924 keep constant 0.8717948717948718 -2925 keep singleton 0.8717948717948718 -2926 keep singleton 0.8717948717948718 -2927 keep singleton 0.8717948717948718 -2928 keep singleton 0.8717948717948718 -2929 keep constant 0.8717948717948718 -2930 keep constant 0.8717948717948718 -2931 keep singleton 0.8717948717948718 -2932 keep constant 0.8632478632478633 -2933 keep constant 0.8632478632478633 -2934 keep singleton 0.8632478632478633 -2935 keep constant 0.8632478632478633 -2936 keep constant 0.8632478632478633 -2937 keep singleton 0.8632478632478633 -2938 keep constant 0.8632478632478633 -2939 keep constant 0.8632478632478633 -2940 keep constant 0.8632478632478633 -2941 keep singleton 0.8632478632478633 -2942 keep singleton 0.8632478632478633 -2943 keep parsimony-informative 0.8632478632478633 -2944 keep singleton 0.8632478632478633 -2945 keep singleton 0.8632478632478633 -2946 keep parsimony-informative 0.8632478632478633 -2947 keep constant 0.8632478632478633 -2948 keep constant 0.8632478632478633 -2949 keep singleton 0.8632478632478633 -2950 keep singleton 0.8632478632478633 -2951 keep constant 0.8632478632478633 -2952 keep parsimony-informative 0.8632478632478633 -2953 keep singleton 0.8632478632478633 -2954 keep singleton 0.8632478632478633 -2955 keep parsimony-informative 0.8632478632478633 -2956 keep singleton 0.8632478632478633 -2957 keep singleton 0.8632478632478633 -2958 keep singleton 0.8632478632478633 -2959 keep singleton 0.8632478632478633 -2960 keep singleton 0.8632478632478633 -2961 keep singleton 0.8632478632478633 -2962 keep constant 0.8632478632478633 -2963 keep singleton 0.8632478632478633 -2964 keep singleton 0.8632478632478633 -2965 keep constant 0.8632478632478633 -2966 keep constant 0.8632478632478633 -2967 keep singleton 0.8632478632478633 -2968 keep parsimony-informative 0.8717948717948718 -2969 keep constant 0.8717948717948718 -2970 keep singleton 0.8717948717948718 -2971 keep constant 0.8717948717948718 -2972 keep constant 0.8717948717948718 -2973 keep constant 0.8717948717948718 -2974 keep constant 0.8717948717948718 -2975 keep constant 0.8717948717948718 -2976 keep parsimony-informative 0.8717948717948718 -2977 keep parsimony-informative 0.8717948717948718 -2978 keep constant 0.8717948717948718 -2979 keep parsimony-informative 0.8717948717948718 -2980 keep constant 0.8717948717948718 -2981 keep constant 0.8717948717948718 -2982 keep parsimony-informative 0.8717948717948718 -2983 keep constant 0.8717948717948718 -2984 keep constant 0.8717948717948718 -2985 keep constant 0.8717948717948718 -2986 keep singleton 0.8717948717948718 -2987 keep constant 0.8717948717948718 -2988 keep constant 0.8717948717948718 -2989 keep constant 0.8888888888888888 -2990 keep constant 0.8888888888888888 -2991 keep constant 0.8888888888888888 -2992 keep singleton 0.8888888888888888 -2993 keep constant 0.8888888888888888 -2994 keep constant 0.8888888888888888 -2995 keep constant 0.8888888888888888 -2996 keep constant 0.8888888888888888 -2997 keep constant 0.8888888888888888 -2998 keep constant 0.8888888888888888 -2999 keep parsimony-informative 0.8888888888888888 -3000 keep singleton 0.8888888888888888 -3001 keep singleton 0.8888888888888888 -3002 keep parsimony-informative 0.8888888888888888 -3003 keep singleton 0.8888888888888888 -3004 keep parsimony-informative 0.8888888888888888 -3005 keep parsimony-informative 0.8888888888888888 -3006 keep parsimony-informative 0.8888888888888888 -3007 keep parsimony-informative 0.8888888888888888 -3008 keep constant 0.8888888888888888 -3009 keep constant 0.8888888888888888 -3010 keep singleton 0.8888888888888888 -3011 keep singleton 0.8888888888888888 -3012 keep singleton 0.8888888888888888 -3013 keep constant 0.8888888888888888 -3014 keep singleton 0.8888888888888888 -3015 keep parsimony-informative 0.8888888888888888 -3016 keep constant 0.8888888888888888 -3017 keep singleton 0.8888888888888888 -3018 keep parsimony-informative 0.8888888888888888 -3019 keep singleton 0.8888888888888888 -3020 keep constant 0.8888888888888888 -3021 keep parsimony-informative 0.8888888888888888 -3022 trim constant 0.9829059829059829 -3023 trim other 0.9829059829059829 -3024 trim other 0.9829059829059829 -3025 trim other 0.9914529914529915 -3026 trim other 0.9914529914529915 -3027 trim other 0.9914529914529915 -3028 trim other 0.9914529914529915 -3029 trim other 0.9914529914529915 -3030 trim other 0.9914529914529915 -3031 trim other 0.9914529914529915 -3032 trim other 0.9914529914529915 -3033 trim other 0.9914529914529915 -3034 trim other 0.9914529914529915 -3035 trim other 0.9914529914529915 -3036 trim other 0.9914529914529915 -3037 trim other 0.9914529914529915 -3038 trim other 0.9914529914529915 -3039 trim other 0.9914529914529915 -3040 trim other 0.9914529914529915 -3041 trim other 0.9914529914529915 -3042 trim other 0.9914529914529915 -3043 trim other 0.9914529914529915 -3044 trim other 0.9914529914529915 -3045 trim other 0.9914529914529915 -3046 trim other 0.9914529914529915 -3047 trim other 0.9914529914529915 -3048 trim other 0.9914529914529915 -3049 trim other 0.9914529914529915 -3050 trim other 0.9914529914529915 -3051 trim other 0.9914529914529915 -3052 trim other 0.9914529914529915 -3053 trim other 0.9914529914529915 -3054 trim other 0.9914529914529915 -3055 trim other 0.9914529914529915 -3056 trim other 0.9914529914529915 -3057 trim other 0.9914529914529915 -3058 trim other 0.9914529914529915 -3059 trim other 0.9914529914529915 -3060 trim other 0.9914529914529915 -3061 trim other 0.9914529914529915 -3062 trim other 0.9914529914529915 -3063 trim other 0.9914529914529915 -3064 trim other 0.9914529914529915 -3065 trim other 0.9914529914529915 -3066 trim other 0.9914529914529915 -3067 trim other 0.9914529914529915 -3068 trim other 0.9914529914529915 -3069 trim other 0.9914529914529915 -3070 trim other 0.9914529914529915 -3071 trim other 0.9914529914529915 -3072 trim other 0.9914529914529915 -3073 trim other 0.9914529914529915 -3074 trim other 0.9914529914529915 -3075 trim other 0.9914529914529915 -3076 keep singleton 0.8974358974358975 -3077 keep constant 0.8974358974358975 -3078 keep singleton 0.8974358974358975 +616 keep constant 0.8462 +617 keep constant 0.8462 +618 keep constant 0.8462 +619 keep constant 0.8462 +620 keep constant 0.8462 +621 keep constant 0.8462 +622 keep constant 0.8034 +623 keep constant 0.8034 +624 keep constant 0.8034 +625 keep constant 0.8034 +626 keep constant 0.8034 +627 keep constant 0.8034 +628 keep constant 0.8034 +629 keep constant 0.8034 +630 keep constant 0.8034 +631 keep constant 0.8034 +632 keep constant 0.8034 +633 keep constant 0.8034 +634 keep parsimony-informative 0.7949 +635 keep parsimony-informative 0.7949 +636 keep parsimony-informative 0.7949 +637 keep parsimony-informative 0.7607 +638 keep parsimony-informative 0.7607 +639 keep parsimony-informative 0.7607 +640 keep parsimony-informative 0.7607 +641 keep parsimony-informative 0.7607 +642 keep parsimony-informative 0.7607 +643 keep constant 0.7692 +644 keep constant 0.7692 +645 keep constant 0.7692 +646 keep constant 0.7692 +647 keep constant 0.7692 +648 keep constant 0.7692 +649 keep constant 0.7692 +650 keep constant 0.7692 +651 keep constant 0.7692 +652 keep constant 0.7692 +653 keep constant 0.7692 +654 keep constant 0.7692 +655 trim constant 0.9829 +656 trim constant 0.9829 +657 trim constant 0.9829 +658 keep constant 0.7692 +659 keep constant 0.7692 +660 keep parsimony-informative 0.7692 +661 keep constant 0.7692 +662 keep constant 0.7692 +663 keep parsimony-informative 0.7692 +664 keep constant 0.7692 +665 keep constant 0.7692 +666 keep constant 0.7692 +667 keep constant 0.7692 +668 keep constant 0.7692 +669 keep constant 0.7692 +670 keep constant 0.7692 +671 keep constant 0.7692 +672 keep constant 0.7692 +673 keep constant 0.7692 +674 keep constant 0.7692 +675 keep constant 0.7692 +676 keep constant 0.7692 +677 keep constant 0.7692 +678 keep constant 0.7692 +679 keep constant 0.7692 +680 keep constant 0.7692 +681 keep constant 0.7692 +682 keep constant 0.7692 +683 keep constant 0.7692 +684 keep constant 0.7692 +685 keep constant 0.7692 +686 keep constant 0.7692 +687 keep constant 0.7692 +688 keep constant 0.7692 +689 keep constant 0.7692 +690 keep constant 0.7692 +691 keep constant 0.7692 +692 keep constant 0.7692 +693 keep constant 0.7692 +694 keep constant 0.7692 +695 keep constant 0.7692 +696 keep parsimony-informative 0.7692 +697 keep constant 0.7692 +698 keep constant 0.7692 +699 keep constant 0.7692 +700 keep singleton 0.7607 +701 keep constant 0.7607 +702 keep constant 0.7607 +703 keep singleton 0.7607 +704 keep constant 0.7607 +705 keep parsimony-informative 0.7607 +706 keep constant 0.7692 +707 keep constant 0.7692 +708 keep parsimony-informative 0.7692 +709 keep constant 0.7692 +710 keep constant 0.7692 +711 keep singleton 0.7692 +712 keep constant 0.7692 +713 keep constant 0.7692 +714 keep constant 0.7692 +715 keep constant 0.7692 +716 keep constant 0.7692 +717 keep constant 0.7692 +718 keep constant 0.7607 +719 keep constant 0.7607 +720 keep constant 0.7607 +721 keep singleton 0.7607 +722 keep constant 0.7607 +723 keep singleton 0.7607 +724 keep singleton 0.7607 +725 keep singleton 0.7607 +726 keep singleton 0.7607 +727 keep constant 0.7607 +728 keep constant 0.7607 +729 keep singleton 0.7607 +730 keep constant 0.7607 +731 keep constant 0.7607 +732 keep constant 0.7607 +733 keep constant 0.7692 +734 keep constant 0.7692 +735 keep parsimony-informative 0.7692 +736 keep constant 0.7692 +737 keep constant 0.7692 +738 keep constant 0.7692 +739 keep constant 0.7692 +740 keep constant 0.7692 +741 keep constant 0.7692 +742 keep constant 0.7692 +743 keep constant 0.7692 +744 keep constant 0.7692 +745 keep constant 0.7692 +746 keep constant 0.7692 +747 keep constant 0.7692 +748 keep constant 0.7692 +749 keep constant 0.7692 +750 keep constant 0.7692 +751 keep constant 0.7692 +752 keep constant 0.7692 +753 keep constant 0.7692 +754 keep constant 0.7607 +755 keep constant 0.7607 +756 keep singleton 0.7607 +757 keep singleton 0.7607 +758 keep singleton 0.7607 +759 keep constant 0.7607 +760 keep constant 0.7692 +761 keep constant 0.7692 +762 keep constant 0.7692 +763 keep constant 0.7692 +764 keep constant 0.7692 +765 keep constant 0.7692 +766 keep constant 0.7692 +767 keep constant 0.7692 +768 keep singleton 0.7692 +769 keep constant 0.7692 +770 keep constant 0.7692 +771 keep constant 0.7692 +772 keep constant 0.7692 +773 keep constant 0.7692 +774 keep constant 0.7692 +775 keep constant 0.7692 +776 keep constant 0.7692 +777 keep constant 0.7692 +778 keep constant 0.7692 +779 keep constant 0.7692 +780 keep constant 0.7692 +781 keep constant 0.7692 +782 keep constant 0.7692 +783 keep singleton 0.7692 +784 keep constant 0.7692 +785 keep constant 0.7692 +786 keep constant 0.7692 +787 keep constant 0.7692 +788 keep constant 0.7692 +789 keep constant 0.7692 +790 keep constant 0.7692 +791 keep constant 0.7692 +792 keep singleton 0.7692 +793 keep constant 0.7692 +794 keep constant 0.7692 +795 keep parsimony-informative 0.7692 +796 keep constant 0.7692 +797 keep constant 0.7692 +798 keep constant 0.7692 +799 keep constant 0.7692 +800 keep constant 0.7692 +801 keep constant 0.7692 +802 keep constant 0.7692 +803 keep constant 0.7692 +804 keep constant 0.7692 +805 keep constant 0.7692 +806 keep constant 0.7692 +807 keep constant 0.7692 +808 keep singleton 0.7521 +809 keep singleton 0.7521 +810 keep singleton 0.7521 +811 keep singleton 0.7521 +812 keep singleton 0.7521 +813 keep singleton 0.7521 +814 keep singleton 0.7521 +815 keep singleton 0.7521 +816 keep parsimony-informative 0.7521 +817 keep singleton 0.7521 +818 keep constant 0.7521 +819 keep singleton 0.7521 +820 keep constant 0.7692 +821 keep constant 0.7692 +822 keep constant 0.7692 +823 keep constant 0.7692 +824 keep constant 0.7692 +825 keep constant 0.7692 +826 keep constant 0.7692 +827 keep constant 0.7692 +828 keep constant 0.7692 +829 keep constant 0.7607 +830 keep constant 0.7607 +831 keep constant 0.7607 +832 keep constant 0.7607 +833 keep constant 0.7607 +834 keep constant 0.7607 +835 keep singleton 0.7607 +836 keep constant 0.7607 +837 keep singleton 0.7607 +838 keep constant 0.7607 +839 keep singleton 0.7607 +840 keep singleton 0.7607 +841 keep constant 0.7607 +842 keep singleton 0.7607 +843 keep singleton 0.7607 +844 keep singleton 0.7607 +845 keep singleton 0.7607 +846 keep singleton 0.7607 +847 keep constant 0.7607 +848 keep constant 0.7607 +849 keep singleton 0.7607 +850 keep constant 0.7692 +851 keep constant 0.7692 +852 keep parsimony-informative 0.7692 +853 keep constant 0.7692 +854 keep constant 0.7692 +855 keep constant 0.7692 +856 keep constant 0.7692 +857 keep constant 0.7692 +858 keep constant 0.7692 +859 keep constant 0.7692 +860 keep constant 0.7692 +861 keep constant 0.7692 +862 keep constant 0.7692 +863 keep constant 0.7692 +864 keep constant 0.7692 +865 keep constant 0.7692 +866 keep constant 0.7692 +867 keep constant 0.7692 +868 keep constant 0.7692 +869 keep constant 0.7692 +870 keep constant 0.7692 +871 keep constant 0.7692 +872 keep constant 0.7692 +873 keep parsimony-informative 0.7692 +874 keep constant 0.7692 +875 keep constant 0.7692 +876 keep constant 0.7692 +877 keep constant 0.7692 +878 keep constant 0.7692 +879 keep constant 0.7692 +880 keep constant 0.7692 +881 keep constant 0.7692 +882 keep constant 0.7692 +883 keep constant 0.7692 +884 keep constant 0.7692 +885 keep parsimony-informative 0.7692 +886 keep constant 0.7692 +887 keep constant 0.7692 +888 keep constant 0.7692 +889 keep constant 0.7692 +890 keep constant 0.7692 +891 keep constant 0.7692 +892 keep constant 0.7692 +893 keep constant 0.7692 +894 keep constant 0.7692 +895 keep constant 0.7692 +896 keep constant 0.7692 +897 keep constant 0.7692 +898 keep constant 0.7692 +899 keep constant 0.7692 +900 keep constant 0.7692 +901 keep constant 0.7692 +902 keep constant 0.7692 +903 keep parsimony-informative 0.7692 +904 keep constant 0.7692 +905 keep constant 0.7692 +906 keep constant 0.7692 +907 keep constant 0.7692 +908 keep constant 0.7692 +909 keep constant 0.7692 +910 keep constant 0.7692 +911 keep constant 0.7692 +912 keep constant 0.7692 +913 keep constant 0.7692 +914 keep constant 0.7692 +915 keep constant 0.7692 +916 keep constant 0.7692 +917 keep constant 0.7692 +918 keep constant 0.7692 +919 keep constant 0.7692 +920 keep constant 0.7692 +921 keep constant 0.7692 +922 keep constant 0.7692 +923 keep constant 0.7692 +924 keep singleton 0.7692 +925 keep constant 0.7692 +926 keep constant 0.7692 +927 keep constant 0.7692 +928 keep constant 0.7692 +929 keep constant 0.7692 +930 keep parsimony-informative 0.7692 +931 keep parsimony-informative 0.6667 +932 keep constant 0.6667 +933 keep parsimony-informative 0.6667 +934 keep parsimony-informative 0.6667 +935 keep constant 0.6667 +936 keep parsimony-informative 0.6667 +937 keep parsimony-informative 0.6667 +938 keep constant 0.6667 +939 keep parsimony-informative 0.6667 +940 keep constant 0.6667 +941 keep constant 0.6667 +942 keep parsimony-informative 0.6667 +943 keep parsimony-informative 0.6667 +944 keep parsimony-informative 0.6667 +945 keep parsimony-informative 0.6667 +946 keep constant 0.7692 +947 keep constant 0.7692 +948 keep constant 0.7692 +949 keep constant 0.7692 +950 keep constant 0.7692 +951 keep constant 0.7692 +952 keep constant 0.7692 +953 keep constant 0.7692 +954 keep constant 0.7692 +955 keep constant 0.7692 +956 keep constant 0.7692 +957 keep constant 0.7692 +958 keep constant 0.7692 +959 keep constant 0.7692 +960 keep constant 0.7692 +961 keep constant 0.7692 +962 keep constant 0.7692 +963 keep constant 0.7692 +964 keep constant 0.7692 +965 keep constant 0.7692 +966 keep constant 0.7692 +967 keep constant 0.7692 +968 keep constant 0.7692 +969 keep constant 0.7692 +970 keep constant 0.7692 +971 keep constant 0.7692 +972 keep constant 0.7692 +973 keep constant 0.7692 +974 keep constant 0.7692 +975 keep constant 0.7692 +976 keep constant 0.7692 +977 keep constant 0.7692 +978 keep constant 0.7692 +979 keep constant 0.7692 +980 keep constant 0.7692 +981 keep constant 0.7692 +982 keep constant 0.7692 +983 keep constant 0.7692 +984 keep constant 0.7692 +985 keep constant 0.7692 +986 keep constant 0.7692 +987 keep constant 0.7692 +988 keep constant 0.7692 +989 keep constant 0.7692 +990 keep parsimony-informative 0.7692 +991 keep constant 0.7692 +992 keep constant 0.7692 +993 keep constant 0.7692 +994 keep constant 0.7607 +995 keep constant 0.7607 +996 keep constant 0.7607 +997 keep parsimony-informative 0.7607 +998 keep constant 0.7607 +999 keep singleton 0.7607 +1000 keep constant 0.7692 +1001 keep constant 0.7692 +1002 keep constant 0.7692 +1003 keep constant 0.7692 +1004 keep constant 0.7692 +1005 keep constant 0.7692 +1006 keep constant 0.7692 +1007 keep constant 0.7692 +1008 keep constant 0.7692 +1009 keep constant 0.7692 +1010 keep constant 0.7692 +1011 keep constant 0.7692 +1012 keep constant 0.7692 +1013 keep constant 0.7692 +1014 keep constant 0.7692 +1015 keep constant 0.7692 +1016 keep constant 0.7692 +1017 keep constant 0.7692 +1018 keep constant 0.7692 +1019 keep constant 0.7692 +1020 keep constant 0.7692 +1021 keep constant 0.7692 +1022 keep constant 0.7692 +1023 keep constant 0.7692 +1024 keep constant 0.7692 +1025 keep constant 0.7692 +1026 keep constant 0.7692 +1027 keep singleton 0.7692 +1028 keep singleton 0.7692 +1029 keep singleton 0.7692 +1030 keep singleton 0.7607 +1031 keep singleton 0.7607 +1032 keep singleton 0.7607 +1033 keep constant 0.7692 +1034 keep constant 0.7692 +1035 keep singleton 0.7692 +1036 keep constant 0.7692 +1037 keep singleton 0.7692 +1038 keep singleton 0.7692 +1039 keep singleton 0.7692 +1040 keep singleton 0.7692 +1041 keep singleton 0.7692 +1042 keep constant 0.7692 +1043 keep constant 0.7692 +1044 keep constant 0.7692 +1045 keep constant 0.8205 +1046 keep constant 0.8205 +1047 keep constant 0.8205 +1048 keep constant 0.8205 +1049 keep constant 0.8205 +1050 keep parsimony-informative 0.8205 +1051 keep constant 0.8376 +1052 keep constant 0.8376 +1053 keep constant 0.8376 +1054 keep constant 0.8376 +1055 keep constant 0.8376 +1056 keep singleton 0.8376 +1057 keep constant 0.8376 +1058 keep constant 0.8376 +1059 keep constant 0.8376 +1060 keep constant 0.8376 +1061 keep constant 0.8376 +1062 keep constant 0.8376 +1063 keep constant 0.8376 +1064 keep constant 0.8376 +1065 keep constant 0.8376 +1066 keep constant 0.8376 +1067 keep constant 0.8376 +1068 keep constant 0.8376 +1069 keep constant 0.8718 +1070 keep constant 0.8718 +1071 keep constant 0.8718 +1072 keep constant 0.8718 +1073 keep constant 0.8718 +1074 keep constant 0.8718 +1075 keep constant 0.8718 +1076 keep constant 0.8718 +1077 keep constant 0.8718 +1078 keep constant 0.8718 +1079 keep constant 0.8718 +1080 keep constant 0.8718 +1081 keep constant 0.8718 +1082 keep constant 0.8718 +1083 keep constant 0.8718 +1084 keep constant 0.8803 +1085 keep constant 0.8803 +1086 keep singleton 0.8803 +1087 trim constant 0.9487 +1088 trim constant 0.9487 +1089 trim constant 0.9487 +1090 trim constant 0.9487 +1091 trim constant 0.9487 +1092 trim constant 0.9487 +1093 trim constant 0.9487 +1094 trim constant 0.9487 +1095 trim constant 0.9487 +1096 trim constant 0.9487 +1097 trim constant 0.9487 +1098 trim constant 0.9487 +1099 trim constant 0.9487 +1100 trim constant 0.9487 +1101 trim constant 0.9487 +1102 trim constant 0.9487 +1103 trim constant 0.9487 +1104 trim constant 0.9487 +1105 trim constant 0.9487 +1106 trim constant 0.9487 +1107 trim constant 0.9487 +1108 trim constant 0.9316 +1109 trim constant 0.9316 +1110 trim constant 0.9316 +1111 trim constant 0.9316 +1112 trim constant 0.9316 +1113 trim constant 0.9316 +1114 keep parsimony-informative 0.8889 +1115 keep constant 0.8889 +1116 keep parsimony-informative 0.8889 +1117 keep parsimony-informative 0.8889 +1118 keep parsimony-informative 0.8889 +1119 keep constant 0.8889 +1120 keep parsimony-informative 0.8889 +1121 keep constant 0.8889 +1122 keep parsimony-informative 0.8889 +1123 keep constant 0.8889 +1124 keep constant 0.8889 +1125 keep parsimony-informative 0.8889 +1126 keep parsimony-informative 0.8889 +1127 keep constant 0.8889 +1128 keep parsimony-informative 0.8889 +1129 keep parsimony-informative 0.8889 +1130 keep constant 0.8889 +1131 keep parsimony-informative 0.8889 +1132 keep parsimony-informative 0.8889 +1133 keep parsimony-informative 0.8889 +1134 keep constant 0.8889 +1135 keep parsimony-informative 0.8889 +1136 keep parsimony-informative 0.8889 +1137 keep parsimony-informative 0.8889 +1138 trim constant 0.9573 +1139 trim constant 0.9573 +1140 trim constant 0.9573 +1141 trim constant 0.9573 +1142 trim constant 0.9573 +1143 trim constant 0.9573 +1144 trim constant 0.9573 +1145 trim constant 0.9573 +1146 trim constant 0.9573 +1147 trim constant 0.9573 +1148 trim constant 0.9573 +1149 trim constant 0.9573 +1150 trim constant 0.9573 +1151 trim constant 0.9573 +1152 trim constant 0.9573 +1153 keep constant 0.8803 +1154 keep constant 0.8803 +1155 keep parsimony-informative 0.8803 +1156 keep constant 0.8803 +1157 keep constant 0.8803 +1158 keep constant 0.8803 +1159 keep constant 0.8803 +1160 keep constant 0.8803 +1161 keep parsimony-informative 0.8803 +1162 keep parsimony-informative 0.8803 +1163 keep parsimony-informative 0.8803 +1164 keep parsimony-informative 0.8803 +1165 keep parsimony-informative 0.8803 +1166 keep constant 0.8803 +1167 keep parsimony-informative 0.8803 +1168 trim constant 0.9316 +1169 trim constant 0.9316 +1170 trim constant 0.9316 +1171 trim constant 0.9316 +1172 trim constant 0.9316 +1173 trim constant 0.9316 +1174 trim constant 0.9316 +1175 trim constant 0.9316 +1176 trim constant 0.9316 +1177 trim constant 0.9316 +1178 trim constant 0.9316 +1179 trim constant 0.9316 +1180 trim constant 0.9316 +1181 trim constant 0.9316 +1182 trim constant 0.9316 +1183 trim constant 0.9316 +1184 trim constant 0.9316 +1185 trim constant 0.9316 +1186 trim constant 0.9316 +1187 trim constant 0.9316 +1188 trim constant 0.9316 +1189 trim constant 0.9316 +1190 trim constant 0.9316 +1191 trim constant 0.9316 +1192 trim constant 0.9231 +1193 trim constant 0.9231 +1194 trim singleton 0.9231 +1195 trim constant 0.9231 +1196 trim constant 0.9231 +1197 trim singleton 0.9231 +1198 trim singleton 0.9231 +1199 trim singleton 0.9231 +1200 trim constant 0.9231 +1201 trim singleton 0.9231 +1202 trim constant 0.9231 +1203 trim singleton 0.9231 +1204 trim constant 0.9231 +1205 trim singleton 0.9231 +1206 trim singleton 0.9231 +1207 trim singleton 0.9231 +1208 trim constant 0.9231 +1209 trim constant 0.9231 +1210 keep singleton 0.8718 +1211 keep constant 0.8718 +1212 keep parsimony-informative 0.8718 +1213 keep parsimony-informative 0.8718 +1214 keep singleton 0.8718 +1215 keep constant 0.8718 +1216 keep parsimony-informative 0.8718 +1217 keep constant 0.8718 +1218 keep parsimony-informative 0.8718 +1219 keep parsimony-informative 0.8718 +1220 keep constant 0.8718 +1221 keep parsimony-informative 0.8718 +1222 keep parsimony-informative 0.8718 +1223 keep parsimony-informative 0.8718 +1224 keep singleton 0.8718 +1225 keep constant 0.8803 +1226 keep parsimony-informative 0.8803 +1227 keep parsimony-informative 0.8803 +1228 keep parsimony-informative 0.8803 +1229 keep constant 0.8803 +1230 keep parsimony-informative 0.8803 +1231 keep constant 0.8803 +1232 keep parsimony-informative 0.8803 +1233 keep constant 0.8803 +1234 keep constant 0.8803 +1235 keep constant 0.8803 +1236 keep parsimony-informative 0.8803 +1237 keep constant 0.8803 +1238 keep constant 0.8803 +1239 keep parsimony-informative 0.8803 +1240 keep parsimony-informative 0.8803 +1241 keep constant 0.8803 +1242 keep parsimony-informative 0.8803 +1243 keep constant 0.8803 +1244 keep constant 0.8803 +1245 keep parsimony-informative 0.8803 +1246 keep parsimony-informative 0.8803 +1247 keep parsimony-informative 0.8803 +1248 keep parsimony-informative 0.8803 +1249 keep parsimony-informative 0.8803 +1250 keep parsimony-informative 0.8803 +1251 keep parsimony-informative 0.8803 +1252 trim constant 0.9487 +1253 trim constant 0.9487 +1254 trim constant 0.9487 +1255 trim constant 0.9487 +1256 trim constant 0.9487 +1257 trim constant 0.9487 +1258 trim constant 0.9487 +1259 trim constant 0.9487 +1260 trim constant 0.9487 +1261 trim constant 0.9487 +1262 trim constant 0.9487 +1263 trim constant 0.9487 +1264 trim constant 0.9487 +1265 trim constant 0.9487 +1266 trim constant 0.9487 +1267 keep constant 0.8803 +1268 keep parsimony-informative 0.8803 +1269 keep constant 0.8803 +1270 keep parsimony-informative 0.8803 +1271 keep constant 0.8803 +1272 keep constant 0.8803 +1273 keep constant 0.8803 +1274 keep constant 0.8803 +1275 keep parsimony-informative 0.8803 +1276 keep parsimony-informative 0.8803 +1277 keep parsimony-informative 0.8803 +1278 keep constant 0.8803 +1279 keep parsimony-informative 0.8803 +1280 keep constant 0.8803 +1281 keep parsimony-informative 0.8803 +1282 keep parsimony-informative 0.8632 +1283 keep singleton 0.8632 +1284 keep parsimony-informative 0.8632 +1285 keep parsimony-informative 0.8632 +1286 keep parsimony-informative 0.8632 +1287 keep parsimony-informative 0.8632 +1288 keep constant 0.8632 +1289 keep constant 0.8632 +1290 keep singleton 0.8632 +1291 trim constant 0.9316 +1292 trim constant 0.9316 +1293 trim constant 0.9316 +1294 trim constant 0.9316 +1295 trim constant 0.9316 +1296 trim constant 0.9316 +1297 trim constant 0.9316 +1298 trim constant 0.9316 +1299 trim constant 0.9316 +1300 keep constant 0.8718 +1301 keep constant 0.8718 +1302 keep parsimony-informative 0.8718 +1303 trim constant 0.9316 +1304 trim constant 0.9316 +1305 trim constant 0.9316 +1306 trim constant 0.9316 +1307 trim constant 0.9316 +1308 trim constant 0.9316 +1309 trim constant 0.9316 +1310 trim constant 0.9316 +1311 trim constant 0.9316 +1312 keep constant 0.8718 +1313 keep constant 0.8718 +1314 keep constant 0.8718 +1315 keep constant 0.8718 +1316 keep constant 0.8718 +1317 keep parsimony-informative 0.8718 +1318 trim constant 0.9316 +1319 trim constant 0.9316 +1320 trim constant 0.9316 +1321 trim constant 0.9316 +1322 trim constant 0.9316 +1323 trim constant 0.9316 +1324 trim constant 0.9316 +1325 trim constant 0.9316 +1326 trim constant 0.9316 +1327 trim constant 0.9316 +1328 trim constant 0.9316 +1329 trim constant 0.9316 +1330 trim constant 0.9316 +1331 trim constant 0.9316 +1332 trim constant 0.9316 +1333 trim constant 0.9316 +1334 trim constant 0.9316 +1335 trim constant 0.9316 +1336 keep parsimony-informative 0.8718 +1337 keep constant 0.8718 +1338 keep parsimony-informative 0.8718 +1339 keep parsimony-informative 0.7692 +1340 keep constant 0.7692 +1341 keep parsimony-informative 0.7692 +1342 keep parsimony-informative 0.7692 +1343 keep constant 0.7692 +1344 keep constant 0.7692 +1345 keep constant 0.7692 +1346 keep constant 0.7692 +1347 keep parsimony-informative 0.7692 +1348 keep constant 0.7692 +1349 keep constant 0.7692 +1350 keep parsimony-informative 0.7692 +1351 keep constant 0.7692 +1352 keep constant 0.7692 +1353 keep constant 0.7692 +1354 keep constant 0.7692 +1355 keep constant 0.7692 +1356 keep parsimony-informative 0.7692 +1357 keep constant 0.7692 +1358 keep constant 0.7692 +1359 keep singleton 0.7692 +1360 keep constant 0.7692 +1361 keep constant 0.7692 +1362 keep parsimony-informative 0.7692 +1363 keep parsimony-informative 0.7692 +1364 keep constant 0.7692 +1365 keep parsimony-informative 0.7692 +1366 keep constant 0.7692 +1367 keep constant 0.7692 +1368 keep parsimony-informative 0.7692 +1369 keep parsimony-informative 0.7692 +1370 keep parsimony-informative 0.7692 +1371 keep singleton 0.7692 +1372 keep constant 0.7692 +1373 keep constant 0.7692 +1374 keep parsimony-informative 0.7692 +1375 keep constant 0.7692 +1376 keep constant 0.7692 +1377 keep constant 0.7692 +1378 keep constant 0.7692 +1379 keep constant 0.7692 +1380 keep constant 0.7692 +1381 keep constant 0.7692 +1382 keep constant 0.7692 +1383 keep parsimony-informative 0.7692 +1384 keep parsimony-informative 0.7692 +1385 keep constant 0.7692 +1386 keep parsimony-informative 0.7692 +1387 keep constant 0.7692 +1388 keep constant 0.7692 +1389 keep parsimony-informative 0.7692 +1390 keep constant 0.7692 +1391 keep parsimony-informative 0.7692 +1392 keep parsimony-informative 0.7692 +1393 keep constant 0.7692 +1394 keep constant 0.7692 +1395 keep parsimony-informative 0.7692 +1396 keep constant 0.7692 +1397 keep constant 0.7692 +1398 keep constant 0.7692 +1399 keep constant 0.7692 +1400 keep constant 0.7692 +1401 keep parsimony-informative 0.7692 +1402 keep constant 0.7692 +1403 keep constant 0.7692 +1404 keep constant 0.7692 +1405 keep parsimony-informative 0.7692 +1406 keep constant 0.7692 +1407 keep parsimony-informative 0.7692 +1408 keep constant 0.7692 +1409 keep constant 0.7692 +1410 keep parsimony-informative 0.7692 +1411 keep constant 0.7692 +1412 keep constant 0.7692 +1413 keep singleton 0.7692 +1414 keep constant 0.7692 +1415 keep constant 0.7692 +1416 keep parsimony-informative 0.7692 +1417 keep constant 0.7692 +1418 keep constant 0.7692 +1419 keep parsimony-informative 0.7692 +1420 keep constant 0.7692 +1421 keep constant 0.7692 +1422 keep constant 0.7692 +1423 keep parsimony-informative 0.7692 +1424 keep parsimony-informative 0.7692 +1425 keep parsimony-informative 0.7692 +1426 keep constant 0.7692 +1427 keep constant 0.7692 +1428 keep parsimony-informative 0.7692 +1429 keep singleton 0.7692 +1430 keep constant 0.7692 +1431 keep parsimony-informative 0.7692 +1432 keep constant 0.7692 +1433 keep constant 0.7692 +1434 keep singleton 0.7692 +1435 keep constant 0.7692 +1436 keep constant 0.7692 +1437 keep parsimony-informative 0.7692 +1438 keep constant 0.7692 +1439 keep constant 0.7692 +1440 keep constant 0.7692 +1441 keep parsimony-informative 0.7692 +1442 keep parsimony-informative 0.7692 +1443 keep parsimony-informative 0.7692 +1444 keep constant 0.7692 +1445 keep constant 0.7692 +1446 keep constant 0.7692 +1447 keep constant 0.7692 +1448 keep constant 0.7692 +1449 keep constant 0.7692 +1450 keep constant 0.7692 +1451 keep constant 0.7692 +1452 keep constant 0.7692 +1453 keep constant 0.7692 +1454 keep constant 0.7692 +1455 keep parsimony-informative 0.7692 +1456 keep constant 0.7692 +1457 keep constant 0.7692 +1458 keep parsimony-informative 0.7692 +1459 keep constant 0.7692 +1460 keep constant 0.7692 +1461 keep singleton 0.7692 +1462 keep singleton 0.7607 +1463 keep constant 0.7607 +1464 keep parsimony-informative 0.7607 +1465 keep singleton 0.7607 +1466 keep singleton 0.7607 +1467 keep parsimony-informative 0.7607 +1468 keep singleton 0.7607 +1469 keep singleton 0.7607 +1470 keep parsimony-informative 0.7607 +1471 keep constant 0.7607 +1472 keep constant 0.7607 +1473 keep parsimony-informative 0.7607 +1474 keep constant 0.7607 +1475 keep singleton 0.7607 +1476 keep parsimony-informative 0.7607 +1477 keep constant 0.7607 +1478 keep singleton 0.7607 +1479 keep singleton 0.7607 +1480 keep singleton 0.7607 +1481 keep singleton 0.7607 +1482 keep parsimony-informative 0.7607 +1483 keep singleton 0.7607 +1484 keep singleton 0.7607 +1485 keep singleton 0.7607 +1486 keep constant 0.7607 +1487 keep constant 0.7607 +1488 keep parsimony-informative 0.7607 +1489 keep constant 0.7692 +1490 keep constant 0.7692 +1491 keep constant 0.7692 +1492 keep parsimony-informative 0.7692 +1493 keep constant 0.7692 +1494 keep parsimony-informative 0.7692 +1495 keep singleton 0.7692 +1496 keep constant 0.7692 +1497 keep constant 0.7692 +1498 keep constant 0.7692 +1499 keep constant 0.7692 +1500 keep constant 0.7692 +1501 keep constant 0.7692 +1502 keep constant 0.7692 +1503 keep constant 0.7692 +1504 keep constant 0.7692 +1505 keep constant 0.7692 +1506 keep singleton 0.7692 +1507 keep constant 0.7692 +1508 keep constant 0.7692 +1509 keep parsimony-informative 0.7692 +1510 keep constant 0.7692 +1511 keep constant 0.7692 +1512 keep parsimony-informative 0.7692 +1513 keep constant 0.7692 +1514 keep constant 0.7692 +1515 keep constant 0.7692 +1516 keep constant 0.7692 +1517 keep constant 0.7692 +1518 keep singleton 0.7692 +1519 keep constant 0.7692 +1520 keep constant 0.7692 +1521 keep parsimony-informative 0.7692 +1522 keep constant 0.7692 +1523 keep constant 0.7692 +1524 keep parsimony-informative 0.7692 +1525 keep parsimony-informative 0.7692 +1526 keep constant 0.7692 +1527 keep parsimony-informative 0.7692 +1528 keep parsimony-informative 0.7607 +1529 keep singleton 0.7607 +1530 keep parsimony-informative 0.7607 +1531 keep singleton 0.7607 +1532 keep singleton 0.7607 +1533 keep parsimony-informative 0.7607 +1534 keep constant 0.7607 +1535 keep constant 0.7607 +1536 keep singleton 0.7607 +1537 keep singleton 0.7607 +1538 keep constant 0.7607 +1539 keep parsimony-informative 0.7607 +1540 keep constant 0.7607 +1541 keep singleton 0.7607 +1542 keep parsimony-informative 0.7607 +1543 keep constant 0.7607 +1544 keep constant 0.7607 +1545 keep parsimony-informative 0.7607 +1546 keep constant 0.7692 +1547 keep parsimony-informative 0.7692 +1548 keep parsimony-informative 0.7692 +1549 keep constant 0.7692 +1550 keep constant 0.7692 +1551 keep parsimony-informative 0.7692 +1552 keep constant 0.7692 +1553 keep constant 0.7692 +1554 keep parsimony-informative 0.7692 +1555 keep constant 0.7692 +1556 keep constant 0.7692 +1557 keep parsimony-informative 0.7692 +1558 keep constant 0.7692 +1559 keep constant 0.7692 +1560 keep singleton 0.7692 +1561 keep constant 0.7692 +1562 keep constant 0.7692 +1563 keep singleton 0.7692 +1564 keep parsimony-informative 0.7692 +1565 keep constant 0.7692 +1566 keep parsimony-informative 0.7692 +1567 keep constant 0.7692 +1568 keep parsimony-informative 0.7692 +1569 keep parsimony-informative 0.7692 +1570 keep constant 0.7692 +1571 keep constant 0.7692 +1572 keep constant 0.7692 +1573 keep constant 0.7692 +1574 keep constant 0.7692 +1575 keep parsimony-informative 0.7692 +1576 keep constant 0.7692 +1577 keep constant 0.7692 +1578 keep parsimony-informative 0.7692 +1579 keep constant 0.7692 +1580 keep constant 0.7692 +1581 keep constant 0.7692 +1582 keep constant 0.7692 +1583 keep constant 0.7692 +1584 keep parsimony-informative 0.7692 +1585 keep constant 0.7692 +1586 keep constant 0.7692 +1587 keep parsimony-informative 0.7692 +1588 keep parsimony-informative 0.7692 +1589 keep parsimony-informative 0.7692 +1590 keep parsimony-informative 0.7692 +1591 keep constant 0.7692 +1592 keep constant 0.7692 +1593 keep parsimony-informative 0.7692 +1594 keep constant 0.7692 +1595 keep constant 0.7692 +1596 keep constant 0.7692 +1597 keep constant 0.7692 +1598 keep constant 0.7692 +1599 keep parsimony-informative 0.7692 +1600 keep singleton 0.7692 +1601 keep constant 0.7692 +1602 keep parsimony-informative 0.7692 +1603 keep constant 0.7692 +1604 keep parsimony-informative 0.7692 +1605 keep parsimony-informative 0.7692 +1606 keep constant 0.7692 +1607 keep constant 0.7692 +1608 keep singleton 0.7692 +1609 keep constant 0.7692 +1610 keep constant 0.7692 +1611 keep parsimony-informative 0.7692 +1612 keep singleton 0.7692 +1613 keep parsimony-informative 0.7692 +1614 keep parsimony-informative 0.7692 +1615 keep constant 0.7692 +1616 keep constant 0.7692 +1617 keep singleton 0.7692 +1618 keep constant 0.7692 +1619 keep parsimony-informative 0.7692 +1620 keep parsimony-informative 0.7692 +1621 keep parsimony-informative 0.7692 +1622 keep constant 0.7692 +1623 keep constant 0.7692 +1624 keep constant 0.7692 +1625 keep constant 0.7692 +1626 keep singleton 0.7692 +1627 keep constant 0.7692 +1628 keep constant 0.7692 +1629 keep singleton 0.7692 +1630 keep constant 0.7692 +1631 keep constant 0.7692 +1632 keep parsimony-informative 0.7692 +1633 keep parsimony-informative 0.7692 +1634 keep parsimony-informative 0.7692 +1635 keep parsimony-informative 0.7692 +1636 keep parsimony-informative 0.7692 +1637 keep constant 0.7692 +1638 keep parsimony-informative 0.7692 +1639 keep constant 0.7692 +1640 keep constant 0.7692 +1641 keep parsimony-informative 0.7692 +1642 keep singleton 0.7607 +1643 keep constant 0.7607 +1644 keep parsimony-informative 0.7607 +1645 keep singleton 0.7607 +1646 keep constant 0.7607 +1647 keep singleton 0.7607 +1648 keep constant 0.7607 +1649 keep constant 0.7607 +1650 keep parsimony-informative 0.7607 +1651 keep singleton 0.7607 +1652 keep constant 0.7607 +1653 keep constant 0.7607 +1654 keep singleton 0.7607 +1655 keep singleton 0.7607 +1656 keep singleton 0.7607 +1657 keep parsimony-informative 0.7607 +1658 keep singleton 0.7607 +1659 keep constant 0.7607 +1660 keep parsimony-informative 0.7607 +1661 keep parsimony-informative 0.7607 +1662 keep parsimony-informative 0.7607 +1663 keep constant 0.7607 +1664 keep constant 0.7607 +1665 keep parsimony-informative 0.7607 +1666 keep singleton 0.7607 +1667 keep constant 0.7607 +1668 keep parsimony-informative 0.7607 +1669 keep singleton 0.7607 +1670 keep singleton 0.7607 +1671 keep parsimony-informative 0.7607 +1672 keep singleton 0.7607 +1673 keep singleton 0.7607 +1674 keep parsimony-informative 0.7607 +1675 keep constant 0.7607 +1676 keep constant 0.7607 +1677 keep parsimony-informative 0.7607 +1678 keep parsimony-informative 0.7607 +1679 keep constant 0.7607 +1680 keep parsimony-informative 0.7607 +1681 keep singleton 0.7607 +1682 keep constant 0.7607 +1683 keep singleton 0.7607 +1684 keep singleton 0.7607 +1685 keep singleton 0.7607 +1686 keep parsimony-informative 0.7607 +1687 keep constant 0.7607 +1688 keep constant 0.7607 +1689 keep singleton 0.7607 +1690 keep singleton 0.7607 +1691 keep singleton 0.7607 +1692 keep singleton 0.7607 +1693 keep singleton 0.7607 +1694 keep singleton 0.7607 +1695 keep parsimony-informative 0.7607 +1696 keep constant 0.7607 +1697 keep singleton 0.7607 +1698 keep parsimony-informative 0.7607 +1699 keep constant 0.7607 +1700 keep constant 0.7607 +1701 keep parsimony-informative 0.7607 +1702 keep singleton 0.7607 +1703 keep parsimony-informative 0.7607 +1704 keep parsimony-informative 0.7607 +1705 keep singleton 0.7607 +1706 keep parsimony-informative 0.7607 +1707 keep singleton 0.7607 +1708 keep singleton 0.7607 +1709 keep constant 0.7607 +1710 keep parsimony-informative 0.7607 +1711 keep parsimony-informative 0.7607 +1712 keep parsimony-informative 0.7607 +1713 keep singleton 0.7607 +1714 keep constant 0.7607 +1715 keep constant 0.7607 +1716 keep parsimony-informative 0.7607 +1717 keep singleton 0.7607 +1718 keep constant 0.7607 +1719 keep singleton 0.7607 +1720 keep singleton 0.7607 +1721 keep singleton 0.7607 +1722 keep parsimony-informative 0.7607 +1723 keep constant 0.7607 +1724 keep parsimony-informative 0.7607 +1725 keep singleton 0.7607 +1726 keep singleton 0.7607 +1727 keep singleton 0.7607 +1728 keep parsimony-informative 0.7607 +1729 keep singleton 0.7607 +1730 keep constant 0.7607 +1731 keep singleton 0.7607 +1732 keep singleton 0.7607 +1733 keep singleton 0.7607 +1734 keep parsimony-informative 0.7607 +1735 keep constant 0.7607 +1736 keep constant 0.7607 +1737 keep singleton 0.7607 +1738 keep parsimony-informative 0.7607 +1739 keep singleton 0.7607 +1740 keep singleton 0.7607 +1741 keep constant 0.7692 +1742 keep constant 0.7692 +1743 keep singleton 0.7692 +1744 keep constant 0.7692 +1745 keep constant 0.7692 +1746 keep singleton 0.7692 +1747 keep constant 0.7692 +1748 keep constant 0.7692 +1749 keep singleton 0.7692 +1750 keep singleton 0.7692 +1751 keep constant 0.7692 +1752 keep parsimony-informative 0.7692 +1753 keep constant 0.7692 +1754 keep constant 0.7692 +1755 keep singleton 0.7692 +1756 keep constant 0.7692 +1757 keep constant 0.7692 +1758 keep constant 0.7692 +1759 keep parsimony-informative 0.7607 +1760 keep singleton 0.7607 +1761 keep parsimony-informative 0.7607 +1762 keep constant 0.7607 +1763 keep constant 0.7607 +1764 keep constant 0.7607 +1765 keep constant 0.7607 +1766 keep constant 0.7607 +1767 keep parsimony-informative 0.7607 +1768 keep singleton 0.7607 +1769 keep parsimony-informative 0.7607 +1770 keep singleton 0.7607 +1771 keep parsimony-informative 0.7692 +1772 keep constant 0.7692 +1773 keep parsimony-informative 0.7692 +1774 keep constant 0.7692 +1775 keep singleton 0.7692 +1776 keep singleton 0.7692 +1777 keep constant 0.7692 +1778 keep constant 0.7692 +1779 keep parsimony-informative 0.7692 +1780 keep constant 0.7692 +1781 keep parsimony-informative 0.7692 +1782 keep parsimony-informative 0.7692 +1783 keep parsimony-informative 0.7607 +1784 keep parsimony-informative 0.7607 +1785 keep singleton 0.7607 +1786 keep constant 0.7607 +1787 keep constant 0.7607 +1788 keep parsimony-informative 0.7607 +1789 keep constant 0.7607 +1790 keep singleton 0.7607 +1791 keep parsimony-informative 0.7607 +1792 keep singleton 0.7607 +1793 keep singleton 0.7607 +1794 keep parsimony-informative 0.7607 +1795 keep constant 0.7607 +1796 keep singleton 0.7607 +1797 keep parsimony-informative 0.7607 +1798 keep constant 0.7607 +1799 keep singleton 0.7607 +1800 keep constant 0.7607 +1801 keep constant 0.7607 +1802 keep singleton 0.7607 +1803 keep parsimony-informative 0.7607 +1804 keep constant 0.7607 +1805 keep constant 0.7607 +1806 keep parsimony-informative 0.7607 +1807 keep singleton 0.7607 +1808 keep singleton 0.7607 +1809 keep parsimony-informative 0.7607 +1810 keep singleton 0.7607 +1811 keep constant 0.7607 +1812 keep singleton 0.7607 +1813 keep singleton 0.7607 +1814 keep singleton 0.7607 +1815 keep parsimony-informative 0.7607 +1816 keep singleton 0.7607 +1817 keep constant 0.7607 +1818 keep parsimony-informative 0.7607 +1819 keep constant 0.7607 +1820 keep constant 0.7607 +1821 keep parsimony-informative 0.7607 +1822 keep singleton 0.7607 +1823 keep singleton 0.7607 +1824 keep singleton 0.7607 +1825 keep constant 0.7607 +1826 keep singleton 0.7607 +1827 keep parsimony-informative 0.7607 +1828 keep constant 0.7607 +1829 keep constant 0.7607 +1830 keep parsimony-informative 0.7607 +1831 keep singleton 0.7607 +1832 keep constant 0.7607 +1833 keep parsimony-informative 0.7607 +1834 keep singleton 0.7607 +1835 keep singleton 0.7607 +1836 keep parsimony-informative 0.7607 +1837 keep constant 0.7607 +1838 keep singleton 0.7607 +1839 keep parsimony-informative 0.7607 +1840 keep singleton 0.7607 +1841 keep singleton 0.7607 +1842 keep singleton 0.7607 +1843 keep parsimony-informative 0.7607 +1844 keep singleton 0.7607 +1845 keep parsimony-informative 0.7607 +1846 keep singleton 0.7607 +1847 keep singleton 0.7607 +1848 keep singleton 0.7607 +1849 keep singleton 0.7607 +1850 keep constant 0.7607 +1851 keep singleton 0.7607 +1852 trim other 0.9915 +1853 trim other 0.9915 +1854 trim other 0.9915 +1855 trim other 0.9915 +1856 trim other 0.9915 +1857 trim other 0.9915 +1858 trim other 0.9915 +1859 trim other 0.9915 +1860 trim other 0.9915 +1861 trim other 0.9915 +1862 trim other 0.9915 +1863 trim other 0.9915 +1864 trim other 0.9915 +1865 trim other 0.9915 +1866 trim other 0.9915 +1867 trim other 0.9915 +1868 trim other 0.9915 +1869 trim other 0.9915 +1870 trim other 0.9915 +1871 trim other 0.9915 +1872 trim other 0.9915 +1873 trim other 0.9915 +1874 trim other 0.9915 +1875 trim other 0.9915 +1876 trim other 0.9915 +1877 trim other 0.9915 +1878 trim other 0.9915 +1879 keep parsimony-informative 0.7607 +1880 keep constant 0.7607 +1881 keep parsimony-informative 0.7607 +1882 keep constant 0.7607 +1883 keep singleton 0.7607 +1884 keep constant 0.7607 +1885 keep singleton 0.7607 +1886 keep constant 0.7607 +1887 keep singleton 0.7607 +1888 keep parsimony-informative 0.7607 +1889 keep singleton 0.7607 +1890 keep singleton 0.7607 +1891 keep singleton 0.7607 +1892 keep singleton 0.7607 +1893 keep singleton 0.7607 +1894 keep constant 0.7607 +1895 keep singleton 0.7607 +1896 keep singleton 0.7607 +1897 keep parsimony-informative 0.7607 +1898 keep singleton 0.7607 +1899 keep parsimony-informative 0.7607 +1900 keep constant 0.7607 +1901 keep parsimony-informative 0.7607 +1902 keep parsimony-informative 0.7607 +1903 keep singleton 0.7607 +1904 keep constant 0.7607 +1905 keep singleton 0.7607 +1906 keep singleton 0.7607 +1907 keep singleton 0.7607 +1908 keep parsimony-informative 0.7607 +1909 keep parsimony-informative 0.7607 +1910 keep parsimony-informative 0.7607 +1911 keep constant 0.7607 +1912 keep parsimony-informative 0.7607 +1913 keep parsimony-informative 0.7607 +1914 keep parsimony-informative 0.7607 +1915 keep singleton 0.7607 +1916 keep parsimony-informative 0.7607 +1917 keep singleton 0.7607 +1918 keep singleton 0.7607 +1919 keep singleton 0.7607 +1920 keep parsimony-informative 0.7607 +1921 keep constant 0.7607 +1922 keep constant 0.7607 +1923 keep parsimony-informative 0.7607 +1924 keep parsimony-informative 0.7607 +1925 keep parsimony-informative 0.7607 +1926 keep parsimony-informative 0.7607 +1927 keep parsimony-informative 0.7607 +1928 keep parsimony-informative 0.7607 +1929 keep parsimony-informative 0.7607 +1930 keep parsimony-informative 0.7607 +1931 keep singleton 0.7607 +1932 keep parsimony-informative 0.7607 +1933 keep parsimony-informative 0.7607 +1934 keep constant 0.7607 +1935 keep singleton 0.7607 +1936 keep constant 0.7607 +1937 keep singleton 0.7607 +1938 keep singleton 0.7607 +1939 keep parsimony-informative 0.7607 +1940 keep singleton 0.7607 +1941 keep constant 0.7607 +1942 keep constant 0.7607 +1943 keep singleton 0.7607 +1944 keep parsimony-informative 0.7607 +1945 keep constant 0.7607 +1946 keep singleton 0.7607 +1947 keep singleton 0.7607 +1948 keep singleton 0.7607 +1949 keep parsimony-informative 0.7607 +1950 keep parsimony-informative 0.7607 +1951 keep constant 0.7607 +1952 keep constant 0.7607 +1953 keep parsimony-informative 0.7607 +1954 keep constant 0.7607 +1955 keep constant 0.7607 +1956 keep parsimony-informative 0.7607 +1957 keep constant 0.7607 +1958 keep constant 0.7607 +1959 keep singleton 0.7607 +1960 keep singleton 0.7607 +1961 keep singleton 0.7607 +1962 keep parsimony-informative 0.7607 +1963 keep singleton 0.7607 +1964 keep constant 0.7607 +1965 keep parsimony-informative 0.7607 +1966 keep parsimony-informative 0.7607 +1967 keep constant 0.7607 +1968 keep parsimony-informative 0.7607 +1969 keep singleton 0.7607 +1970 keep constant 0.7607 +1971 keep parsimony-informative 0.7607 +1972 keep parsimony-informative 0.7607 +1973 keep singleton 0.7607 +1974 keep parsimony-informative 0.7607 +1975 keep constant 0.7607 +1976 keep constant 0.7607 +1977 keep singleton 0.7607 +1978 keep constant 0.7607 +1979 keep constant 0.7607 +1980 keep parsimony-informative 0.7607 +1981 keep constant 0.7607 +1982 keep constant 0.7607 +1983 keep parsimony-informative 0.7607 +1984 keep constant 0.7692 +1985 keep constant 0.7692 +1986 keep parsimony-informative 0.7692 +1987 keep constant 0.7692 +1988 keep constant 0.7692 +1989 keep constant 0.7692 +1990 keep constant 0.7692 +1991 keep parsimony-informative 0.7692 +1992 keep constant 0.7692 +1993 keep constant 0.7692 +1994 keep constant 0.7692 +1995 keep parsimony-informative 0.7692 +1996 keep constant 0.7692 +1997 keep constant 0.7692 +1998 keep parsimony-informative 0.7692 +1999 keep constant 0.7692 +2000 keep constant 0.7692 +2001 keep constant 0.7692 +2002 keep constant 0.7607 +2003 keep constant 0.7607 +2004 keep parsimony-informative 0.7607 +2005 keep constant 0.7692 +2006 keep constant 0.7692 +2007 keep constant 0.7692 +2008 keep constant 0.7692 +2009 keep parsimony-informative 0.7692 +2010 keep parsimony-informative 0.7692 +2011 keep constant 0.7692 +2012 keep constant 0.7692 +2013 keep parsimony-informative 0.7692 +2014 keep parsimony-informative 0.7607 +2015 keep singleton 0.7607 +2016 keep singleton 0.7607 +2017 keep parsimony-informative 0.7607 +2018 keep constant 0.7607 +2019 keep parsimony-informative 0.7607 +2020 keep parsimony-informative 0.7607 +2021 keep singleton 0.7607 +2022 keep parsimony-informative 0.7607 +2023 keep constant 0.7607 +2024 keep constant 0.7607 +2025 keep parsimony-informative 0.7607 +2026 keep parsimony-informative 0.7692 +2027 keep constant 0.7692 +2028 keep parsimony-informative 0.7692 +2029 keep parsimony-informative 0.7692 +2030 keep constant 0.7692 +2031 keep parsimony-informative 0.7692 +2032 keep constant 0.7692 +2033 keep constant 0.7692 +2034 keep parsimony-informative 0.7692 +2035 keep constant 0.7692 +2036 keep constant 0.7692 +2037 keep constant 0.7692 +2038 keep constant 0.7692 +2039 keep constant 0.7692 +2040 keep parsimony-informative 0.7692 +2041 keep constant 0.7692 +2042 keep constant 0.7692 +2043 keep parsimony-informative 0.7692 +2044 keep constant 0.7692 +2045 keep constant 0.7692 +2046 keep constant 0.7692 +2047 keep parsimony-informative 0.7692 +2048 keep constant 0.7692 +2049 keep singleton 0.7692 +2050 keep parsimony-informative 0.7692 +2051 keep constant 0.7692 +2052 keep singleton 0.7692 +2053 keep constant 0.7692 +2054 keep constant 0.7692 +2055 keep parsimony-informative 0.7692 +2056 keep constant 0.7692 +2057 keep constant 0.7692 +2058 keep constant 0.7692 +2059 keep constant 0.7692 +2060 keep constant 0.7692 +2061 keep parsimony-informative 0.7692 +2062 keep constant 0.7692 +2063 keep constant 0.7692 +2064 keep singleton 0.7692 +2065 keep parsimony-informative 0.1026 +2066 keep parsimony-informative 0.1026 +2067 keep parsimony-informative 0.1026 +2068 keep parsimony-informative 0.1026 +2069 keep parsimony-informative 0.1026 +2070 keep parsimony-informative 0.1026 +2071 keep singleton 0.7607 +2072 keep constant 0.7607 +2073 keep parsimony-informative 0.7607 +2074 keep constant 0.7692 +2075 keep constant 0.7692 +2076 keep parsimony-informative 0.7692 +2077 keep constant 0.7692 +2078 keep constant 0.7692 +2079 keep parsimony-informative 0.7692 +2080 keep constant 0.7692 +2081 keep constant 0.7692 +2082 keep constant 0.7692 +2083 keep constant 0.7692 +2084 keep constant 0.7692 +2085 keep parsimony-informative 0.7692 +2086 keep constant 0.7692 +2087 keep constant 0.7692 +2088 keep parsimony-informative 0.7692 +2089 keep constant 0.7692 +2090 keep constant 0.7692 +2091 keep singleton 0.7692 +2092 keep constant 0.7692 +2093 keep constant 0.7692 +2094 keep parsimony-informative 0.7692 +2095 keep constant 0.7692 +2096 keep constant 0.7692 +2097 keep constant 0.7692 +2098 keep constant 0.7692 +2099 keep constant 0.7692 +2100 keep constant 0.7692 +2101 keep constant 0.7692 +2102 keep constant 0.7692 +2103 keep constant 0.7692 +2104 keep constant 0.7692 +2105 keep constant 0.7692 +2106 keep singleton 0.7692 +2107 keep constant 0.7692 +2108 keep constant 0.7692 +2109 keep parsimony-informative 0.7692 +2110 keep parsimony-informative 0.7692 +2111 keep constant 0.7692 +2112 keep parsimony-informative 0.7692 +2113 keep constant 0.7692 +2114 keep constant 0.7692 +2115 keep constant 0.7692 +2116 keep constant 0.7692 +2117 keep constant 0.7692 +2118 keep constant 0.7692 +2119 keep constant 0.7692 +2120 keep constant 0.7692 +2121 keep constant 0.7692 +2122 keep parsimony-informative 0.7692 +2123 keep constant 0.7692 +2124 keep parsimony-informative 0.7692 +2125 keep constant 0.7692 +2126 keep constant 0.7692 +2127 keep singleton 0.7692 +2128 keep constant 0.7692 +2129 keep constant 0.7692 +2130 keep parsimony-informative 0.7692 +2131 keep constant 0.7692 +2132 keep constant 0.7692 +2133 keep parsimony-informative 0.7692 +2134 keep constant 0.7692 +2135 keep constant 0.7692 +2136 keep constant 0.7692 +2137 keep constant 0.7692 +2138 keep constant 0.7692 +2139 keep singleton 0.7692 +2140 keep singleton 0.7692 +2141 keep constant 0.7692 +2142 keep parsimony-informative 0.7692 +2143 keep singleton 0.7692 +2144 keep constant 0.7692 +2145 keep parsimony-informative 0.7692 +2146 keep singleton 0.7692 +2147 keep constant 0.7692 +2148 keep parsimony-informative 0.7692 +2149 keep constant 0.7692 +2150 keep constant 0.7692 +2151 keep parsimony-informative 0.7692 +2152 keep constant 0.7692 +2153 keep constant 0.7692 +2154 keep singleton 0.7692 +2155 keep constant 0.7692 +2156 keep constant 0.7692 +2157 keep constant 0.7692 +2158 keep constant 0.7692 +2159 keep constant 0.7692 +2160 keep parsimony-informative 0.7692 +2161 keep constant 0.7692 +2162 keep constant 0.7692 +2163 keep singleton 0.7692 +2164 keep constant 0.7692 +2165 keep constant 0.7692 +2166 keep parsimony-informative 0.7692 +2167 keep constant 0.7692 +2168 keep constant 0.7692 +2169 keep parsimony-informative 0.7692 +2170 keep constant 0.7692 +2171 keep constant 0.7692 +2172 keep parsimony-informative 0.7692 +2173 keep constant 0.7692 +2174 keep constant 0.7692 +2175 keep parsimony-informative 0.7692 +2176 keep constant 0.7607 +2177 keep constant 0.7607 +2178 keep singleton 0.7607 +2179 keep constant 0.7607 +2180 keep singleton 0.7607 +2181 keep parsimony-informative 0.7607 +2182 keep singleton 0.7607 +2183 keep singleton 0.7607 +2184 keep parsimony-informative 0.7607 +2185 keep singleton 0.7607 +2186 keep singleton 0.7607 +2187 keep singleton 0.7607 +2188 keep parsimony-informative 0.7607 +2189 keep singleton 0.7607 +2190 keep parsimony-informative 0.7607 +2191 keep singleton 0.7607 +2192 keep singleton 0.7607 +2193 keep parsimony-informative 0.7607 +2194 keep constant 0.7607 +2195 keep constant 0.7607 +2196 keep singleton 0.7607 +2197 keep singleton 0.7607 +2198 keep constant 0.7607 +2199 keep singleton 0.7607 +2200 keep singleton 0.7607 +2201 keep singleton 0.7607 +2202 keep singleton 0.7607 +2203 keep singleton 0.7607 +2204 keep singleton 0.7607 +2205 keep singleton 0.7607 +2206 keep singleton 0.7607 +2207 keep singleton 0.7607 +2208 keep parsimony-informative 0.7607 +2209 keep singleton 0.7607 +2210 keep singleton 0.7607 +2211 keep parsimony-informative 0.7607 +2212 keep constant 0.7607 +2213 keep constant 0.7607 +2214 keep parsimony-informative 0.7607 +2215 keep constant 0.7607 +2216 keep constant 0.7607 +2217 keep parsimony-informative 0.7607 +2218 keep singleton 0.7607 +2219 keep constant 0.7607 +2220 keep parsimony-informative 0.7607 +2221 keep singleton 0.7607 +2222 keep singleton 0.7607 +2223 keep parsimony-informative 0.7607 +2224 keep singleton 0.7607 +2225 keep singleton 0.7607 +2226 keep parsimony-informative 0.7607 +2227 keep constant 0.7607 +2228 keep singleton 0.7607 +2229 keep singleton 0.7607 +2230 keep singleton 0.7607 +2231 keep singleton 0.7607 +2232 keep parsimony-informative 0.7607 +2233 keep constant 0.7607 +2234 keep singleton 0.7607 +2235 keep parsimony-informative 0.7607 +2236 keep parsimony-informative 0.7607 +2237 keep constant 0.7607 +2238 keep constant 0.7607 +2239 keep parsimony-informative 0.7607 +2240 keep singleton 0.7607 +2241 keep singleton 0.7607 +2242 keep constant 0.7607 +2243 keep constant 0.7607 +2244 keep parsimony-informative 0.7607 +2245 keep constant 0.7692 +2246 keep constant 0.7692 +2247 keep constant 0.7692 +2248 keep singleton 0.7692 +2249 keep constant 0.7692 +2250 keep parsimony-informative 0.7692 +2251 keep constant 0.7607 +2252 keep constant 0.7607 +2253 keep constant 0.7607 +2254 keep singleton 0.7607 +2255 keep singleton 0.7607 +2256 keep constant 0.7607 +2257 keep constant 0.7607 +2258 keep constant 0.7607 +2259 keep singleton 0.7607 +2260 keep singleton 0.7607 +2261 keep singleton 0.7607 +2262 keep singleton 0.7607 +2263 keep constant 0.7607 +2264 keep singleton 0.7607 +2265 keep parsimony-informative 0.7607 +2266 keep singleton 0.7607 +2267 keep constant 0.7607 +2268 keep singleton 0.7607 +2269 keep singleton 0.7607 +2270 keep singleton 0.7607 +2271 keep parsimony-informative 0.7607 +2272 keep singleton 0.7607 +2273 keep constant 0.7607 +2274 keep parsimony-informative 0.7607 +2275 keep constant 0.7607 +2276 keep singleton 0.7607 +2277 keep parsimony-informative 0.7607 +2278 keep singleton 0.7607 +2279 keep constant 0.7607 +2280 keep parsimony-informative 0.7607 +2281 keep singleton 0.7607 +2282 keep singleton 0.7607 +2283 keep parsimony-informative 0.7607 +2284 keep singleton 0.7607 +2285 keep singleton 0.7607 +2286 keep parsimony-informative 0.7607 +2287 keep singleton 0.7607 +2288 keep singleton 0.7607 +2289 keep constant 0.7607 +2290 keep singleton 0.7607 +2291 keep singleton 0.7607 +2292 keep constant 0.7607 +2293 keep constant 0.7607 +2294 keep constant 0.7607 +2295 keep parsimony-informative 0.7607 +2296 keep singleton 0.7607 +2297 keep singleton 0.7607 +2298 keep singleton 0.7607 +2299 keep singleton 0.7607 +2300 keep singleton 0.7607 +2301 keep singleton 0.7607 +2302 keep constant 0.7607 +2303 keep singleton 0.7607 +2304 keep parsimony-informative 0.7607 +2305 keep constant 0.7607 +2306 keep singleton 0.7607 +2307 keep parsimony-informative 0.7607 +2308 keep singleton 0.7607 +2309 keep singleton 0.7607 +2310 keep constant 0.7607 +2311 keep parsimony-informative 0.7607 +2312 keep singleton 0.7607 +2313 keep singleton 0.7607 +2314 keep singleton 0.7607 +2315 keep constant 0.7607 +2316 keep singleton 0.7607 +2317 keep singleton 0.7607 +2318 keep parsimony-informative 0.7607 +2319 keep parsimony-informative 0.7607 +2320 keep singleton 0.7607 +2321 keep singleton 0.7607 +2322 keep singleton 0.7607 +2323 keep singleton 0.7607 +2324 keep parsimony-informative 0.7607 +2325 keep singleton 0.7607 +2326 keep constant 0.7607 +2327 keep constant 0.7607 +2328 keep parsimony-informative 0.7607 +2329 keep singleton 0.7607 +2330 keep singleton 0.7607 +2331 keep singleton 0.7607 +2332 keep singleton 0.7607 +2333 keep singleton 0.7607 +2334 keep singleton 0.7607 +2335 keep constant 0.7607 +2336 keep constant 0.7607 +2337 keep parsimony-informative 0.7607 +2338 keep parsimony-informative 0.7607 +2339 keep singleton 0.7607 +2340 keep parsimony-informative 0.7607 +2341 keep singleton 0.7607 +2342 keep constant 0.7607 +2343 keep parsimony-informative 0.7607 +2344 keep constant 0.7607 +2345 keep constant 0.7607 +2346 keep parsimony-informative 0.7607 +2347 keep singleton 0.7607 +2348 keep singleton 0.7607 +2349 keep parsimony-informative 0.7607 +2350 keep singleton 0.7607 +2351 keep constant 0.7607 +2352 keep parsimony-informative 0.7607 +2353 keep singleton 0.7521 +2354 keep singleton 0.7521 +2355 keep parsimony-informative 0.7521 +2356 keep singleton 0.7607 +2357 keep constant 0.7607 +2358 keep parsimony-informative 0.7607 +2359 keep singleton 0.7607 +2360 keep constant 0.7607 +2361 keep singleton 0.7607 +2362 keep singleton 0.7607 +2363 keep singleton 0.7607 +2364 keep singleton 0.7607 +2365 keep singleton 0.7607 +2366 keep singleton 0.7607 +2367 keep parsimony-informative 0.7607 +2368 keep constant 0.7607 +2369 keep singleton 0.7607 +2370 keep parsimony-informative 0.7607 +2371 keep singleton 0.7607 +2372 keep singleton 0.7607 +2373 keep singleton 0.7607 +2374 keep constant 0.7607 +2375 keep constant 0.7607 +2376 keep constant 0.7607 +2377 keep singleton 0.7607 +2378 keep singleton 0.7607 +2379 keep parsimony-informative 0.7607 +2380 keep constant 0.7607 +2381 keep singleton 0.7607 +2382 keep parsimony-informative 0.7607 +2383 keep constant 0.7607 +2384 keep constant 0.7607 +2385 keep parsimony-informative 0.7607 +2386 keep singleton 0.7607 +2387 keep singleton 0.7607 +2388 keep singleton 0.7607 +2389 keep singleton 0.7607 +2390 keep constant 0.7607 +2391 keep singleton 0.7607 +2392 keep singleton 0.7607 +2393 keep singleton 0.7607 +2394 keep constant 0.7607 +2395 keep singleton 0.7607 +2396 keep singleton 0.7607 +2397 keep parsimony-informative 0.7607 +2398 keep singleton 0.7607 +2399 keep singleton 0.7607 +2400 keep singleton 0.7607 +2401 keep singleton 0.7607 +2402 keep singleton 0.7607 +2403 keep parsimony-informative 0.7607 +2404 keep constant 0.7607 +2405 keep singleton 0.7607 +2406 keep parsimony-informative 0.7607 +2407 keep constant 0.7607 +2408 keep singleton 0.7607 +2409 keep parsimony-informative 0.7607 +2410 keep constant 0.7607 +2411 keep constant 0.7607 +2412 keep parsimony-informative 0.7607 +2413 keep singleton 0.7607 +2414 keep singleton 0.7607 +2415 keep parsimony-informative 0.7607 +2416 keep singleton 0.7607 +2417 keep constant 0.7607 +2418 keep singleton 0.7607 +2419 keep constant 0.7607 +2420 keep singleton 0.7607 +2421 keep parsimony-informative 0.7607 +2422 keep singleton 0.7607 +2423 keep singleton 0.7607 +2424 keep constant 0.7607 +2425 keep singleton 0.7607 +2426 keep singleton 0.7607 +2427 keep parsimony-informative 0.7607 +2428 keep constant 0.7607 +2429 keep parsimony-informative 0.7607 +2430 keep parsimony-informative 0.7607 +2431 keep singleton 0.7607 +2432 keep singleton 0.7607 +2433 keep parsimony-informative 0.7607 +2434 keep singleton 0.7607 +2435 keep singleton 0.7607 +2436 keep singleton 0.7607 +2437 keep constant 0.7607 +2438 keep constant 0.7607 +2439 keep parsimony-informative 0.7607 +2440 keep singleton 0.7607 +2441 keep singleton 0.7607 +2442 keep parsimony-informative 0.7607 +2443 keep constant 0.7607 +2444 keep singleton 0.7607 +2445 keep parsimony-informative 0.7607 +2446 keep parsimony-informative 0.7607 +2447 keep constant 0.7607 +2448 keep parsimony-informative 0.7607 +2449 keep singleton 0.7607 +2450 keep singleton 0.7607 +2451 keep parsimony-informative 0.7607 +2452 keep parsimony-informative 0.7607 +2453 keep constant 0.7607 +2454 keep parsimony-informative 0.7607 +2455 keep constant 0.7692 +2456 keep constant 0.7692 +2457 keep singleton 0.7692 +2458 keep constant 0.7692 +2459 keep constant 0.7692 +2460 keep singleton 0.7692 +2461 keep constant 0.7692 +2462 keep constant 0.7692 +2463 keep parsimony-informative 0.7692 +2464 keep constant 0.7692 +2465 keep constant 0.7692 +2466 keep parsimony-informative 0.7692 +2467 keep constant 0.7692 +2468 keep constant 0.7692 +2469 keep parsimony-informative 0.7692 +2470 keep constant 0.7692 +2471 keep constant 0.7692 +2472 keep constant 0.7692 +2473 keep parsimony-informative 0.7607 +2474 keep constant 0.7607 +2475 keep parsimony-informative 0.7607 +2476 keep singleton 0.7607 +2477 keep constant 0.7607 +2478 keep parsimony-informative 0.7607 +2479 keep singleton 0.7607 +2480 keep singleton 0.7607 +2481 keep parsimony-informative 0.7607 +2482 keep constant 0.7607 +2483 keep constant 0.7607 +2484 keep parsimony-informative 0.7607 +2485 keep parsimony-informative 0.7607 +2486 keep constant 0.7607 +2487 keep singleton 0.7607 +2488 keep constant 0.7607 +2489 keep constant 0.7607 +2490 keep singleton 0.7607 +2491 keep constant 0.7692 +2492 keep singleton 0.7692 +2493 keep parsimony-informative 0.7692 +2494 keep constant 0.7692 +2495 keep constant 0.7692 +2496 keep constant 0.7692 +2497 keep constant 0.7692 +2498 keep constant 0.7692 +2499 keep parsimony-informative 0.7692 +2500 keep constant 0.7692 +2501 keep constant 0.7692 +2502 keep parsimony-informative 0.7692 +2503 keep constant 0.7692 +2504 keep singleton 0.7692 +2505 keep constant 0.7692 +2506 keep constant 0.7607 +2507 keep constant 0.7607 +2508 keep parsimony-informative 0.7607 +2509 keep singleton 0.7607 +2510 keep singleton 0.7607 +2511 keep parsimony-informative 0.7607 +2512 keep parsimony-informative 0.7607 +2513 keep constant 0.7607 +2514 keep parsimony-informative 0.7607 +2515 keep singleton 0.7607 +2516 keep singleton 0.7607 +2517 keep parsimony-informative 0.7607 +2518 keep singleton 0.7607 +2519 keep constant 0.7607 +2520 keep singleton 0.7607 +2521 trim other 0.9915 +2522 trim other 0.9915 +2523 trim other 0.9915 +2524 keep singleton 0.7607 +2525 keep singleton 0.7607 +2526 keep parsimony-informative 0.7607 +2527 keep constant 0.7607 +2528 keep constant 0.7607 +2529 keep parsimony-informative 0.7607 +2530 keep constant 0.7607 +2531 keep constant 0.7607 +2532 keep constant 0.7607 +2533 keep constant 0.7607 +2534 keep constant 0.7607 +2535 keep singleton 0.7607 +2536 keep singleton 0.7607 +2537 keep constant 0.7607 +2538 keep parsimony-informative 0.7607 +2539 keep constant 0.7607 +2540 keep singleton 0.7607 +2541 keep parsimony-informative 0.7607 +2542 keep constant 0.7607 +2543 keep constant 0.7607 +2544 keep parsimony-informative 0.7607 +2545 trim other 0.9915 +2546 trim other 0.9915 +2547 trim other 0.9915 +2548 trim other 0.9915 +2549 trim other 0.9915 +2550 trim other 0.9915 +2551 trim other 0.9915 +2552 trim other 0.9915 +2553 trim other 0.9915 +2554 trim other 0.9915 +2555 trim other 0.9915 +2556 trim other 0.9915 +2557 trim other 0.9915 +2558 trim other 0.9915 +2559 trim other 0.9915 +2560 trim other 0.9915 +2561 trim other 0.9915 +2562 trim other 0.9915 +2563 trim other 0.9915 +2564 trim other 0.9915 +2565 trim other 0.9915 +2566 keep singleton 0.7607 +2567 keep constant 0.7607 +2568 keep parsimony-informative 0.7607 +2569 keep singleton 0.7607 +2570 keep constant 0.7607 +2571 keep parsimony-informative 0.7607 +2572 keep constant 0.7607 +2573 keep constant 0.7607 +2574 keep parsimony-informative 0.7607 +2575 keep singleton 0.7607 +2576 keep parsimony-informative 0.7607 +2577 keep parsimony-informative 0.7607 +2578 trim other 0.9915 +2579 trim other 0.9915 +2580 trim other 0.9915 +2581 trim other 0.9915 +2582 trim other 0.9915 +2583 trim other 0.9915 +2584 trim other 0.9915 +2585 trim other 0.9915 +2586 trim other 0.9915 +2587 trim other 0.9915 +2588 trim other 0.9915 +2589 trim other 0.9915 +2590 trim other 0.9915 +2591 trim other 0.9915 +2592 trim other 0.9915 +2593 trim other 0.9915 +2594 trim other 0.9915 +2595 trim other 0.9915 +2596 trim other 0.9915 +2597 trim other 0.9915 +2598 trim other 0.9915 +2599 trim other 0.9915 +2600 trim other 0.9915 +2601 trim other 0.9915 +2602 trim other 0.9915 +2603 trim other 0.9915 +2604 trim other 0.9915 +2605 trim other 0.9915 +2606 trim other 0.9915 +2607 trim other 0.9915 +2608 trim other 0.9915 +2609 trim other 0.9915 +2610 trim other 0.9915 +2611 trim other 0.9915 +2612 trim other 0.9915 +2613 trim other 0.9915 +2614 trim other 0.9915 +2615 trim other 0.9915 +2616 trim other 0.9915 +2617 trim other 0.9915 +2618 trim other 0.9915 +2619 trim other 0.9915 +2620 keep singleton 0.7607 +2621 keep constant 0.7607 +2622 keep singleton 0.7607 +2623 keep constant 0.7607 +2624 keep constant 0.7607 +2625 keep parsimony-informative 0.7607 +2626 keep singleton 0.7607 +2627 keep singleton 0.7607 +2628 keep singleton 0.7607 +2629 keep constant 0.7607 +2630 keep constant 0.7607 +2631 keep singleton 0.7607 +2632 keep singleton 0.7607 +2633 keep constant 0.7607 +2634 keep parsimony-informative 0.7607 +2635 keep singleton 0.7607 +2636 keep singleton 0.7607 +2637 keep parsimony-informative 0.7607 +2638 keep constant 0.7607 +2639 keep constant 0.7607 +2640 keep singleton 0.7607 +2641 keep constant 0.7607 +2642 keep constant 0.7607 +2643 keep constant 0.7607 +2644 trim other 0.9915 +2645 trim other 0.9915 +2646 trim other 0.9915 +2647 trim other 0.9915 +2648 trim other 0.9915 +2649 trim other 0.9915 +2650 trim other 0.9915 +2651 trim other 0.9915 +2652 trim other 0.9915 +2653 keep singleton 0.7607 +2654 keep constant 0.7607 +2655 keep parsimony-informative 0.7607 +2656 keep singleton 0.7607 +2657 keep singleton 0.7607 +2658 keep singleton 0.7607 +2659 keep constant 0.7607 +2660 keep constant 0.7607 +2661 keep parsimony-informative 0.7607 +2662 keep constant 0.7607 +2663 keep constant 0.7607 +2664 keep singleton 0.7607 +2665 keep singleton 0.7607 +2666 keep constant 0.7607 +2667 keep singleton 0.7607 +2668 keep constant 0.7607 +2669 keep singleton 0.7607 +2670 keep singleton 0.7607 +2671 keep singleton 0.7607 +2672 keep singleton 0.7607 +2673 keep parsimony-informative 0.7607 +2674 keep singleton 0.7607 +2675 keep singleton 0.7607 +2676 keep parsimony-informative 0.7607 +2677 keep constant 0.7607 +2678 keep constant 0.7607 +2679 keep parsimony-informative 0.7607 +2680 keep singleton 0.7607 +2681 keep constant 0.7607 +2682 keep singleton 0.7607 +2683 keep constant 0.7692 +2684 keep constant 0.7692 +2685 keep parsimony-informative 0.7692 +2686 keep constant 0.7692 +2687 keep constant 0.7692 +2688 keep constant 0.7692 +2689 keep constant 0.7607 +2690 keep constant 0.7607 +2691 keep parsimony-informative 0.7607 +2692 keep constant 0.7692 +2693 keep constant 0.7692 +2694 keep parsimony-informative 0.7692 +2695 keep constant 0.7607 +2696 keep singleton 0.7607 +2697 keep singleton 0.7607 +2698 keep constant 0.7607 +2699 keep singleton 0.7607 +2700 keep parsimony-informative 0.7607 +2701 keep constant 0.7607 +2702 keep constant 0.7607 +2703 keep constant 0.7607 +2704 keep constant 0.7692 +2705 keep constant 0.7692 +2706 keep constant 0.7692 +2707 keep constant 0.7692 +2708 keep constant 0.7692 +2709 keep parsimony-informative 0.7692 +2710 keep constant 0.7692 +2711 keep constant 0.7692 +2712 keep parsimony-informative 0.7692 +2713 keep constant 0.7692 +2714 keep constant 0.7692 +2715 keep parsimony-informative 0.7692 +2716 keep constant 0.7692 +2717 keep constant 0.7692 +2718 keep parsimony-informative 0.7692 +2719 keep constant 0.7692 +2720 keep constant 0.7692 +2721 keep constant 0.7692 +2722 keep parsimony-informative 0.7692 +2723 keep parsimony-informative 0.7692 +2724 keep singleton 0.7692 +2725 keep singleton 0.7607 +2726 keep constant 0.7607 +2727 keep parsimony-informative 0.7607 +2728 keep singleton 0.7607 +2729 keep constant 0.7607 +2730 keep constant 0.7607 +2731 keep constant 0.7607 +2732 keep constant 0.7607 +2733 keep parsimony-informative 0.7607 +2734 keep singleton 0.7607 +2735 keep constant 0.7607 +2736 keep parsimony-informative 0.7607 +2737 keep singleton 0.7607 +2738 keep singleton 0.7607 +2739 keep singleton 0.7607 +2740 keep constant 0.7607 +2741 keep singleton 0.7607 +2742 keep parsimony-informative 0.7607 +2743 keep parsimony-informative 0.7607 +2744 keep constant 0.7607 +2745 keep parsimony-informative 0.7607 +2746 keep constant 0.7607 +2747 keep constant 0.7607 +2748 keep singleton 0.7607 +2749 keep constant 0.7692 +2750 keep constant 0.7692 +2751 keep parsimony-informative 0.7692 +2752 keep constant 0.7692 +2753 keep constant 0.7692 +2754 keep parsimony-informative 0.7692 +2755 keep constant 0.7692 +2756 keep constant 0.7692 +2757 keep parsimony-informative 0.7692 +2758 keep constant 0.7692 +2759 keep constant 0.7692 +2760 keep parsimony-informative 0.7692 +2761 keep constant 0.7692 +2762 keep constant 0.7692 +2763 keep singleton 0.7692 +2764 keep constant 0.7692 +2765 keep constant 0.7692 +2766 keep parsimony-informative 0.7692 +2767 keep constant 0.7692 +2768 keep constant 0.7692 +2769 keep constant 0.7692 +2770 keep constant 0.7692 +2771 keep constant 0.7692 +2772 keep constant 0.7692 +2773 keep constant 0.8034 +2774 keep constant 0.8034 +2775 keep parsimony-informative 0.8034 +2776 keep constant 0.8034 +2777 keep constant 0.8034 +2778 keep singleton 0.8034 +2779 keep parsimony-informative 0.8034 +2780 keep constant 0.8034 +2781 keep parsimony-informative 0.8034 +2782 keep constant 0.8034 +2783 keep constant 0.8034 +2784 keep parsimony-informative 0.8034 +2785 keep constant 0.8034 +2786 keep constant 0.8034 +2787 keep parsimony-informative 0.8034 +2788 keep singleton 0.8034 +2789 keep constant 0.8034 +2790 keep parsimony-informative 0.8034 +2791 keep singleton 0.8034 +2792 keep singleton 0.8034 +2793 keep parsimony-informative 0.8034 +2794 keep singleton 0.8034 +2795 keep constant 0.8034 +2796 keep constant 0.8034 +2797 keep constant 0.8034 +2798 keep constant 0.8034 +2799 keep parsimony-informative 0.8034 +2800 keep parsimony-informative 0.8034 +2801 keep constant 0.8034 +2802 keep parsimony-informative 0.8034 +2803 keep constant 0.8034 +2804 keep singleton 0.8034 +2805 keep singleton 0.8034 +2806 keep constant 0.812 +2807 keep constant 0.812 +2808 keep singleton 0.812 +2809 keep constant 0.812 +2810 keep constant 0.812 +2811 keep parsimony-informative 0.812 +2812 keep constant 0.812 +2813 keep constant 0.812 +2814 keep constant 0.812 +2815 keep constant 0.812 +2816 keep constant 0.812 +2817 keep parsimony-informative 0.812 +2818 keep constant 0.812 +2819 keep constant 0.812 +2820 keep singleton 0.812 +2821 keep constant 0.812 +2822 keep constant 0.812 +2823 keep parsimony-informative 0.812 +2824 keep constant 0.812 +2825 keep constant 0.812 +2826 keep constant 0.812 +2827 keep singleton 0.8034 +2828 keep singleton 0.8034 +2829 keep constant 0.8034 +2830 keep singleton 0.8034 +2831 keep singleton 0.8034 +2832 keep singleton 0.8034 +2833 keep singleton 0.8034 +2834 keep singleton 0.8034 +2835 keep singleton 0.8034 +2836 keep constant 0.8034 +2837 keep constant 0.8034 +2838 keep parsimony-informative 0.8034 +2839 keep singleton 0.8462 +2840 keep singleton 0.8462 +2841 keep singleton 0.8462 +2842 keep singleton 0.8462 +2843 keep parsimony-informative 0.8462 +2844 keep parsimony-informative 0.8462 +2845 keep singleton 0.8462 +2846 keep parsimony-informative 0.8462 +2847 keep parsimony-informative 0.8462 +2848 keep singleton 0.8462 +2849 keep parsimony-informative 0.8462 +2850 keep parsimony-informative 0.8462 +2851 keep singleton 0.8462 +2852 keep singleton 0.8462 +2853 keep singleton 0.8462 +2854 keep singleton 0.8462 +2855 keep singleton 0.8462 +2856 keep parsimony-informative 0.8462 +2857 keep parsimony-informative 0.8462 +2858 keep constant 0.8462 +2859 keep parsimony-informative 0.8462 +2860 keep singleton 0.8462 +2861 keep singleton 0.8462 +2862 keep singleton 0.8462 +2863 keep constant 0.8462 +2864 keep parsimony-informative 0.8462 +2865 keep singleton 0.8462 +2866 keep singleton 0.8462 +2867 keep parsimony-informative 0.8462 +2868 keep parsimony-informative 0.8462 +2869 keep singleton 0.8462 +2870 keep singleton 0.8462 +2871 keep parsimony-informative 0.8462 +2872 keep parsimony-informative 0.8462 +2873 keep constant 0.8462 +2874 keep constant 0.8462 +2875 keep singleton 0.8462 +2876 keep singleton 0.8462 +2877 keep parsimony-informative 0.8462 +2878 keep constant 0.8462 +2879 keep constant 0.8462 +2880 keep constant 0.8462 +2881 keep singleton 0.8462 +2882 keep singleton 0.8462 +2883 keep singleton 0.8462 +2884 keep singleton 0.8462 +2885 keep constant 0.8462 +2886 keep singleton 0.8462 +2887 keep parsimony-informative 0.8718 +2888 keep constant 0.8718 +2889 keep constant 0.8718 +2890 keep constant 0.8718 +2891 keep singleton 0.8718 +2892 keep parsimony-informative 0.8718 +2893 keep constant 0.8718 +2894 keep constant 0.8718 +2895 keep parsimony-informative 0.8718 +2896 keep parsimony-informative 0.8718 +2897 keep constant 0.8718 +2898 keep parsimony-informative 0.8718 +2899 keep parsimony-informative 0.8718 +2900 keep parsimony-informative 0.8718 +2901 keep parsimony-informative 0.8718 +2902 keep constant 0.8718 +2903 keep constant 0.8718 +2904 keep constant 0.8718 +2905 keep constant 0.8718 +2906 keep constant 0.8718 +2907 keep parsimony-informative 0.8718 +2908 keep constant 0.8718 +2909 keep constant 0.8718 +2910 keep parsimony-informative 0.8718 +2911 keep constant 0.8718 +2912 keep constant 0.8718 +2913 keep constant 0.8718 +2914 keep constant 0.8718 +2915 keep constant 0.8718 +2916 keep parsimony-informative 0.8718 +2917 keep constant 0.8718 +2918 keep constant 0.8718 +2919 keep parsimony-informative 0.8718 +2920 keep constant 0.8718 +2921 keep constant 0.8718 +2922 keep constant 0.8718 +2923 keep constant 0.8718 +2924 keep constant 0.8718 +2925 keep singleton 0.8718 +2926 keep singleton 0.8718 +2927 keep singleton 0.8718 +2928 keep singleton 0.8718 +2929 keep constant 0.8718 +2930 keep constant 0.8718 +2931 keep singleton 0.8718 +2932 keep constant 0.8632 +2933 keep constant 0.8632 +2934 keep singleton 0.8632 +2935 keep constant 0.8632 +2936 keep constant 0.8632 +2937 keep singleton 0.8632 +2938 keep constant 0.8632 +2939 keep constant 0.8632 +2940 keep constant 0.8632 +2941 keep singleton 0.8632 +2942 keep singleton 0.8632 +2943 keep parsimony-informative 0.8632 +2944 keep singleton 0.8632 +2945 keep singleton 0.8632 +2946 keep parsimony-informative 0.8632 +2947 keep constant 0.8632 +2948 keep constant 0.8632 +2949 keep singleton 0.8632 +2950 keep singleton 0.8632 +2951 keep constant 0.8632 +2952 keep parsimony-informative 0.8632 +2953 keep singleton 0.8632 +2954 keep singleton 0.8632 +2955 keep parsimony-informative 0.8632 +2956 keep singleton 0.8632 +2957 keep singleton 0.8632 +2958 keep singleton 0.8632 +2959 keep singleton 0.8632 +2960 keep singleton 0.8632 +2961 keep singleton 0.8632 +2962 keep constant 0.8632 +2963 keep singleton 0.8632 +2964 keep singleton 0.8632 +2965 keep constant 0.8632 +2966 keep constant 0.8632 +2967 keep singleton 0.8632 +2968 keep parsimony-informative 0.8718 +2969 keep constant 0.8718 +2970 keep singleton 0.8718 +2971 keep constant 0.8718 +2972 keep constant 0.8718 +2973 keep constant 0.8718 +2974 keep constant 0.8718 +2975 keep constant 0.8718 +2976 keep parsimony-informative 0.8718 +2977 keep parsimony-informative 0.8718 +2978 keep constant 0.8718 +2979 keep parsimony-informative 0.8718 +2980 keep constant 0.8718 +2981 keep constant 0.8718 +2982 keep parsimony-informative 0.8718 +2983 keep constant 0.8718 +2984 keep constant 0.8718 +2985 keep constant 0.8718 +2986 keep singleton 0.8718 +2987 keep constant 0.8718 +2988 keep constant 0.8718 +2989 keep constant 0.8889 +2990 keep constant 0.8889 +2991 keep constant 0.8889 +2992 keep singleton 0.8889 +2993 keep constant 0.8889 +2994 keep constant 0.8889 +2995 keep constant 0.8889 +2996 keep constant 0.8889 +2997 keep constant 0.8889 +2998 keep constant 0.8889 +2999 keep parsimony-informative 0.8889 +3000 keep singleton 0.8889 +3001 keep singleton 0.8889 +3002 keep parsimony-informative 0.8889 +3003 keep singleton 0.8889 +3004 keep parsimony-informative 0.8889 +3005 keep parsimony-informative 0.8889 +3006 keep parsimony-informative 0.8889 +3007 keep parsimony-informative 0.8889 +3008 keep constant 0.8889 +3009 keep constant 0.8889 +3010 keep singleton 0.8889 +3011 keep singleton 0.8889 +3012 keep singleton 0.8889 +3013 keep constant 0.8889 +3014 keep singleton 0.8889 +3015 keep parsimony-informative 0.8889 +3016 keep constant 0.8889 +3017 keep singleton 0.8889 +3018 keep parsimony-informative 0.8889 +3019 keep singleton 0.8889 +3020 keep constant 0.8889 +3021 keep parsimony-informative 0.8889 +3022 trim constant 0.9829 +3023 trim other 0.9829 +3024 trim other 0.9829 +3025 trim other 0.9915 +3026 trim other 0.9915 +3027 trim other 0.9915 +3028 trim other 0.9915 +3029 trim other 0.9915 +3030 trim other 0.9915 +3031 trim other 0.9915 +3032 trim other 0.9915 +3033 trim other 0.9915 +3034 trim other 0.9915 +3035 trim other 0.9915 +3036 trim other 0.9915 +3037 trim other 0.9915 +3038 trim other 0.9915 +3039 trim other 0.9915 +3040 trim other 0.9915 +3041 trim other 0.9915 +3042 trim other 0.9915 +3043 trim other 0.9915 +3044 trim other 0.9915 +3045 trim other 0.9915 +3046 trim other 0.9915 +3047 trim other 0.9915 +3048 trim other 0.9915 +3049 trim other 0.9915 +3050 trim other 0.9915 +3051 trim other 0.9915 +3052 trim other 0.9915 +3053 trim other 0.9915 +3054 trim other 0.9915 +3055 trim other 0.9915 +3056 trim other 0.9915 +3057 trim other 0.9915 +3058 trim other 0.9915 +3059 trim other 0.9915 +3060 trim other 0.9915 +3061 trim other 0.9915 +3062 trim other 0.9915 +3063 trim other 0.9915 +3064 trim other 0.9915 +3065 trim other 0.9915 +3066 trim other 0.9915 +3067 trim other 0.9915 +3068 trim other 0.9915 +3069 trim other 0.9915 +3070 trim other 0.9915 +3071 trim other 0.9915 +3072 trim other 0.9915 +3073 trim other 0.9915 +3074 trim other 0.9915 +3075 trim other 0.9915 +3076 keep singleton 0.8974 +3077 keep constant 0.8974 +3078 keep singleton 0.8974 diff --git a/tests/integration/expected/simple.fa_gappy_gaps_set_to_0.2 b/tests/integration/expected/simple.fa_gappy_gaps_set_to_0.2 index 2a39c28..d3744bf 100644 --- a/tests/integration/expected/simple.fa_gappy_gaps_set_to_0.2 +++ b/tests/integration/expected/simple.fa_gappy_gaps_set_to_0.2 @@ -1,10 +1,10 @@ >1 -AGAT +AGA >2 -AGAT +AGA >3 -AGTA +AGT >4 -AATA +AAT >5 -AaT- +AaT diff --git a/tests/integration/samples/simple.fa.clipkit b/tests/integration/samples/simple.fa.clipkit index da4f9f8..0cef391 100644 --- a/tests/integration/samples/simple.fa.clipkit +++ b/tests/integration/samples/simple.fa.clipkit @@ -1,10 +1,10 @@ >1 -A-GAT +A-GTAT >2 -A-GAT +A-G-AT >3 -A-GTA +A-G-TA >4 -AGATA +AGA-TA >5 -ACaT- +ACa-T- diff --git a/tests/integration/test_api.py b/tests/integration/test_api.py index d237dc8..005e280 100644 --- a/tests/integration/test_api.py +++ b/tests/integration/test_api.py @@ -6,12 +6,13 @@ from clipkit.modes import TrimmingMode from clipkit.msa import MSA + @pytest.mark.integration class TestApiInvocation(object): def test_input_file(self): trim_run, stats = clipkit( input_file_path="tests/integration/samples/simple.fa", - mode="gappy", + mode=TrimmingMode.gappy, gaps=0.3, sequence_type="nt", ) @@ -20,10 +21,9 @@ def test_input_file(self): "alignment_length": 6, "output_length": 4, "trimmed_length": 2, - "trimmed_percentage": 33.333 + "trimmed_percentage": 33.333, } assert isinstance(trim_run.version, str) - assert trim_run.complement is None assert isinstance(trim_run.trimmed, MultipleSeqAlignment) def test_raw_alignment(self): @@ -37,7 +37,6 @@ def test_raw_alignment(self): "alignment_length": 6, "output_length": 5, "trimmed_length": 1, - "trimmed_percentage": 16.667 + "trimmed_percentage": 16.667, } assert isinstance(trim_run.version, str) - assert trim_run.complement is None diff --git a/tests/unit/test_helpers.py b/tests/unit/test_helpers.py deleted file mode 100644 index 1a36ccb..0000000 --- a/tests/unit/test_helpers.py +++ /dev/null @@ -1,221 +0,0 @@ -import pytest -import pytest_mock -from pathlib import Path - - -import numpy as np -from Bio import AlignIO -from Bio import SeqIO -from Bio.Seq import Seq -from Bio.SeqRecord import SeqRecord -from Bio.Align import MultipleSeqAlignment - -from clipkit.helpers import ( - count_characters_at_position, - get_gap_chars, - report_column_features, - determine_site_classification_type, - create_keep_and_trim_msas, - write_trim_msa, - write_keep_msa, - SeqType, -) -from clipkit.files import FileFormat -from clipkit.modes import SiteClassificationType, TrimmingMode, trim, should_keep_site -from clipkit.settings import DEFAULT_AA_GAP_CHARS, DEFAULT_NT_GAP_CHARS - - -here = Path(__file__) - - -@pytest.fixture -def sample_msa(): - return MultipleSeqAlignment( - [ - SeqRecord( - seq=Seq("['A']"), - id="1", - name="", - description="", - dbxrefs=[], - ), - SeqRecord( - seq=Seq("['A']"), - id="2", - name="", - description="", - dbxrefs=[], - ), - SeqRecord( - seq=Seq("['A']"), - id="3", - name="", - description="", - dbxrefs=[], - ), - SeqRecord( - seq=Seq("['A']"), - id="4", - name="", - description="", - dbxrefs=[], - ), - SeqRecord( - seq=Seq("['A']"), - id="5", - name="", - description="", - dbxrefs=[], - ), - ] - ) - - -class TestCountCharactersAtPosition(object): - def test_gives_count_for_each_char(self): - ## setup - s = "ACTTTGGG" - - ## execution - res = count_characters_at_position(s, DEFAULT_NT_GAP_CHARS) - - ## check results - # test that each character has an associated key - for char in s: - assert char in res.keys() - - # test that the len of the res is equal to the - # number of unique string characters - assert len(res) == len(set(s)) - - -class TestGetSequenceAtPositionAndReportFeatures(object): - def test_gets_sequence_and_gappyness(self): - ## setup - alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - i = 5 - - ## execution - seq, gappyness = report_column_features(alignment, i, DEFAULT_AA_GAP_CHARS) - - ## check results - # test output types - assert isinstance(seq, str) - assert isinstance(gappyness, float) - - -class TestParsimonyInformativeOrConstant(object): - def test_determine_site_classification_type(self): - ## set up - num_occurences_pi = {"A": 5, "T": 10, "G": 2, "C": 4} - num_occurences_const = {"T": 10} - num_occurences_singleton = {"A": 1, "T": 2} - num_occurences_other = {"A": 1} - - ## execution - res_num_occurences_pi = determine_site_classification_type(num_occurences_pi) - res_num_occurences_const = determine_site_classification_type( - num_occurences_const - ) - res_num_occurences_singleton = determine_site_classification_type( - num_occurences_singleton - ) - res_num_occurences_other = determine_site_classification_type( - num_occurences_other - ) - - ## check results - assert res_num_occurences_pi is SiteClassificationType.parsimony_informative - assert res_num_occurences_const is SiteClassificationType.constant - assert res_num_occurences_singleton is SiteClassificationType.singleton - assert res_num_occurences_other is SiteClassificationType.other - - -class TestPopulateEmptyKeepDAndTrimD(object): - def test_create_keep_and_trim_msas(self): - ## set up - alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - - ## execution - keep_msa, trim_msa = create_keep_and_trim_msas(alignment, True) - - ## check results - expected_keep_data = { - "1": np.array([b"", b"", b"", b"", b"", b""]), - "2": np.array([b"", b"", b"", b"", b"", b""]), - "3": np.array([b"", b"", b"", b"", b"", b""]), - "4": np.array([b"", b"", b"", b"", b"", b""]), - "5": np.array([b"", b"", b"", b"", b"", b""]), - } - expected_trim_data = { - "1": np.array([b"", b"", b"", b"", b"", b""]), - "2": np.array([b"", b"", b"", b"", b"", b""]), - "3": np.array([b"", b"", b"", b"", b"", b""]), - "4": np.array([b"", b"", b"", b"", b"", b""]), - "5": np.array([b"", b"", b"", b"", b"", b""]), - } - - assert expected_keep_data.keys() == keep_msa._data.keys() - assert all( - np.array_equal(expected_keep_data[key], keep_msa._data[key]) - for key in expected_keep_data - ) - assert expected_trim_data.keys() == trim_msa._data.keys() - assert all( - np.array_equal(expected_trim_data[key], trim_msa._data[key]) - for key in expected_trim_data - ) - - -class TestWriteKeepD(object): - def test_write_keep_msa_writes_file(self, mocker, sample_msa): - ## set up - alignment = AlignIO.read(f"{here.parent}/examples/single_site.fa", "fasta") - keep_msa, _ = create_keep_and_trim_msas(alignment, True) - - out_file = "output_file_name.fa" - out_file_format = FileFormat.fasta - mock_msa = mocker.patch("clipkit.msa.MultipleSeqAlignment") - mock_msa.return_value = sample_msa - mock_write = mocker.patch("clipkit.helpers.SeqIO.write") - - ## execution - write_keep_msa(keep_msa, out_file, out_file_format) - - ## check results - mock_write.assert_called_once_with(sample_msa, out_file, out_file_format.value) - - -class TestWriteTrimD(object): - def test_write_trim_msa_calls_seqio_write(self, mocker, sample_msa): - ## set up - alignment = AlignIO.read(f"{here.parent}/examples/single_site.fa", "fasta") - _, trim_msa = create_keep_and_trim_msas(alignment, True) - - out_file = "output_file_name.fa" - out_file_format = FileFormat.fasta - mock_msa = mocker.patch("clipkit.msa.MultipleSeqAlignment") - mock_msa.return_value = sample_msa - mock_write = mocker.patch("clipkit.helpers.SeqIO.write") - - ## execution - write_trim_msa(trim_msa, out_file, out_file_format) - - ## check results - expected_completmentOut = f"{out_file}.complement" - mock_write.assert_called_once_with( - sample_msa, expected_completmentOut, out_file_format.value - ) - - -class TestGetGapChars(object): - def test_get_gap_chars(self): - ## set up - seq_type = SeqType.aa - - ## execution - res_seq_type = get_gap_chars(seq_type) - - ## check results - expected_res = DEFAULT_AA_GAP_CHARS - assert expected_res == res_seq_type diff --git a/tests/unit/test_modes.py b/tests/unit/test_modes.py deleted file mode 100644 index a647f12..0000000 --- a/tests/unit/test_modes.py +++ /dev/null @@ -1,421 +0,0 @@ -import pytest -from pathlib import Path - -import numpy as np -from Bio import AlignIO -from clipkit.modes import SiteClassificationType, TrimmingMode, trim, should_keep_site -from clipkit.msa import MSA -from clipkit.helpers import create_keep_and_trim_msas - - -here = Path(__file__) - - -class TestModes(object): - def test_should_keep_site_kpi_gappy_keep(self): - ## setup - mode = TrimmingMode.kpi_gappy - gappyness = 0.00 - gaps = 0.9 - - assert ( - should_keep_site( - mode, SiteClassificationType.parsimony_informative, gappyness, gaps - ) - is True - ) - - def test_should_keep_site_kpi_gappy_trim(self): - ## setup - mode = TrimmingMode.kpi_gappy - gappyness = 0.00 - gaps = 0.9 - - assert ( - should_keep_site(mode, SiteClassificationType.constant, gappyness, gaps) - is False - ) - - def test_should_keep_site_gappy_keep(self): - ## setup - mode = TrimmingMode.gappy - site_classification_type = SiteClassificationType.parsimony_informative - gappyness = 0.00 - gaps_threshold = 0.9 - - assert ( - should_keep_site(mode, site_classification_type, gappyness, gaps_threshold) - is True - ) - - def test_should_keep_site_gappy_trim(self): - ## setup - mode = TrimmingMode.gappy - site_classification_type = SiteClassificationType.parsimony_informative - gappyness = 0.95 - gaps_threshold = 0.9 - - assert ( - should_keep_site(mode, site_classification_type, gappyness, gaps_threshold) - is False - ) - - def test_should_keep_site_kpi_keep(self): - ## setup - mode = TrimmingMode.kpi - site_classification_type = SiteClassificationType.parsimony_informative - gappyness = 0.00 - gaps_threshold = 0.9 - - assert should_keep_site( - mode, site_classification_type, gappyness, gaps_threshold - ) - - def test_should_keep_site_kpi_trim(self): - ## setup - mode = TrimmingMode.kpi - site_classification_type = SiteClassificationType.other - gappyness = 0.95 - gaps_threshold = 0.9 - - assert ( - should_keep_site(mode, site_classification_type, gappyness, gaps_threshold) - is False - ) - - def test_should_keep_site_kpic_keep(self): - ## setup - mode = TrimmingMode.kpic - site_classification_type = SiteClassificationType.constant - gappyness = 0.95 - gaps_threshold = 0.9 - - assert should_keep_site( - mode, site_classification_type, gappyness, gaps_threshold - ) - - def test_should_keep_site_kpic_trim(self): - ## setup - mode = TrimmingMode.kpic - site_classification_type = SiteClassificationType.other - gappyness = 0.95 - gaps_threshold = 0.9 - - assert ( - should_keep_site(mode, site_classification_type, gappyness, gaps_threshold) - is False - ) - - def test_should_keep_site_kpic_gappy_keep(self): - ## setup - mode = TrimmingMode.kpic_gappy - site_classification_type = SiteClassificationType.constant - gappyness = 0.2 - gaps_threshold = 0.9 - - assert should_keep_site( - mode, site_classification_type, gappyness, gaps_threshold - ) - - def test_should_keep_site_kpic_gappy_trim(self): - ## setup - mode = TrimmingMode.kpic_gappy - site_classification_type = SiteClassificationType.constant - gappyness = 0.95 - gaps_threshold = 0.9 - - assert ( - should_keep_site(mode, site_classification_type, gappyness, gaps_threshold) - is False - ) - - def test_gappy_mode(self): - ## setup - gappyness = 0 - site_classification_type = SiteClassificationType.constant - site_classification_counts = { - SiteClassificationType.parsimony_informative: 0, - SiteClassificationType.constant: 0, - SiteClassificationType.singleton: 0, - SiteClassificationType.other: 0, - } - i = 2 - gaps_threshold = 0.9 - alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - use_log = False - - keep_msa, trim_msa = create_keep_and_trim_msas(alignment, True) - - ## execution - keep_msa, trim_msa = trim( - gappyness, - site_classification_type, - site_classification_counts, - keep_msa, - trim_msa, - i, - gaps_threshold, - alignment, - TrimmingMode.gappy, - use_log, - ) - - ## check results - expected_keep_data = { - "1": np.array([b"", b"", b"G", b"", b"", b""]), - "2": np.array([b"", b"", b"G", b"", b"", b""]), - "3": np.array([b"", b"", b"G", b"", b"", b""]), - "4": np.array([b"", b"", b"A", b"", b"", b""]), - "5": np.array([b"", b"", b"a", b"", b"", b""]), - } - expected_trim_data = { - "1": np.array([b"", b"", b"", b"", b"", b""]), - "2": np.array([b"", b"", b"", b"", b"", b""]), - "3": np.array([b"", b"", b"", b"", b"", b""]), - "4": np.array([b"", b"", b"", b"", b"", b""]), - "5": np.array([b"", b"", b"", b"", b"", b""]), - } - - assert expected_keep_data.keys() == keep_msa._data.keys() - assert all( - np.array_equal(expected_keep_data[key], keep_msa._data[key]) - for key in expected_keep_data - ) - assert expected_trim_data.keys() == trim_msa._data.keys() - assert all( - np.array_equal(expected_trim_data[key], trim_msa._data[key]) - for key in expected_trim_data - ) - - def test_kpi_gappy_mode(self): - ## setup - gappyness = 0 - site_classification_type = SiteClassificationType.constant - site_classification_counts = { - SiteClassificationType.parsimony_informative: 0, - SiteClassificationType.constant: 0, - SiteClassificationType.singleton: 0, - SiteClassificationType.other: 0, - } - i = 1 - gaps_threshold = 0.9 - alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - use_log = False - - keep_msa, trim_msa = create_keep_and_trim_msas(alignment, True) - - ## execution - keep_msa, trim_msa = trim( - gappyness, - site_classification_type, - site_classification_counts, - keep_msa, - trim_msa, - i, - gaps_threshold, - alignment, - TrimmingMode.kpi_gappy, - use_log, - ) - - ## check results - expected_keep_data = { - "1": np.array([b"", b"", b"", b"", b"", b""]), - "2": np.array([b"", b"", b"", b"", b"", b""]), - "3": np.array([b"", b"", b"", b"", b"", b""]), - "4": np.array([b"", b"", b"", b"", b"", b""]), - "5": np.array([b"", b"", b"", b"", b"", b""]), - } - expected_trim_data = { - "1": np.array([b"", b"-", b"", b"", b"", b""]), - "2": np.array([b"", b"-", b"", b"", b"", b""]), - "3": np.array([b"", b"-", b"", b"", b"", b""]), - "4": np.array([b"", b"G", b"", b"", b"", b""]), - "5": np.array([b"", b"C", b"", b"", b"", b""]), - } - - assert expected_keep_data.keys() == keep_msa._data.keys() - assert all( - np.array_equal(expected_keep_data[key], keep_msa._data[key]) - for key in expected_keep_data - ) - assert expected_trim_data.keys() == trim_msa._data.keys() - assert all( - np.array_equal(expected_trim_data[key], trim_msa._data[key]) - for key in expected_trim_data - ) - - def test_kpi_mode(self): - ## setup - gappyness = 0 - site_classification_type = SiteClassificationType.parsimony_informative - site_classification_counts = { - SiteClassificationType.parsimony_informative: 0, - SiteClassificationType.constant: 0, - SiteClassificationType.singleton: 0, - SiteClassificationType.other: 0, - } - i = 5 - gaps_threshold = 0.9 - alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - use_log = False - - keep_msa, trim_msa = create_keep_and_trim_msas(alignment, True) - - ## execution - keep_msa, trim_msa = trim( - gappyness, - site_classification_type, - site_classification_counts, - keep_msa, - trim_msa, - i, - gaps_threshold, - alignment, - TrimmingMode.kpi, - use_log, - ) - - ## check results - expected_keep_data = { - "1": np.array([b"", b"", b"", b"", b"", b"T"]), - "2": np.array([b"", b"", b"", b"", b"", b"T"]), - "3": np.array([b"", b"", b"", b"", b"", b"A"]), - "4": np.array([b"", b"", b"", b"", b"", b"A"]), - "5": np.array([b"", b"", b"", b"", b"", b"-"]), - } - expected_trim_data = { - "1": np.array([b"", b"", b"", b"", b"", b""]), - "2": np.array([b"", b"", b"", b"", b"", b""]), - "3": np.array([b"", b"", b"", b"", b"", b""]), - "4": np.array([b"", b"", b"", b"", b"", b""]), - "5": np.array([b"", b"", b"", b"", b"", b""]), - } - - assert expected_keep_data.keys() == keep_msa._data.keys() - assert all( - np.array_equal(expected_keep_data[key], keep_msa._data[key]) - for key in expected_keep_data - ) - assert expected_trim_data.keys() == trim_msa._data.keys() - assert all( - np.array_equal(expected_trim_data[key], trim_msa._data[key]) - for key in expected_trim_data - ) - - def test_kpic_mode(self): - ## setup - gappyness = 0 - site_classification_type = SiteClassificationType.constant - site_classification_counts = { - SiteClassificationType.parsimony_informative: 0, - SiteClassificationType.constant: 0, - SiteClassificationType.singleton: 0, - SiteClassificationType.other: 0, - } - i = 0 - gaps_threshold = 0.9 - alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - use_log = False - - keep_msa, trim_msa = create_keep_and_trim_msas(alignment, True) - - ## execution - keep_msa, trim_msa = trim( - gappyness, - site_classification_type, - site_classification_counts, - keep_msa, - trim_msa, - i, - gaps_threshold, - alignment, - TrimmingMode.kpic_gappy, - use_log, - ) - - ## check results - expected_keep_data = { - "1": np.array([b"A", b"", b"", b"", b"", b""]), - "2": np.array([b"A", b"", b"", b"", b"", b""]), - "3": np.array([b"A", b"", b"", b"", b"", b""]), - "4": np.array([b"A", b"", b"", b"", b"", b""]), - "5": np.array([b"A", b"", b"", b"", b"", b""]), - } - expected_trim_data = { - "1": np.array([b"", b"", b"", b"", b"", b""]), - "2": np.array([b"", b"", b"", b"", b"", b""]), - "3": np.array([b"", b"", b"", b"", b"", b""]), - "4": np.array([b"", b"", b"", b"", b"", b""]), - "5": np.array([b"", b"", b"", b"", b"", b""]), - } - - assert expected_keep_data.keys() == keep_msa._data.keys() - assert all( - np.array_equal(expected_keep_data[key], keep_msa._data[key]) - for key in expected_keep_data - ) - assert expected_trim_data.keys() == trim_msa._data.keys() - assert all( - np.array_equal(expected_trim_data[key], trim_msa._data[key]) - for key in expected_trim_data - ) - - def test_kpic_gappy_mode(self): - ## setup - gappyness = 0.2 - site_classification_type = SiteClassificationType.singleton - site_classification_counts = { - SiteClassificationType.parsimony_informative: 0, - SiteClassificationType.constant: 0, - SiteClassificationType.singleton: 0, - SiteClassificationType.other: 0, - } - - i = 3 - gaps_threshold = 0.9 - alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - use_log = False - - keep_msa, trim_msa = create_keep_and_trim_msas(alignment, True) - - ## execution - keep_msa, trim_msa = trim( - gappyness, - site_classification_type, - site_classification_counts, - keep_msa, - trim_msa, - i, - gaps_threshold, - alignment, - TrimmingMode.kpic_gappy, - use_log, - ) - - ## check results - expected_keep_data = { - "1": np.array([b"", b"", b"", b"", b"", b""]), - "2": np.array([b"", b"", b"", b"", b"", b""]), - "3": np.array([b"", b"", b"", b"", b"", b""]), - "4": np.array([b"", b"", b"", b"", b"", b""]), - "5": np.array([b"", b"", b"", b"", b"", b""]), - } - expected_trim_data = { - "1": np.array([b"", b"", b"", b"T", b"", b""]), - "2": np.array([b"", b"", b"", b"-", b"", b""]), - "3": np.array([b"", b"", b"", b"-", b"", b""]), - "4": np.array([b"", b"", b"", b"-", b"", b""]), - "5": np.array([b"", b"", b"", b"-", b"", b""]), - } - - assert expected_keep_data.keys() == keep_msa._data.keys() - assert all( - np.array_equal(expected_keep_data[key], keep_msa._data[key]) - for key in expected_keep_data - ) - assert expected_trim_data.keys() == trim_msa._data.keys() - assert all( - np.array_equal(expected_trim_data[key], trim_msa._data[key]) - for key in expected_trim_data - ) diff --git a/tests/unit/test_smart_gap_helper.py b/tests/unit/test_smart_gap_helper.py index 8565d82..c755168 100644 --- a/tests/unit/test_smart_gap_helper.py +++ b/tests/unit/test_smart_gap_helper.py @@ -32,7 +32,7 @@ def test_smart_gap_threshold_simple_case(self): expected_gaps = 0.8 ## execution - gaps = smart_gap_threshold_determination(alignment, DEFAULT_AA_GAP_CHARS, True) + gaps = smart_gap_threshold_determination(alignment, DEFAULT_AA_GAP_CHARS) ## check results assert expected_gaps == gaps @@ -42,7 +42,7 @@ def test_smart_gap_threshold_standard_case(self): alignment = AlignIO.read(f"{here.parent}/examples/EOG091N44M8_aa.fa", "fasta") ## execution - gaps = smart_gap_threshold_determination(alignment, DEFAULT_AA_GAP_CHARS, True) + gaps = smart_gap_threshold_determination(alignment, DEFAULT_AA_GAP_CHARS) expected_gaps = 0.8803 ## check results @@ -136,12 +136,9 @@ def test_gap_to_gap_slope_simple_case(self): def test_get_gaps_distribution(self): ## set up alignment = AlignIO.read(f"{here.parent}/examples/simple.fa", "fasta") - alignment_length = 6 ## execution - gaps_arr = get_gaps_distribution( - alignment, alignment_length, DEFAULT_NT_GAP_CHARS, True - ) + gaps_arr = get_gaps_distribution(alignment, DEFAULT_NT_GAP_CHARS) expected_gaps_arr = [0.0, 0.6, 0.0, 0.8, 0.0, 0.2] ## check results diff --git a/tests/unit/test_warnings.py b/tests/unit/test_warnings.py index 9b0cae7..0e4bca8 100644 --- a/tests/unit/test_warnings.py +++ b/tests/unit/test_warnings.py @@ -10,27 +10,90 @@ class TestWarnings(object): - def test_all_sites_trimmed(self, mocker): + @pytest.mark.parametrize( + "header_info, seq_records, should_warn", + [ + ( + [ + {"id": "1", "name": "1", "description": "1"}, + {"id": "2", "name": "2", "description": "2"}, + ], + np.array([["", "", "", "", "", ""], ["", "", "", "", "", ""]]), + True, + ), + ( + [ + {"id": "1", "name": "1", "description": "1"}, + {"id": "2", "name": "2", "description": "2"}, + ], + np.array( + [["A", "-", "G", "T", "A", "T"], ["A", "-", "G", "-", "A", "T"]] + ), + False, + ), + ], + ) + def test_warn_all_sites_trimmed( + self, mocker, header_info, seq_records, should_warn + ): mocked_warning = mocker.patch("clipkit.warnings.logger.warning") - entries = ["some_id"] - length = 10 - keep_msa = MSA(entries, length) - warn_if_all_sites_were_trimmed(keep_msa) + msa = MSA(header_info, seq_records) + warn_if_all_sites_were_trimmed(msa) - mocked_warning.assert_called_once_with( - "WARNING: All sites trimmed from alignment. Please use different parameters." - ) + if should_warn: + mocked_warning.assert_called_once_with( + "WARNING: All sites trimmed from alignment. Please use different parameters." + ) + else: + mocked_warning.assert_not_called() - def test_gaps_only(self, mocker): + @pytest.mark.parametrize( + "header_info, seq_records, gap_only_header_id", + [ + ( + [ + {"id": "1", "name": "1", "description": "1"}, + {"id": "2", "name": "2", "description": "2"}, + ], + np.array( + [["-", "-", "-", "-", "-", "-"], ["A", "G", "G", "T", "A", "C"]] + ), + "1", + ), + ( + [ + {"id": "1", "name": "1", "description": "1"}, + {"id": "2", "name": "2", "description": "2"}, + ], + np.array( + [["A", "G", "G", "T", "A", "C"], ["-", "-", "-", "-", "-", "-"]] + ), + "2", + ), + ( + [ + {"id": "1", "name": "1", "description": "1"}, + {"id": "2", "name": "2", "description": "2"}, + ], + np.array( + [["A", "-", "G", "T", "A", "T"], ["A", "-", "G", "-", "A", "T"]] + ), + None, + ), + ], + ) + def test_warn_if_entry_contains_only_gaps( + self, mocker, header_info, seq_records, gap_only_header_id + ): mocked_warning = mocker.patch("clipkit.warnings.logger.warning") - entries = ["some_id"] - length = 1 - keep_msa = MSA(entries, length) - keep_msa.set_entry_sequence_at_position("some_id", 0, "-") - warn_if_entry_contains_only_gaps(keep_msa, SeqType.aa) + msa = MSA(header_info, seq_records) + warn_if_entry_contains_only_gaps(msa) - mocked_warning.assert_called_once_with( - """WARNING: header id 'some_id' contains only gaps""" - ) + if gap_only_header_id: + mocked_warning.assert_called_once_with( + f"""WARNING: header id '{gap_only_header_id}' contains only gaps""" + ) + else: + mocked_warning.assert_not_called()