From 58ee35e922794b93ef3519f4e636f471a2f889e2 Mon Sep 17 00:00:00 2001 From: Joe Brown Date: Thu, 28 Jun 2018 13:58:39 -0700 Subject: [PATCH] updates appearance --- index.html | 374 + notebooks/html_file.ipynb | 383 - notebooks/lca.ipynb | 556 - notebooks/perseq_graphs.ipynb | 412 - notebooks/plotly_button_prototyping.ipynb | 56693 -------------------- resources/summary_quality.png | Bin 0 -> 192026 bytes resources/summary_table.png | Bin 0 -> 163376 bytes resources/summary_taxonomy.png | Bin 0 -> 130220 bytes 8 files changed, 374 insertions(+), 58044 deletions(-) create mode 100644 index.html delete mode 100644 notebooks/html_file.ipynb delete mode 100644 notebooks/lca.ipynb delete mode 100644 notebooks/perseq_graphs.ipynb delete mode 100644 notebooks/plotly_button_prototyping.ipynb create mode 100644 resources/summary_quality.png create mode 100644 resources/summary_table.png create mode 100644 resources/summary_taxonomy.png diff --git a/index.html b/index.html new file mode 100644 index 0000000..ae9f319 --- /dev/null +++ b/index.html @@ -0,0 +1,374 @@ + + + + + + +PerSeq - Per sequence functional and taxonomic assignments + + + +
+

PerSeq - Per sequence functional and taxonomic assignments

+ + + + + + + + + + + +
+

Summary

+
+

Sequence Counts

+
+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
SampleSequencesPairs + JoinedJoin + RateAverage + InsertUniqueCleanAssigned + FunctionAssigned + TaxonomyAssigned + Both
S082000005471054.710%164.949732383062633657486
S0162000004093340.933%184.8388733409440671120785
S0172000004808648.086%183.9448703723044311381948
S0302000005392153.921%188.2470443995737251081702
+
+
+

Sequence Quality

+
+
+

Taxonomy by Count

+

Samples are sorted based on their Shannon index calculated from taxonomically +annotated sequences. The order is most to least diverse.

+
+
+

Taxonomy by Percent

+
+
+
+

Methods

+

Paired-end sequences were evaluated for quality using VSEARCH [1]. Sequence +reads are quality trimmed after successful merging using bbmerge [2]. +Sequences are allowed to be extended up 300 bp +during the merging process to account for non-overlapping R1 and R2 sequences +(k=60 extend2=60 iterations=5 qtrim2=t). Merged sequences are deduplicated +using the clumpify tool [2] then, by default, filtered of PhiX and +rRNA using bbsplit [2]. An arbitrary number of Name:FASTA pairs may be +specified during the decontamination process. Functional annotation and +taxonomic classification were performed following the decontamination step.

+
+

Functional Annotation

+

The blastx algorithm of DIAMOND [3] was used to align nucleotide sequences to +the KEGG protein reference database [4] consisting of non-redundant, family +level fungal eukaryotes and genus level prokaryotes +(--strand=both --evalue 0.00001). The highest scoring alignment per +sequence was used for functional annotation.

+
+
+

Taxonomic Annotation

+

Kmer-based taxonomic classification was performed on the merged reads using +Kaiju [5] in greedy mode (-a greedy -E 0.05). NCBI's nr database [6] +containing reference sequences for archaea, bacteria, viruses, fungi, and +microbial eukaryotes was used as the reference index for Kaiju.

+
+
+

References

+
    +
  1. Rognes T, Flouri T, Nichols B, Quince C, Mahé F. VSEARCH: a versatile open source tool for metagenomics. PeerJ. PeerJ Inc; 2016;4:e2584.
  2. +
  3. Bushnell B. BBTools [Internet]. Available from: https://sourceforge.net/projects/bbmap/
  4. +
  5. Buchfink B, Xie C, Huson DH. Fast and sensitive protein alignment using DIAMOND. Nat. Methods. Nature Publishing Group; 2015;12:59–60.
  6. +
  7. Kanehisa M, Sato Y, Kawashima M, Furumichi M, Tanabe M. KEGG as a reference resource for gene and protein annotation. Nucleic Acids Res. 2016;44:D457–62.
  8. +
  9. Menzel P, Ng KL, Krogh A. Fast and sensitive taxonomic classification for metagenomics with Kaiju. Nat Commun. Nature Publishing Group; 2016;7:11257.
  10. +
  11. NCBI Resource Coordinators. Database resources of the National Center for Biotechnology Information. Nucleic Acids Res. 2018;46:D8–D13.
  12. +
+
+
+
+

Execution Environment

+
+channels:
+    - bioconda
+    - conda-forge
+    - defaults
+dependencies:
+    - python=3.6
+    - bbmap=37.99
+    - click=6.7
+    - diamond=0.9.21
+    - kaiju=1.6.2
+    - numpy
+    - pandas=0.23.1
+    - plotly=2.7.0
+    - snakemake>=5.1.3
+    - vsearch=2.6.0
+
+
+
+

Output

+
+

Classification Tables

+

Per sample classifications in tables/ contain:

+ ++++ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
Header IDDefinition
aa_alignment_lengthThe length of the DIAMOND blastx hit
aa_percent_idThe percent ID of the DIAMOND blastx hit; could be used to increase post-processing stringency
ecEnzyme Commission number from KEGG; semicolon delimited where multiple
koKEGG entry ID
productKEGG gene ID <semicolon> KEGG product
read_idThe sequence identifier (unique)
kaiju_alignment_lengthThe length of the Kaiju hit
kaiju_classificationThe Kaiju classification in order of superkingdom, phylum, order, class, family, genus, species; "NA" for each taxonomic level not defined
blastx_lca_classificationThe LCA result from the blastx HSPs
+
+
+

Summary Tables

+
+

Taxonomy

+

Per taxonomy assignments in tables named summaries/taxonomy/<level>.txt +contain:

+ ++++ + + + + + + + + + + + + + +
Header IDDefinition
taxonomy_<level>taxonomic level into which counts have been summed
samples namesnon-normalized, per sample sum at this taxonomic level
+
+
+

Function

+

Per function assignments in tables named summaries/function/<type>.txt +contain:

+ ++++ + + + + + + + + + + + + + + + + + + + + + + +
Header IDDefinition
<type>either KO, EC, or product into which counts have been summed
samples namesnon-normalized, per sample sum for this particular functional group
level_1KEGG hierarchy [level 1] if KO defined in first column
level_2KEGG hierarchy [level 2] if KO defined in first column
level_3KEGG hierarchy [level 3] if KO defined in first column
+
+
+

Combined

+

Per taxonomy+function assignments in tables named +summaries/combined/<type>_<level>.txt contain:

+ ++++ + + + + + + + + + + + + + + + + + + + + + + + + + +
Header IDDefinition
<type>either KO, EC, or product; counts are summed using <type>+<taxonomy>
taxonomy_<level>taxonomic level; counts are summed using <type>+<taxonomy>
sample namesnon-normalized, per sample sum for this particular functional group
level_1KEGG hierarchy [level 1] if KO defined in first column
level_2KEGG hierarchy [level 2] if KO defined in first column
level_3KEGG hierarchy [level 3] if KO defined in first column
+
+
+
+
+

Downloads

+
+
+
+
+
file1:
+
ko.txt
+
+
+
+
+
file2:
+
phylum.txt
+
+
+
+
+
file3:
+
ko_phylum.txt
+
+
+
+
+
+2018-06-28
+
+
+ + diff --git a/notebooks/html_file.ipynb b/notebooks/html_file.ipynb deleted file mode 100644 index c642f84..0000000 --- a/notebooks/html_file.ipynb +++ /dev/null @@ -1,383 +0,0 @@ -{ - "cells": [ - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "import argparse\n", - "import os\n", - "import pandas as pd\n", - "import plotly.graph_objs as go\n", - "from plotly import offline\n", - "from cufflinks import iplot\n", - "from snakemake.utils import report\n", - "\n", - "PLOTLY_PARAMS = dict(\n", - " include_plotlyjs=False, show_link=False, output_type=\"div\", image_height=700\n", - ")\n", - "\n", - "\n", - "#parses log_file for extra info\n", - "\n", - "# def parse_log_file(log_file, keyword, expect_one_value=True):\n", - "# content = open(log_file).read()\n", - "# pos = content.find(keyword)\n", - "# if pos == -1:\n", - "# raise Exception(\"Didn't find {} in file:\\n\\n{}\".format(keyword, log_file))\n", - "\n", - "# else:\n", - "# if expect_one_value:\n", - "# return content[pos:].split()[2]\n", - "\n", - "# else:\n", - "# return content[pos:].split()[2:]\n", - "\n", - "#dependent functions for the others\n", - "#function to parse kaiju output\n", - "\n", - "#parse the kaiju output\n", - "def parse_align(alignment_file):\n", - " total_lines=0\n", - " order_dict={}\n", - " class_dict={}\n", - " phylum_dict={}\n", - " total_align=[]\n", - " #for alignment_file in file_list:\n", - " with open(alignment_file) as file:\n", - " classified=0\n", - " unc=0\n", - " for line in file:\n", - "\n", - "\n", - " total_lines+=1\n", - " toks=line.strip().split('\\t')\n", - " #print(toks)\n", - " classification=toks[0]\n", - "\n", - " if classification =='C':\n", - " classified+=1\n", - " bits=toks[7].split(';')\n", - " order=bits[3].strip()\n", - " clas=bits[2]\n", - " phylum=bits[1]\n", - " if order in order_dict:\n", - " order_dict[order]+=1\n", - " else:\n", - " order_dict[order]=1\n", - " if clas in class_dict:\n", - " class_dict[clas]+=1\n", - " else:\n", - " class_dict[clas]=1\n", - " if phylum in phylum_dict:\n", - " phylum_dict[phylum]+=1\n", - " else:\n", - " phylum_dict[phylum]=1\n", - " else:\n", - " unc+=1\n", - " total=classified+unc\n", - " # or should this be a list. prob list\n", - " #print('family',family)\n", - " return order_dict,class_dict,phylum_dict,total \n", - "\n", - "\n", - "#calculates the order for diversity \n", - "def gini(x, corr=False):\n", - " \"\"\"Calculates Gini coefficient, the measure of inequality among values\n", - " of a frequency distribution. A Gini coefficient of zero expresses\n", - " perfect equality.\n", - "\n", - " Port from ineq package in R::\n", - "\n", - " > library(ineq)\n", - " > t <- c(1,2,6,7,8)\n", - " > Gini(t)\n", - " [1] 0.3166667\n", - " > Gini(t, corr=TRUE)\n", - " [1] 0.3958333\n", - "\n", - " Args:\n", - " x (list): list or array of numbers\n", - " corr (Optional[bool]): finite sample correction\n", - "\n", - " Returns:\n", - " float\n", - "\n", - " >>> import numpy as np\n", - " >>> t = [1,2,6,7,8]\n", - " >>> gini(t) # doctest: +ELLIPSIS\n", - " 0.3166...\n", - " >>> gini(t, corr=True) # doctest: +ELLIPSIS\n", - " 0.3958...\n", - " >>> gini([]) # doctest: +ELLIPSIS\n", - " Traceback (most recent call last):\n", - " ...\n", - " AssertionError: x is empty\n", - " >>> t = [1,2,6,7,\"A\"]\n", - " >>> gini(t) # doctest: +ELLIPSIS\n", - " Traceback (most recent call last):\n", - " ...\n", - " ValueError: could not convert...\n", - " \"\"\"\n", - " x = np.array(x, dtype=float)\n", - " # filter out nan values as list is coming from merged dataframe\n", - " x = x[~np.isnan(x)]\n", - " n = len(x)\n", - " assert n > 0, \"x is empty\"\n", - " x.sort(kind=\"mergesort\")\n", - " G = sum(np.arange(1, n + 1) * x)\n", - " G = 2 * G / sum(x) - (n + 1)\n", - " if corr:\n", - " return G / (n - 1)\n", - " else:\n", - " return G / n\n", - " \n", - "#step 2\n", - "#so this will make the counts information that we need. but this should be put into a function because it needs to be done\n", - "#for all three of the taxa\n", - "import numpy as np\n", - "def process_reads(tax_level, pandas_df):\n", - " '''This function will take the merged reads from the file and put them into a graphable\n", - " form for both counts and percents. It will return both. '''\n", - " #cols = [i for i in m.columns.tolist() if i.startswith(\"Percent_\")]\n", - " header=merged_phy_final.columns.tolist()\n", - " header.pop(0)\n", - " full= merged_phy_final.sort_values(by=header,ascending=False) #organize these by count\n", - "\n", - " sample_order = []\n", - " for read_col in merged_phy_final.columns.tolist(): #this will make a list of the gini coefficient of where these should be located by diversity of the sample\n", - " if read_col.startswith(\"Reads_\"):\n", - " sample_order.append([read_col.strip(\"Reads_\"), gini(merged_phy_final[read_col])])\n", - " sample_order = sorted(sample_order, key=lambda x: x[1])\n", - "\n", - " sub = full[[tax_level] + [\"Reads_%s\" % sample_order[i][0] for i in range(len(sample_order))]]\n", - " sub = sub.head(100)\n", - " cols=sub[tax_level].tolist()\n", - "\n", - " #find the percent\n", - " sub_perc=sub[header].div(total_counts)\n", - " sub_perc_t=sub_perc.transpose()\n", - " sub_perc_t.columns=cols #reset the names \n", - "\n", - "\n", - " #these are just the counts\n", - " sub_t=sub.transpose() #needs to be in this form or it wont work\n", - " sub_t.columns = sub_t.loc[tax_level] #set the column names as the taxoomy levels \n", - " sub_t.drop([tax_level], inplace=True) #this just takes out the duplicate header\n", - " \n", - " return sub_t, sub_perc_t\n", - "\n", - "\n", - "#step 1\n", - "def df_by_merge(path,tax_level):\n", - " \"\"\"\n", - " Reads in multiple sample alignments from diamond in a given directory and merges them into\n", - " a single pandas.DataFrame. It returns a pandas dataframe for each of th\n", - " phylum that is ready to plug into the processing function. Also returns total counts\n", - " which is necessary to calculate the percentage of total that is being represented \n", - " \"\"\"\n", - " merged_phy = None\n", - " samples = []\n", - " total_counts=[]\n", - " for f in os.listdir(path):\n", - " f = os.path.join(path, f)\n", - "\n", - " #print(f)\n", - " #if not f.endswith(\"%s_summary.txt\" % tax_level): continue\n", - " sample = os.path.basename(f).partition(\"_aln_names.txt\")[0]\n", - " samples.append(sample) #making a list of the sample headers\n", - " header = [tax_level,\"Reads_%s\" % sample]\n", - " if merged_phy is None:\n", - " #print('yes')\n", - " #merged = pd.read_table(f, header=0, names=header, comment=\"-\")\n", - " phy,ordr,clas,tc=parse_align(f)\n", - " #print(phy)\n", - " total_counts.append(tc)\n", - " merged_phy = pd.DataFrame(data=phy,index=[0]).transpose()\n", - " merged_phy.reset_index(inplace=True)\n", - " merged_phy.columns=header\n", - " merged_clas = pd.DataFrame(data=clas, index=[0]).transpose()\n", - " merged_clas.reset_index(inplace=True)\n", - " merged_clas.columns=header\n", - " merged_ord = pd.DataFrame(data=ordr, index=[0]).transpose()\n", - " merged_ord.reset_index(inplace=True)\n", - " merged_ord.columns=header\n", - " #cols = merged.columns.tolist() #make a list of the column headers from the merged file\n", - " #cols.remove(tax_level) #remove the order tag\n", - " #cols.insert(0, tax_level) #insert it at the front.\n", - " #merged = merged[cols]\n", - " continue\n", - " phy,ordr,clas,tc=parse_align(f)\n", - " total_counts.append(tc)\n", - " df1 = pd.DataFrame(data=phy,index=[0]).transpose()\n", - " df1.reset_index(inplace=True)\n", - " df1.columns=header\n", - " df2 = pd.DataFrame(data=ordr,index=[0]).transpose()\n", - " df2.reset_index(inplace=True)\n", - " df2.columns=header\n", - " df3 = pd.DataFrame(data=clas,index=[0]).transpose()\n", - " df3.reset_index(inplace=True)\n", - " df3.columns=header\n", - " merged_phy_final = merged_phy.merge(df1, on=tax_level, how=\"outer\")\n", - " merged_ord_final = merged_ord.merge(df2, on=tax_level, how=\"outer\")\n", - " merged_class_final = merged_clas.merge(df3, on=tax_level, how=\"outer\")\n", - " #print(total_counts)\n", - "\n", - "\n", - " p_done,p_perc_done=process_reads(tax_level,merged_phy_final)\n", - " c_done,c_perc_done=process_reads(tax_level,merged_class_final)\n", - " o_done,o_perc_done=process_reads(tax_level,merged_order_final)\n", - " \n", - " return p_done,p_perc_done,c_done, c_perc_done,o_done,o_perc_done\n", - "\n", - "\n", - "\n", - "\n", - "\n", - "def make_plots(p_done,c_done,o_done,y_axis_title):\n", - " ##code in this block works\n", - "\n", - " # data traces are taxonomies across samples\n", - " data = [go.Bar(x=p_done.index, y=p_done[tax], name=tax, visible=True) for tax in p_done.columns.tolist()] + \\\n", - " [go.Bar(x=c_done.index, y=c_done[tax], name=tax, visible=False) for tax in c_done.columns.tolist()] + \\\n", - " [go.Bar(x=o_done.index, y=o_done[tax], name=tax, visible=True) for tax in o_done.columns.tolist()]\n", - "\n", - "\n", - " # the number of taxa\n", - " trace_length = len(o_done.columns)\n", - "\n", - " # plot buttons\n", - " updatemenus = list([\n", - " dict(type=\"buttons\",\n", - " active=0,\n", - " buttons=list([ \n", - " dict(label = 'Phylum',\n", - " method = 'update',\n", - " args = [{'visible': [True]*trace_length + [False]*trace_length + [False]*trace_length},\n", - " {'yaxis': {\"title\": \"Percent\"}}\n", - " ]),\n", - " dict(label = 'Class',\n", - " method = 'update',\n", - " args = [{'visible': [False]*trace_length + [True]*trace_length + [False]*trace_length},\n", - " {'yaxis': {\"title\": \"Count\"}}\n", - " ]),\n", - " dict(label = 'Order',\n", - " method = 'update',\n", - " args = [{'visible': [False]*trace_length + [False]*trace_length + [True]*trace_length},\n", - " {'yaxis': {\"title\": \"Count\"}}\n", - " ])\n", - " ]),\n", - " direction = 'left',\n", - " pad = {'r': 0, 't': 0},\n", - " showactive = True,\n", - " x = 0,\n", - " xanchor = 'left',\n", - " y = 1.2,\n", - " yanchor = 'top' \n", - " )\n", - " ])\n", - "\n", - " # initial layout\n", - " layout = dict(title=\"Assignments per Sample By Count (Top 20)\",\n", - " updatemenus=updatemenus,\n", - " barmode=\"stack\",\n", - " margin={\"b\": 200},\n", - " xaxis={\"tickangle\": -60},\n", - " yaxis=y_axis_title,\n", - " showlegend=False,\n", - " hovermode='closest'\n", - " )\n", - "\n", - " fig = go.Figure(data=data, layout=layout)\n", - "\n", - " return fig\n", - "\n", - "def main(path_to_files):\n", - " p_done,p_perc_done,c_done,c_perc_done,o_done,o_perc_done=df_by_merge(path_to_files)\n", - " div = {} #this this appears to be what the actual html is going to call on(because it contains the plot info)\n", - " labels = {\n", - " \"percentage\": \"Percent of Total Reads Aligned\",\n", - " \"counts\": \"Count of Alignments\",\n", - " }\n", - " for variable in [\n", - " \"percentage\", \"counts\"\n", - " ]:\n", - " if variable == 'counts'\n", - " y_axis_label = labels[variable]\n", - " div[variable] = offline.plot(iplot(\n", - " make_plots(p_done,c_done,o_done,y_axis_label)\n", - " ),\n", - " **PLOTLY_PARAMS,\n", - " )\n", - " else:\n", - " y_axis_label = labels[variable]\n", - " div[variable] = offline.plot(iplot(\n", - " make_plots(p_perc_done,c_perc_done,o_perc_done,y_axis_label)\n", - " ),\n", - " **PLOTLY_PARAMS,\n", - " )\n", - " \n", - "\n", - " report_str = \"\"\"\n", - ".. raw:: html\n", - " \n", - "=============================================================\n", - "ATLAS_ - Assembly Summary\n", - "=============================================================\n", - ".. _ATLAS: https://github.com/pnnl/atlas\n", - ".. contents::\n", - " :backlinks: none\n", - "Summary\n", - "-------\n", - "N50 Counts by Taxonomy\n", - "***\n", - ".. raw:: html\n", - " {div[counts]}\n", - "Assembly Length Percentage by Taxonomy\n", - "***************\n", - ".. raw:: html\n", - " {div[percentage]}\n", - "\n", - "For more information see Table_1_\n", - "Downloads\n", - "---------\n", - "\"\"\"\n", - " report(report_str, report_out, Table_1=combined_stats, stylesheet=os.path.join(os.path.abspath(os.path.dirname(__file__)), \"report.css\"))\n", - "\n", - "\n", - "if __name__ == \"__main__\":\n", - " p = argparse.ArgumentParser()\n", - " p.add_argument(\"--path_to_alignment_files\", nargs=\"+\")\n", - " p.add_argument(\"--report-out\")\n", - "\n", - " args = p.parse_args()\n", - " main(\n", - " args.path_to_alignment_files,\n", - " args.report_out\n", - " )\n" - ] - } - ], - "metadata": { - "kernelspec": { - "display_name": "Python 3", - "language": "python", - "name": "python3" - }, - "language_info": { - "codemirror_mode": { - "name": "ipython", - "version": 3 - }, - "file_extension": ".py", - "mimetype": "text/x-python", - "name": "python", - "nbconvert_exporter": "python", - "pygments_lexer": "ipython3", - "version": "3.6.4" - } - }, - "nbformat": 4, - "nbformat_minor": 2 -} diff --git a/notebooks/lca.ipynb b/notebooks/lca.ipynb deleted file mode 100644 index 02e2b43..0000000 --- a/notebooks/lca.ipynb +++ /dev/null @@ -1,556 +0,0 @@ -{ - "cells": [ - { - "cell_type": "code", - "execution_count": 86, - "metadata": {}, - "outputs": [], - "source": [ - "#convert the kegg id to a number\n", - "\n", - " " - ] - }, - { - "cell_type": "code", - "execution_count": 89, - "metadata": {}, - "outputs": [ - { - "data": { - "text/plain": [ - "'Exiguobacterium sibiricum 255-15'" - ] - }, - "execution_count": 89, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "convert_tax('k117_1_1\tesi:Exig_1092\t53.4\t103\t41\t1\t1\t103\t127\t222\t8.3e-23\t111.7')" - ] - }, - { - "cell_type": "code", - "execution_count": 127, - "metadata": {}, - "outputs": [], - "source": [ - "import re\n", - "with open('real_tax_convert.txt','r') as tax_id:\n", - " converter={}\n", - " for line in tax_id:\n", - " \n", - " toks=line.strip().split('\\t')\n", - " test=toks[1]\n", - " #print(test)\n", - " try:\n", - " others=re.search(r'([a-z]+), .*; (.*)',test)\n", - " kegg_id=others.group(1)\n", - " NCBI_id=others.group(2)\n", - " converter[kegg_id]=NCBI_id\n", - " except:\n", - " print(test)\n", - " break\n", - " #kegg_id=others.group(0)\n", - " \n" - ] - }, - { - "cell_type": "code", - "execution_count": 107, - "metadata": {}, - "outputs": [], - "source": [] - }, - { - "cell_type": "code", - "execution_count": 125, - "metadata": {}, - "outputs": [ - { - "name": "stdout", - "output_type": "stream", - "text": [ - "no\n" - ] - } - ], - "source": [ - "if 'Cryobacterium arcticum PAMC 27867' in blah:\n", - " print('yes')\n", - "else:\n", - " print('no')" - ] - }, - { - "cell_type": "code", - "execution_count": 171, - "metadata": {}, - "outputs": [], - "source": [ - "class Node(object):\n", - "\n", - " def __init__(self, taxonomy, node_id, parent_id, tax_level):\n", - " \"\"\"Represents a node within a tree.\n", - " Args:\n", - " taxonomy (str): taxonomy name or ID\n", - " node_id (str): taxonomy ID\n", - " parent_id (str): taxonomy ID of parent\n", - " tax_level (str): the taxonomic level for this node_id\n", - " \"\"\"\n", - " # the current node's string ID\n", - " self.taxonomy = taxonomy\n", - " # the current node's digit ID\n", - " self.node_id = node_id\n", - " self.parent_id = parent_id\n", - " self.tax_level = tax_level\n", - "\n", - "class Tree(object):\n", - "\n", - " def __init__(self, tree_file):\n", - " \"\"\"Builds reference dictionary of Taxonomy Name, Taxonomy ID, and Parent Taxonomy ID.\"\"\"\n", - " self.tree = defaultdict(dict)\n", - " \n", - " with open(tree_file) as tree_fh:\n", - " for line in tree_fh:\n", - " toks = line.strip().split(\"\\t\")\n", - " if not toks[0] == '1' and not toks[2] == '1':\n", - " assert not toks[0] == toks[2]\n", - " if not len(toks) == 4:\n", - " logging.warning(\"Line [%s] does not have ID, NAME, PARENTID, TAX LEVEL\" % line.strip())\n", - " continue\n", - " self.add_node(toks[1], toks[0], toks[2], toks[3])\n", - " \n", - " \n", - "\n", - " def add_node(self, taxonomy, node_id, parent_id, tax_level):\n", - " \"\"\"Adds node to tree dictionary.\n", - " Args:\n", - " taxonomy (str): the taxonomy name\n", - " node_id (str): the taxonomy id\n", - " parent_id (str): the parent's taxonomy id\n", - " tax_level (str): the taxonomic level for this node_id\n", - " \"\"\"\n", - " \n", - " # taxonomy id to node mapping; ensures unique nodes despite non-unique names\n", - " self.tree[node_id] = Node(taxonomy, node_id, parent_id, tax_level)\n", - " \n", - "\n", - " def lca(self, taxonomies, threshold=1.):\n", - " \"\"\"Returns the taxonomy of the LCA and optionally only use the top fraction of hits.\n", - " Args:\n", - " taxonomies (list): list of taxonomies (ID); when using threshold < 1 they\n", - " should be ordered by decreasing bitscore\n", - " threshold (Optional[float]): 0-1; threshold fraction of hits to be factored into lca\n", - " Returns:\n", - " str: node id of LCA\n", - " \"\"\"\n", - " if threshold > 1:\n", - " threshold = 1\n", - " elif threshold < 0.01:\n", - " # 10% as the minimum\n", - " threshold = 0.1\n", - "\n", - " count_target = len(taxonomies) * threshold\n", - " count_taxonomies = defaultdict(int)\n", - "\n", - " for taxonomy in taxonomies:\n", - " #print('tax',taxonomy) \n", - " \n", - " try:\n", - " current_taxonomy = self.tree[taxonomy].node_id\n", - " #print(current_taxonomy)\n", - " except AttributeError:\n", - " # dict when key not present\n", - " # taxonomy represented in the reference database, but is not present in the tree\n", - " continue\n", - " \n", - " while not current_taxonomy == \"1\":\n", - " #print('curtx',current_taxonomy)\n", - " count_taxonomies[current_taxonomy] += 1\n", - " if count_taxonomies[current_taxonomy] >= count_target:\n", - " #print('target found')\n", - " return self.tree[current_taxonomy].node_id\n", - " \n", - " # traverse up tree\n", - " current_taxonomy = self.tree[current_taxonomy].parent_id\n", - " return \"1\"\n", - " \n", - " def taxonomic_lineage(self, taxonomy):\n", - " \"\"\"For a given taxonomy ID, return its lineage as a list of IDs.\n", - " Args:\n", - " taxonomy (str): taxonomy name or taxonomy ID\n", - " Returns:\n", - " list of lineage\n", - " Example:\n", - " >>> tree = Tree(\"ref/ncbi_taxonomy_tree.txt\")\n", - " >>> tree.taxonomic_lineage(\"135621\")\n", - " ['1', '131567', '99999999', '2', '1224', '1236', '72274', '135621']\n", - " \"\"\"\n", - " # a large portion of ORFs\n", - " if taxonomy == \"1\":\n", - " return [taxonomy]\n", - "\n", - " lineage = [taxonomy]\n", - " while not taxonomy == \"1\":\n", - " taxonomy = self.tree[taxonomy].parent_id\n", - " # prepend\n", - " lineage.insert(0, taxonomy)\n", - " return lineage\n", - " \n", - " def lca_majority(self, taxonomy_list, majority_cutoff):\n", - " \"\"\"Finds a consensus majority up a tree structure.\n", - " Args:\n", - " taxonomy_list (list): list of taxonomy names or IDs\n", - " majority_cutoff (float): this is the total length of the taxonomy list * majority fraction\n", - " Returns:\n", - " list: string representing majority taxonomy ID, lineage counts dictionary with a key\n", - " of taxonomy ID and value of list populated with ordered lineage taxonomy IDs\n", - " Example:\n", - " >>> taxonomy_list = ['gamma subgroup', 'RNA similarity group I',\n", - " 'purple photosynthetic bacteria and relatives',\n", - " 'not Bacteria Haeckel 1894',\n", - " 'purple photosynthetic bacteria and relatives', 'gamma subgroup',\n", - " 'gamma subgroup', 'purple photosynthetic bacteria and relatives',\n", - " 'purple photosynthetic bacteria and relatives']\n", - " >>> majority_cutoff = len(taxonomy_list) * .5\n", - " >>> tree = Tree(\"ref/ncbi_taxonomy_tree.txt\")\n", - " >>> tree.lca_majority(taxonomy_list)\n", - " ('1224', {'1224': ['1', '131567', '99999999', '2', '1224'],\n", - " '1236': ['1', '131567', '99999999', '2', '1224', '1236'],\n", - " '2': ['1', '131567', '99999999', '2'],\n", - " '286': ['1', '131567', '99999999', '2', '1224', '1236', '72274', '135621', '286']})\n", - " \"\"\"\n", - " lineage_counts = Counter()\n", - " lineages = {}\n", - " for taxonomy in taxonomy_list:\n", - " lineage = self.taxonomic_lineage(taxonomy)\n", - " lineage_counts.update(lineage)\n", - " lineages[taxonomy] = lineage\n", - " lineage_indexes = index_of_list_items(lineages.values())\n", - " for taxonomy in lineage_indexes:\n", - " if lineage_counts[taxonomy] > majority_cutoff:\n", - " return taxonomy, lineages\n", - " return \"1\", lineages\n", - "\n", - "\n" - ] - }, - { - "cell_type": "code", - "execution_count": 174, - "metadata": {}, - "outputs": [ - { - "name": "stdout", - "output_type": "stream", - "text": [ - "1783272\n" - ] - }, - { - "data": { - "text/plain": [ - "['1', '131567', '2', '1783272']" - ] - }, - "execution_count": 174, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "test=Tree('refseq.tree')\n", - "lists=['6','10']\n", - "testing=test.lca(taxonomies)\n", - "print(testing)\n", - "test.taxonomic_lineage(testing)" - ] - }, - { - "cell_type": "code", - "execution_count": 166, - "metadata": {}, - "outputs": [], - "source": [ - "from collections import Counter, defaultdict, deque, OrderedDict\n", - "import re\n", - "\n", - "\n", - "#this converts the kegg ID into the NCBI ID \n", - "def convert_tax(aligned):\n", - " \n", - " with open('real_tax_convert.txt','r') as tax_id:\n", - " converter={}\n", - " for line in tax_id:\n", - "\n", - " toks=line.strip().split('\\t')\n", - " test=toks[1]\n", - " #print(test)\n", - " others=re.search(r'([a-z]+), .*; (.*)',test)\n", - " kegg_id=others.group(1)\n", - " NCBI_id=others.group(2)\n", - " converter[kegg_id]=NCBI_id\n", - " \n", - " toks=aligned.strip().split('\\t')\n", - " kegg_id=toks[1].split(':')[0]\n", - " try:\n", - "\n", - " if kegg_id in converter:\n", - " return(converter[kegg_id])\n", - " except KeyError:\n", - " pass\n", - " \n", - " \n", - "\n", - "\n", - "\n", - "#below will make the taxonomy name to the node id so that lca can run. somehow need to integrate into the Tree class(if possible)\n", - "tax_to_node_id={}\n", - "with open('refseq.tree') as tree_fh:\n", - " for line in tree_fh:\n", - " toks = line.strip().split(\"\\t\")\n", - " if not toks[0] == '1' and not toks[2] == '1':\n", - " assert not toks[0] == toks[2]\n", - " if not len(toks) == 4:\n", - " logging.warning(\"Line [%s] does not have ID, NAME, PARENTID, TAX LEVEL\" % line.strip())\n", - " continue\n", - " tax_to_node_id[toks[1]]=toks[0]\n", - " \n", - "\n", - "#this function will generate the taxonomy that we want from the alignment file\n", - "def make_tax_list(alignment_file):\n", - "\n", - " with open(alignment_file,'r') as alignments:\n", - " taxonomies=[]\n", - " for line in alignments:\n", - " converted_line=convert_tax(line)\n", - " try:\n", - " node_id=tax_to_node_id[converted_line]\n", - " except KeyError:\n", - " continue\n", - " taxonomies.append(node_id)\n", - " return taxonomies\n", - "\n", - "\n", - "\n", - "\n", - " \n", - " \n" - ] - }, - { - "cell_type": "code", - "execution_count": 193, - "metadata": {}, - "outputs": [ - { - "name": "stdout", - "output_type": "stream", - "text": [ - "k117_1_1\n", - "['1', '131567', '2', '1783272']\n", - "k117_2_1\n", - "['1', '131567', '2', '1224', '28211', '356', '69277', '28100', '1867719']\n", - "k117_3_1\n", - "['1', '131567', '2', '1224', '28211', '356', '45401', '29407', '674703']\n" - ] - } - ], - "source": [ - "from itertools import groupby\n", - "with open('head_20.txt','r') as alignments:\n", - " for aligned, kegg_id in groupby(alignments, key=lambda x: x.split(\"\\t\")[0]):\n", - " print(aligned)\n", - " taxonomies=[]\n", - " for item in kegg_id:\n", - " converted_line=convert_tax(item)\n", - " try:\n", - " node_id=tax_to_node_id[converted_line]\n", - " except KeyError:\n", - " continue\n", - " taxonomies.append(node_id)\n", - " lca=test.lca(taxonomies)\n", - " lineages=test.taxonomic_lineage(lca)\n", - " print(lineages)\n", - " \n", - " " - ] - }, - { - "cell_type": "code", - "execution_count": 167, - "metadata": {}, - "outputs": [ - { - "data": { - "text/plain": [ - "'1783272'" - ] - }, - "execution_count": 167, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "test.lca(taxonomies)" - ] - }, - { - "cell_type": "code", - "execution_count": 1, - "metadata": {}, - "outputs": [], - "source": [ - "class DiamondHits(object):\n", - "\n", - " def __init__(self, names=None, max_hits=10, top_fraction=None):\n", - " \"\"\"Class that represents BLAST hits for a single target sequence. Hits are added to queues\n", - " for bitscore and ID and ordered by increasing bitscore.\n", - " Args:\n", - " names (Optional[list]): when initiated with a name list; :func:`best_hit` and\n", - " :func:`add` will no longer operate as intended\n", - " max_hits (int): maximum number of hits to consider for this :class:`BlastHits` group\n", - " top_fraction (float): fraction cutoff from best bitscore, e.g. 0.7 will filter out 699 when best bitscore is 1000\n", - " Notes:\n", - " max_hits and top_fraction work in conjunction of one another\n", - " Examples:\n", - " >>> hits = BlastHits()\n", - " >>> hits.add(\"name_1\", 100)\n", - " >>> hits.add(\"name_2\", 110)\n", - " >>> hits.add(\"name_3\", 120)\n", - " >>> hits.add(\"name_4\", 130)\n", - " >>> hits.add(\"name_4\", 140)\n", - " >>> hits.majority()\n", - " 'name_4'\n", - " >>> hits.best_hit()\n", - " 'name_4'\n", - " >>> hits.add(\"name_5\", 150)\n", - " >>> hits.best_hit()\n", - " 'name_5'\n", - " # demo max hits and top fraction\n", - " >>> hits = BlastHits(max_hits=3, top_fraction=0.7)\n", - " >>> hits.add(\"name_1\", 100)\n", - " # filtered hit\n", - " >>> hits.add(\"name_2\", 65)\n", - " >>> hits.names\n", - " deque(['name_1'])\n", - " >>> hits.add(\"name_3\", 70)\n", - " deque(['name_3', 'name_1'])\n", - " >>> hits.add(\"name_4\", 80)\n", - " >>> hits.add(\"name_5\", 85)\n", - " >>> hits.names\n", - " deque(['name_4', 'name_5', 'name_1'])\n", - " # new best bitscore\n", - " >>> hits.add(\"name_6\", 125)\n", - " >>> dict(zip(hits.names, hits.bitscores))\n", - " {'name_1': 100.0, 'name_6': 125.0}\n", - " \"\"\"\n", - " if names is None:\n", - " # increasing bitscore sorted\n", - " self.names = deque()\n", - " self.bitscores = deque()\n", - " else:\n", - " self.names = names\n", - " self.max_hits = max_hits\n", - " self.top_fraction = top_fraction\n", - "\n", - " def __repr__(self):\n", - " return \"{cls}[{tax}]\".format(cls=self.__class__.__name__, tax=self.names)\n", - "\n", - " def __len__(self):\n", - " return len(self.names)\n", - "\n", - " def add(self, name, bitscore):\n", - " \"\"\"Add entry to this :class:`BlastHits` group.\n", - " Args:\n", - " name (str): hit identifier\n", - " bitscore (str): bitscore for hit\n", - " \"\"\"\n", - " bitscore = float(bitscore)\n", - "\n", - " if self.top_fraction and self.bitscores:\n", - " # the filter\n", - " if bitscore < (self.bitscores[-1] * self.top_fraction):\n", - " bitscore = None\n", - " # new best\n", - " elif bitscore > self.bitscores[-1]:\n", - " score = self.bitscores[0]\n", - " while score < bitscore * self.top_fraction:\n", - " self.names.popleft()\n", - " self.bitscores.popleft()\n", - " score = self.bitscores[0]\n", - "\n", - " if bitscore:\n", - " # insert into sorted list\n", - " idx = bisect.bisect_left(self.bitscores, bitscore)\n", - " self.bitscores.insert(idx, bitscore)\n", - " self.names.insert(idx, name)\n", - " if len(self.names) > self.max_hits:\n", - " # remove lowest bitscore\n", - " self.names.popleft()\n", - " self.bitscores.popleft()\n", - "\n", - " def best_hit(self):\n", - " \"\"\"Returns the hit ID of the best scoring alignment.\"\"\"\n", - " return self.names[-1]\n", - "\n", - " def majority(self):\n", - " \"\"\"Returns the hit ID of the best scoring hit ID that is repeated or the best hit when\n", - " no items are repeated.\n", - " \"\"\"\n", - " # no repeated names\n", - " if len(self.names) == len(set(self.names)):\n", - " return self.best_hit()\n", - " else:\n", - " # count each taxonomy, grab top taxonomy\n", - " most_common = Counter(self.names).most_common(1)[0][0]\n", - " # need to flip to grab best bitscore\n", - " names_reversed = self.names.copy()\n", - " names_reversed.reverse()\n", - " # left most index match\n", - " idx = names_reversed.index(most_common)\n", - " return names_reversed[idx]\n", - "\n" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [] - } - ], - "metadata": { - "kernelspec": { - "display_name": "Python 3", - "language": "python", - "name": "python3" - }, - "language_info": { - "codemirror_mode": { - "name": "ipython", - "version": 3 - }, - "file_extension": ".py", - "mimetype": "text/x-python", - "name": "python", - "nbconvert_exporter": "python", - "pygments_lexer": "ipython3", - "version": "3.6.4" - } - }, - "nbformat": 4, - "nbformat_minor": 2 -} diff --git a/notebooks/perseq_graphs.ipynb b/notebooks/perseq_graphs.ipynb deleted file mode 100644 index 199da5d..0000000 --- a/notebooks/perseq_graphs.ipynb +++ /dev/null @@ -1,412 +0,0 @@ -{ - "cells": [ - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "import pandas as pd\n", - "import numpy as np\n", - "import os \n", - "import plotly\n", - "import plotly.plotly as py\n", - "import plotly.figure_factory as ff\n", - "import plotly.graph_objs as go\n", - "\n", - "from plotly.offline import download_plotlyjs, init_notebook_mode, plot, iplot\n", - "\n", - "init_notebook_mode(connected=True)" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "#dependent functions for the others\n", - "#function to parse kaiju output\n", - "\n", - "#parse the kaiju output\n", - "def parse_align(alignment_file):\n", - " total_lines=0\n", - " order_dict={}\n", - " class_dict={}\n", - " phylum_dict={}\n", - " total_align=[]\n", - " #for alignment_file in file_list:\n", - " with open(alignment_file) as file:\n", - " classified=0\n", - " unc=0\n", - " for line in file:\n", - "\n", - "\n", - " total_lines+=1\n", - " toks=line.strip().split('\\t')\n", - " #print(toks)\n", - " classification=toks[0]\n", - "\n", - " if classification =='C':\n", - " classified+=1\n", - " bits=toks[7].split(';')\n", - " order=bits[3].strip()\n", - " clas=bits[2]\n", - " phylum=bits[1]\n", - " if order in order_dict:\n", - " order_dict[order]+=1\n", - " else:\n", - " order_dict[order]=1\n", - " if clas in class_dict:\n", - " class_dict[clas]+=1\n", - " else:\n", - " class_dict[clas]=1\n", - " if phylum in phylum_dict:\n", - " phylum_dict[phylum]+=1\n", - " else:\n", - " phylum_dict[phylum]=1\n", - " else:\n", - " unc+=1\n", - " total=classified+unc\n", - " # or should this be a list. prob list\n", - " #print('family',family)\n", - " return order_dict,class_dict,phylum_dict,total \n", - "\n", - "\n", - "\n", - "#will find the counts(pro)\n", - "\n", - "# def process_df(concat_df):\n", - "# '''This function will process the output so that it is in the proper form for plotting. this is total counts'''\n", - "# lol= concat_df.sort_values(by=[0,1],ascending=False)\n", - "# cols=['sampe 140','sample 164']\n", - "# lol.columns=cols\n", - "# top=lol.head(20) #grab top 20\n", - "\n", - "# #top.rename(index=str, columns={\"0\": \"140\", \"1\": \"164\"})\n", - "# t_top=top.transpose() #must transpose for this method to work\n", - " \n", - " \n", - "# return t_top\n", - "# def process_per(concat_df,d):\n", - "# '''This function will provide the percents of *total* read counts. Both aligned and unaligned'''\n", - "# full= concat_df.sort_values(by=[0,1],ascending=False)\n", - "# cols=['sampe 140','sample 164']\n", - "# full.columns=cols\n", - "# psorted=full.head(20) #grab top 20\n", - "# #sums=psorted.sum().tolist() #make list of the sums for each column\n", - "# perc=psorted.div(d) #divide by the sums to get the percents\n", - "# t_perc=perc.transpose()\n", - "# return t_perc\n", - "\n", - "#calculates the order for diversity \n", - "def gini(x, corr=False):\n", - " \"\"\"Calculates Gini coefficient, the measure of inequality among values\n", - " of a frequency distribution. A Gini coefficient of zero expresses\n", - " perfect equality.\n", - "\n", - " Port from ineq package in R::\n", - "\n", - " > library(ineq)\n", - " > t <- c(1,2,6,7,8)\n", - " > Gini(t)\n", - " [1] 0.3166667\n", - " > Gini(t, corr=TRUE)\n", - " [1] 0.3958333\n", - "\n", - " Args:\n", - " x (list): list or array of numbers\n", - " corr (Optional[bool]): finite sample correction\n", - "\n", - " Returns:\n", - " float\n", - "\n", - " >>> import numpy as np\n", - " >>> t = [1,2,6,7,8]\n", - " >>> gini(t) # doctest: +ELLIPSIS\n", - " 0.3166...\n", - " >>> gini(t, corr=True) # doctest: +ELLIPSIS\n", - " 0.3958...\n", - " >>> gini([]) # doctest: +ELLIPSIS\n", - " Traceback (most recent call last):\n", - " ...\n", - " AssertionError: x is empty\n", - " >>> t = [1,2,6,7,\"A\"]\n", - " >>> gini(t) # doctest: +ELLIPSIS\n", - " Traceback (most recent call last):\n", - " ...\n", - " ValueError: could not convert...\n", - " \"\"\"\n", - " x = np.array(x, dtype=float)\n", - " # filter out nan values as list is coming from merged dataframe\n", - " x = x[~np.isnan(x)]\n", - " n = len(x)\n", - " assert n > 0, \"x is empty\"\n", - " x.sort(kind=\"mergesort\")\n", - " G = sum(np.arange(1, n + 1) * x)\n", - " G = 2 * G / sum(x) - (n + 1)\n", - " if corr:\n", - " return G / (n - 1)\n", - " else:\n", - " return G / n\n", - "#step 1\n", - "def df_by_merge(path,tax_level):\n", - " \"\"\"\n", - " Reads in multiple sample alignments from diamond in a given directory and merges them into\n", - " a single pandas.DataFrame. It returns a pandas dataframe for each of th\n", - " phylum that is ready to plug into the processing function. Also returns total counts\n", - " which is necessary to calculate the percentage of total that is being represented \n", - " \"\"\"\n", - " merged_phy = None\n", - " samples = []\n", - " total_counts=[]\n", - " for f in os.listdir(path):\n", - " f = os.path.join(path, f)\n", - "\n", - " #print(f)\n", - " #if not f.endswith(\"%s_summary.txt\" % tax_level): continue\n", - " sample = os.path.basename(f).partition(\"_aln_names.txt\")[0]\n", - " samples.append(sample) #making a list of the sample headers\n", - " header = [tax_level,\"Reads_%s\" % sample]\n", - " if merged_phy is None:\n", - " #print('yes')\n", - " #merged = pd.read_table(f, header=0, names=header, comment=\"-\")\n", - " phy,ordr,clas,tc=parse_align(f)\n", - " #print(phy)\n", - " total_counts.append(tc)\n", - " merged_phy = pd.DataFrame(data=phy,index=[0]).transpose()\n", - " merged_phy.reset_index(inplace=True)\n", - " merged_phy.columns=header\n", - " merged_clas = pd.DataFrame(data=clas, index=[0]).transpose()\n", - " merged_clas.reset_index(inplace=True)\n", - " merged_clas.columns=header\n", - " merged_ord = pd.DataFrame(data=ordr, index=[0]).transpose()\n", - " merged_ord.reset_index(inplace=True)\n", - " merged_ord.columns=header\n", - " #cols = merged.columns.tolist() #make a list of the column headers from the merged file\n", - " #cols.remove(tax_level) #remove the order tag\n", - " #cols.insert(0, tax_level) #insert it at the front.\n", - " #merged = merged[cols]\n", - " continue\n", - " phy,ordr,clas,tc=parse_align(f)\n", - " total_counts.append(tc)\n", - " df1 = pd.DataFrame(data=phy,index=[0]).transpose()\n", - " df1.reset_index(inplace=True)\n", - " df1.columns=header\n", - " df2 = pd.DataFrame(data=ordr,index=[0]).transpose()\n", - " df2.reset_index(inplace=True)\n", - " df2.columns=header\n", - " df3 = pd.DataFrame(data=clas,index=[0]).transpose()\n", - " df3.reset_index(inplace=True)\n", - " df3.columns=header\n", - " merged_phy_final = merged_phy.merge(df1, on=tax_level, how=\"outer\")\n", - " merged_ord_final = merged_ord.merge(df2, on=tax_level, how=\"outer\")\n", - " merged_class_final = merged_clas.merge(df3, on=tax_level, how=\"outer\")\n", - " print(total_counts)\n", - "\n", - "\n", - " \n", - " return merged_phy_final, merged_ord_final, merged_class_final, total_counts\n", - "\n", - "\n", - "#step 2\n", - "#so this will make the counts information that we need. but this should be put into a function because it needs to be done\n", - "#for all three of the taxa\n", - "import numpy as np\n", - "def process_reads(tax_level, pandas_df):\n", - " '''This function will take the merged reads from the file and put them into a graphable\n", - " form for both counts and percents. It will return both. '''\n", - " #cols = [i for i in m.columns.tolist() if i.startswith(\"Percent_\")]\n", - " header=merged_phy_final.columns.tolist()\n", - " header.pop(0)\n", - " full= merged_phy_final.sort_values(by=header,ascending=False) #organize these by count\n", - "\n", - " sample_order = []\n", - " for read_col in merged_phy_final.columns.tolist(): #this will make a list of the gini coefficient of where these should be located by diversity of the sample\n", - " if read_col.startswith(\"Reads_\"):\n", - " sample_order.append([read_col.strip(\"Reads_\"), gini(merged_phy_final[read_col])])\n", - " sample_order = sorted(sample_order, key=lambda x: x[1])\n", - "\n", - " sub = full[[tax_level] + [\"Reads_%s\" % sample_order[i][0] for i in range(len(sample_order))]]\n", - " sub = sub.head(100)\n", - " cols=sub[tax_level].tolist()\n", - "\n", - " #find the percent\n", - " sub_perc=sub[header].div(total_counts)\n", - " sub_perc_t=sub_perc.transpose()\n", - " sub_perc_t.columns=cols #reset the names \n", - "\n", - "\n", - " #these are just the counts\n", - " sub_t=sub.transpose() #needs to be in this form or it wont work\n", - " sub_t.columns = sub_t.loc[tax_level] #set the column names as the taxoomy levels \n", - " sub_t.drop([tax_level], inplace=True) #this just takes out the duplicate header\n", - "\n", - " return sub_t, sub_perc_t" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "#step 1 \n", - "test_p,test_c,test_o,total_counts= df_by_merge(path,tax_level)\n", - "#step 2\n", - "p_done,p_perc_done=process_reads(tax_level,test_p)\n", - "c_done,c_perc_done=process_reads(tax_level,test_c)\n", - "o_done,o_perc_done=process_reads(tax_level,test_o)" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "##this will make counts graphs\n", - "\n", - "# data traces are taxonomies across samples\n", - "data = [go.Bar(x=p_done.index, y=p_done[tax], name=tax, visible=True) for tax in p_done.columns.tolist()] + \\\n", - "[go.Bar(x=c_done.index, y=c_done[tax], name=tax, visible=False) for tax in c_done.columns.tolist()] + \\\n", - "[go.Bar(x=o_done.index, y=o_done[tax], name=tax, visible=True) for tax in o_done.columns.tolist()]\n", - "\n", - "\n", - "# the number of taxa\n", - "trace_length = len(o_done.columns)\n", - "\n", - "# plot buttons\n", - "updatemenus = list([\n", - " dict(type=\"buttons\",\n", - " active=0,\n", - " buttons=list([ \n", - " dict(label = 'Phylum',\n", - " method = 'update',\n", - " args = [{'visible': [True]*trace_length + [False]*trace_length + [False]*trace_length},\n", - " {'yaxis': {\"title\": \"Percent\"}}\n", - " ]),\n", - " dict(label = 'Order',\n", - " method = 'update',\n", - " args = [{'visible': [False]*trace_length + [True]*trace_length + [False]*trace_length},\n", - " {'yaxis': {\"title\": \"Count\"}}\n", - " ]),\n", - " dict(label = 'Class',\n", - " method = 'update',\n", - " args = [{'visible': [False]*trace_length + [False]*trace_length + [True]*trace_length},\n", - " {'yaxis': {\"title\": \"Count\"}}\n", - " ])\n", - " ]),\n", - " direction = 'left',\n", - " pad = {'r': 0, 't': 0},\n", - " showactive = True,\n", - " x = 0,\n", - " xanchor = 'left',\n", - " y = 1.2,\n", - " yanchor = 'top' \n", - " )\n", - "])\n", - "\n", - "# initial layout\n", - "layout = dict(title=\"Assignments per Sample By Count (Top 20)\",\n", - " updatemenus=updatemenus,\n", - " barmode=\"stack\",\n", - " margin={\"b\": 200},\n", - " xaxis={\"tickangle\": -60},\n", - " yaxis={\"title\": \"Percent\"},\n", - " showlegend=False,\n", - " hovermode='closest'\n", - " )\n", - "\n", - "fig = go.Figure(data=data, layout=layout)\n", - "\n", - "iplot(fig)" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "##this will make percents graph\n", - "\n", - "# data traces are taxonomies across samples\n", - "data = [go.Bar(x=p_perc_done.index, y=p_perc_done[tax], name=tax, visible=True) for tax in p_perc_done.columns.tolist()] + \\\n", - "[go.Bar(x=c_perc_done.index, y=c_perc_done[tax], name=tax, visible=False) for tax in c_perc_done.columns.tolist()] + \\\n", - "[go.Bar(x=o_perc_done.index, y=o_perc_done[tax], name=tax, visible=True) for tax in o_perc_done.columns.tolist()]\n", - "\n", - "\n", - "# the number of taxa\n", - "trace_length = len(o_perc_done.columns)\n", - "\n", - "# plot buttons\n", - "updatemenus = list([\n", - " dict(type=\"buttons\",\n", - " active=0,\n", - " buttons=list([ \n", - " dict(label = 'Phylum',\n", - " method = 'update',\n", - " args = [{'visible': [True]*trace_length + [False]*trace_length + [False]*trace_length},\n", - " {'yaxis': {\"title\": \"Percent\"}}\n", - " ]),\n", - " dict(label = 'Order',\n", - " method = 'update',\n", - " args = [{'visible': [False]*trace_length + [True]*trace_length + [False]*trace_length},\n", - " {'yaxis': {\"title\": \"Count\"}}\n", - " ]),\n", - " dict(label = 'Class',\n", - " method = 'update',\n", - " args = [{'visible': [False]*trace_length + [False]*trace_length + [True]*trace_length},\n", - " {'yaxis': {\"title\": \"Count\"}}\n", - " ])\n", - " ]),\n", - " direction = 'left',\n", - " pad = {'r': 0, 't': 0},\n", - " showactive = True,\n", - " x = 0,\n", - " xanchor = 'left',\n", - " y = 1.2,\n", - " yanchor = 'top' \n", - " )\n", - "])\n", - "\n", - "# initial layout\n", - "layout = dict(title=\"Assignments per Sample By Percentage of Total (Top 20)\",\n", - " updatemenus=updatemenus,\n", - " barmode=\"stack\",\n", - " margin={\"b\": 200},\n", - " xaxis={\"tickangle\": -60},\n", - " yaxis={\"title\": \"Percent\"},\n", - " showlegend=False,\n", - " hovermode='closest'\n", - " )\n", - "\n", - "fig = go.Figure(data=data, layout=layout)\n", - "\n", - "iplot(fig)" - ] - } - ], - "metadata": { - "kernelspec": { - "display_name": "Python 3", - "language": "python", - "name": "python3" - }, - "language_info": { - "codemirror_mode": { - "name": "ipython", - "version": 3 - }, - "file_extension": ".py", - "mimetype": "text/x-python", - "name": "python", - "nbconvert_exporter": "python", - "pygments_lexer": "ipython3", - "version": "3.6.4" - } - }, - "nbformat": 4, - "nbformat_minor": 2 -} diff --git a/notebooks/plotly_button_prototyping.ipynb b/notebooks/plotly_button_prototyping.ipynb deleted file mode 100644 index beae9a2..0000000 --- a/notebooks/plotly_button_prototyping.ipynb +++ /dev/null @@ -1,56693 +0,0 @@ -{ - "cells": [ - { - "cell_type": "code", - "execution_count": 9, - "metadata": {}, - "outputs": [ - { - "data": { - "text/html": [ - "" - ], - "text/vnd.plotly.v1+html": [ - "" - ] - }, - "metadata": {}, - "output_type": "display_data" - }, - { - "data": { - "text/html": [ - "" - ], - "text/vnd.plotly.v1+html": [ - "" - ] - }, - "metadata": {}, - "output_type": "display_data" - } - ], - "source": [ - "import cufflinks as cf\n", - "import os\n", - "import pandas as pd\n", - "import plotly\n", - "import plotly.plotly as py\n", - "import plotly.figure_factory as ff\n", - "import plotly.graph_objs as go\n", - "import numpy as np\n", - "# from plotly.graph_objs import Layout, Table, Figure\n", - "from plotly.offline import download_plotlyjs, init_notebook_mode, plot, iplot\n", - "\n", - "plotly.offline.init_notebook_mode(connected=True)\n", - "cf.set_config_file(offline=True)\n", - "cf.set_config_file(theme='white')" - ] - }, - { - "cell_type": "code", - "execution_count": 10, - "metadata": {}, - "outputs": [], - "source": [ - "# kaiju_summary = \"sample1_summary.txt\"\n", - "# sample = os.path.basename(kaiju_summary).partition(\"_summary.txt\")[0]\n", - "# header = [\"Percent_%s\" % sample, \"Reads_%s\" % sample, \"Order\"]\n", - "# df = pd.read_table(kaiju_summary, header=0, names=header, comment=\"-\")\n", - "# cols = df.columns.tolist()\n", - "# cols.remove(\"Order\")\n", - "# cols.insert(0, \"Order\")\n", - "# df = df[cols]\n", - "# df.head()" - ] - }, - { - "cell_type": "code", - "execution_count": 11, - "metadata": {}, - "outputs": [], - "source": [ - "# kaiju_summary = \"sample2_summary.txt\"\n", - "# sample = os.path.basename(kaiju_summary).partition(\"_summary.txt\")[0]\n", - "# header = [\"Percent_%s\" % sample, \"Reads_%s\" % sample, \"Order\"]\n", - "# df2 = pd.read_table(kaiju_summary, header=0, names=header, comment=\"-\")\n", - "# df2.head()" - ] - }, - { - "cell_type": "code", - "execution_count": 2, - "metadata": {}, - "outputs": [], - "source": [ - "def df_by_merge(path, tax_level):\n", - " \"\"\"\n", - " Reads in multiple TSVs in a given directory and merges them into\n", - " a single pandas.DataFrame.\n", - " \"\"\"\n", - " merged = None\n", - " samples = []\n", - " for f in os.listdir(path):\n", - " f = os.path.join(path, f)\n", - " if not f.endswith(\"%s_summary.txt\" % tax_level): continue\n", - " sample = os.path.basename(f).partition(\"_%s_summary.txt\" % tax_level)[0]\n", - " samples.append(sample)\n", - " header = [\"Percent_%s\" % sample, \"Reads_%s\" % sample, tax_level]\n", - " if merged is None:\n", - " merged = pd.read_table(f, header=0, names=header, comment=\"-\")\n", - " cols = merged.columns.tolist()\n", - " cols.remove(tax_level)\n", - " cols.insert(0, tax_level)\n", - " merged = merged[cols]\n", - " continue\n", - " df = pd.read_table(f, header=0, names=header, comment=\"-\")\n", - " merged = merged.merge(df, on=tax_level, how=\"outer\")\n", - " return samples, merged" - ] - }, - { - "cell_type": "code", - "execution_count": 6, - "metadata": {}, - "outputs": [ - { - "data": { - "text/html": [ - "
\n", - "\n", - "\n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - "
orderReads_WL8_S29_001Reads_WL39_S28_001Reads_WL84_S36_001Reads_WL187_S5_001Reads_WL121_S37_001Reads_WL142_S30_001Reads_WL57_S40_001Reads_WL106_S10_001Reads_WL134_S34_001...Reads_WL110_S14_001Reads_WL148_S24_001Reads_WL40_S3_001Reads_WL124_S19_001Reads_WL2_S2_001Reads_WL112_S38_001Reads_WL51_S1_001Reads_WL130_S16_001Reads_WL93_S33_001Reads_WL69_S27_001
412cannot be assigned to a order835405.01587459.04222117.03676849.04660480.0339573.01530270.04347658.02765567.0...2860746.03282043.01078075.05869968.01896028.01864322.02420650.02466153.05129521.02208842.0
0Lactobacillales250226.0217735.02224612.01832091.02519273.049303.0715484.02591916.01895974.0...1484097.01676231.0642967.06863032.02902051.01434848.01923510.02740638.04947499.01651551.0
413unclassified577520.0936302.02621485.01613517.02016587.0250931.0722642.01234499.01294635.0...1111115.0935144.0194847.0846016.0228832.0184864.027763.0110961.038253.044011.0
1Enterobacterales109425.0114408.057848.034727.093402.0155885.0668164.043394.030591.0...32820.02567430.01092443.039799.0268536.02775047.02437271.02625969.04200385.04308198.0
2Bacillales77537.077306.057872.035012.069625.0102992.0440365.036849.030381.0...167688.01767571.0786078.056009.0171677.01748051.01304662.01516751.02452150.02610838.0
\n", - "

5 rows × 41 columns

\n", - "
" - ], - "text/plain": [ - " order Reads_WL8_S29_001 Reads_WL39_S28_001 \\\n", - "412 cannot be assigned to a order 835405.0 1587459.0 \n", - "0 Lactobacillales 250226.0 217735.0 \n", - "413 unclassified 577520.0 936302.0 \n", - "1 Enterobacterales 109425.0 114408.0 \n", - "2 Bacillales 77537.0 77306.0 \n", - "\n", - " Reads_WL84_S36_001 Reads_WL187_S5_001 Reads_WL121_S37_001 \\\n", - "412 4222117.0 3676849.0 4660480.0 \n", - "0 2224612.0 1832091.0 2519273.0 \n", - "413 2621485.0 1613517.0 2016587.0 \n", - "1 57848.0 34727.0 93402.0 \n", - "2 57872.0 35012.0 69625.0 \n", - "\n", - " Reads_WL142_S30_001 Reads_WL57_S40_001 Reads_WL106_S10_001 \\\n", - "412 339573.0 1530270.0 4347658.0 \n", - "0 49303.0 715484.0 2591916.0 \n", - "413 250931.0 722642.0 1234499.0 \n", - "1 155885.0 668164.0 43394.0 \n", - "2 102992.0 440365.0 36849.0 \n", - "\n", - " Reads_WL134_S34_001 ... Reads_WL110_S14_001 \\\n", - "412 2765567.0 ... 2860746.0 \n", - "0 1895974.0 ... 1484097.0 \n", - "413 1294635.0 ... 1111115.0 \n", - "1 30591.0 ... 32820.0 \n", - "2 30381.0 ... 167688.0 \n", - "\n", - " Reads_WL148_S24_001 Reads_WL40_S3_001 Reads_WL124_S19_001 \\\n", - "412 3282043.0 1078075.0 5869968.0 \n", - "0 1676231.0 642967.0 6863032.0 \n", - "413 935144.0 194847.0 846016.0 \n", - "1 2567430.0 1092443.0 39799.0 \n", - "2 1767571.0 786078.0 56009.0 \n", - "\n", - " Reads_WL2_S2_001 Reads_WL112_S38_001 Reads_WL51_S1_001 \\\n", - "412 1896028.0 1864322.0 2420650.0 \n", - "0 2902051.0 1434848.0 1923510.0 \n", - "413 228832.0 184864.0 27763.0 \n", - "1 268536.0 2775047.0 2437271.0 \n", - "2 171677.0 1748051.0 1304662.0 \n", - "\n", - " Reads_WL130_S16_001 Reads_WL93_S33_001 Reads_WL69_S27_001 \n", - "412 2466153.0 5129521.0 2208842.0 \n", - "0 2740638.0 4947499.0 1651551.0 \n", - "413 110961.0 38253.0 44011.0 \n", - "1 2625969.0 4200385.0 4308198.0 \n", - "2 1516751.0 2452150.0 2610838.0 \n", - "\n", - "[5 rows x 41 columns]" - ] - }, - "execution_count": 6, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "tax_level = \"order\"\n", - "samples, m = df_by_merge(\"/Users/brow015/devel/qc/classifications/logs/bailey_qc/kaiju\", tax_level)\n", - "cols = [i for i in m.columns.tolist() if i.startswith(\"Percent_\")]\n", - "m[\"Total_Percent\"] = m[cols].sum(axis=1)\n", - "m.sort_values(\"Total_Percent\", ascending=False, inplace=True)\n", - "tmp = m[(~m[tax_level].str.contains(\"unclassified|cannot\"))]\n", - "sample_order = []\n", - "for read_col in tmp.columns.tolist():\n", - " if read_col.startswith(\"Reads_\"):\n", - " sample_order.append([read_col.strip(\"Reads_\"), gini(tmp[read_col])])\n", - "sample_order = sorted(sample_order, key=lambda x: x[1])\n", - "# m.head()\n", - "\n", - "# sub = m[[tax_level] + cols]\n", - "# sub = sub.head(100)\n", - "# sub.head(5)\n", - "\n", - "# cols = [i for i in m.columns.tolist() if i.startswith(\"Reads_\")]\n", - "sub = m[[tax_level] + [\"Reads_%s\" % sample_order[i][0] for i in range(len(sample_order))]]\n", - "sub = sub.head(100)\n", - "sub.head(5)" - ] - }, - { - "cell_type": "code", - "execution_count": 49, - "metadata": {}, - "outputs": [], - "source": [ - "# trace = Table(\n", - "# header=dict(values=m.columns,\n", - "# fill=dict(color='#F8F8F8'),\n", - "# align=['left']),\n", - "# cells=dict(values=[m[i] for i in m.columns],\n", - "# align=['left']))\n", - "\n", - "# data = [sub.columns, [sub[i] for i in .columns]]\n", - "# data\n", - "# data = [trace]\n", - "# fig = ff.create_table(sub, height_constant=20)\n", - "# layout = Layout?\n", - "# fig = Figure(data, layout)\n", - "# iplot(fig)" - ] - }, - { - "cell_type": "code", - "execution_count": 50, - "metadata": {}, - "outputs": [], - "source": [ - "# t = sub.copy()\n", - "# t.set_index(tax_level, inplace=True)\n", - "# cols = t.columns.tolist()\n", - "# cols = [i.strip(\"Percent_\") for i in cols]\n", - "# t.columns = cols\n", - "# fig = t.iplot(title=\"Top 100 Assignments by Percent\", xTitle=\"Taxonomy\", yTitle=\"Percent\", asFigure=True)\n", - "# fig.layout.margin.update({'b':200})\n", - "# fig.layout.xaxis.update({\"tickangle\":-60, \"title\":\"Taxonomy\"})\n", - "# # print(fig)\n", - "# # t.iplot?\n", - "# iplot(fig)" - ] - }, - { - "cell_type": "code", - "execution_count": 7, - "metadata": {}, - "outputs": [ - { - "data": { - "text/html": [ - "
\n", - "\n", - "\n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - "
orderLactobacillalesEnterobacteralesBacillalesBurkholderialesPseudomonadalesClostridialesRhizobialesNeisserialesCorynebacterialesSporadotrichidaEurotialesXanthomonadalesCoriobacterialesStreptomycetalesPeronosporalesMicrococcalesHaemosporidaEucoccidioridaAcidobacterialesSaccharomycetales
Reads_WL8_S29_00125022610942577537537621180219513176052302322093402115592108956792413474331174972221067121372322
Reads_WL39_S28_0012177351144087730655117180702034762515344316827956523546813243418638106650171631907514263240317888112136
Reads_WL84_S36_0012.22461e+06578485787229544917505577877183349195551658061739414073633364387961101618664661536480531071245226713396
Reads_WL187_S5_0011.83209e+06347273501220280446868646158393191083086630181941145743216828187074458303435842568537584505310518
Reads_WL121_S37_0012.51927e+06934026962521280136210217259916813919610121938163951293153601038638062682052539972828337524489710825
\n", - "
" - ], - "text/plain": [ - "order Lactobacillales Enterobacterales Bacillales \\\n", - "Reads_WL8_S29_001 250226 109425 77537 \n", - "Reads_WL39_S28_001 217735 114408 77306 \n", - "Reads_WL84_S36_001 2.22461e+06 57848 57872 \n", - "Reads_WL187_S5_001 1.83209e+06 34727 35012 \n", - "Reads_WL121_S37_001 2.51927e+06 93402 69625 \n", - "\n", - "order Burkholderiales Pseudomonadales Clostridiales Rhizobiales \\\n", - "Reads_WL8_S29_001 53762 11802 19513 176052 \n", - "Reads_WL39_S28_001 55117 18070 20347 62515 \n", - "Reads_WL84_S36_001 295449 175055 77877 183349 \n", - "Reads_WL187_S5_001 202804 46868 64615 839319 \n", - "Reads_WL121_S37_001 212801 362102 172599 168139 \n", - "\n", - "order Neisseriales Corynebacteriales Sporadotrichida Eurotiales \\\n", - "Reads_WL8_S29_001 3023 22093 4021 15592 \n", - "Reads_WL39_S28_001 3443 168279 5652 35468 \n", - "Reads_WL84_S36_001 19555 165806 17394 140736 \n", - "Reads_WL187_S5_001 10830 86630 18194 114574 \n", - "Reads_WL121_S37_001 19610 121938 16395 129315 \n", - "\n", - "order Xanthomonadales Coriobacteriales Streptomycetales \\\n", - "Reads_WL8_S29_001 10895 679 24134 \n", - "Reads_WL39_S28_001 13243 418638 106650 \n", - "Reads_WL84_S36_001 33364 38796 110161 \n", - "Reads_WL187_S5_001 32168 2818 70744 \n", - "Reads_WL121_S37_001 36010 3863 80626 \n", - "\n", - "order Peronosporales Micrococcales Haemosporida Eucoccidiorida \\\n", - "Reads_WL8_S29_001 7433 11749 7222 1067 \n", - "Reads_WL39_S28_001 17163 19075 14263 2403 \n", - "Reads_WL84_S36_001 86646 61536 48053 107124 \n", - "Reads_WL187_S5_001 58303 43584 25685 3758 \n", - "Reads_WL121_S37_001 82052 53997 28283 3752 \n", - "\n", - "order Acidobacteriales Saccharomycetales \n", - "Reads_WL8_S29_001 12137 2322 \n", - "Reads_WL39_S28_001 17888 112136 \n", - "Reads_WL84_S36_001 52267 13396 \n", - "Reads_WL187_S5_001 45053 10518 \n", - "Reads_WL121_S37_001 44897 10825 " - ] - }, - "execution_count": 7, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "counts = sub.copy()\n", - "# t = t[~t[\"Order\"] == \"unclassified\"]\n", - "counts = counts[(~counts[tax_level].str.contains(\"unclassified|cannot\"))]\n", - "# top 10 taxonomies\n", - "counts = counts.head(20)\n", - "cols = counts.columns.tolist()\n", - "# cols = [i.partition(\"Percent_\")[-1] for i in cols if \"Percent_\" in i]\n", - "# cols = [i.partition(\"Reads_\")[-1] for i in cols if \"Reads_\" in i]\n", - "counts.columns = [tax_level] + [\"Reads_%s\" % sample_order[i][0] for i in range(len(sample_order))]\n", - "counts = counts.T\n", - "counts.columns = counts.loc[tax_level]\n", - "# t.loc[\"Order\"]\n", - "# t.set_index(\"Order\")\n", - "counts.drop([tax_level], inplace=True)\n", - "# t[t[\"Order\"] != \"Order\"]\n", - "counts.head()" - ] - }, - { - "cell_type": "code", - "execution_count": 14, - "metadata": {}, - "outputs": [ - { - "data": { - "application/vnd.plotly.v1+json": { - "data": [ - { - "name": "Lactobacillales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 9.91815, - 4.875787, - 18.299616, - 18.626768, - 20.860512, - 3.534468, - 14.036060999999998, - 24.270857, - 25.254229000000002, - 27.789181, - 7.509417999999999, - 20.31987, - 6.8348059999999995, - 19.57515, - 25.229219, - 24.376435999999998, - 25.894707, - 25.703689999999998, - 32.56089, - 18.51, - 41.992729, - 31.941605, - 39.949127000000004, - 26.536640000000002, - 24.681038, - 9.668959, - 27.828783, - 34.228664, - 30.640402, - 28.820351000000002, - 13.409765, - 13.893896, - 14.753264000000001, - 42.385296000000004, - 37.529037, - 16.328442000000003, - 19.81365, - 25.80336, - 25.487453, - 14.342144000000001 - ] - }, - { - "name": "Enterobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4.337254, - 2.561963, - 0.475857, - 0.353068, - 0.773403, - 11.175193, - 13.107757999999999, - 0.406344, - 0.40747, - 3.32761, - 1.940316, - 0.43078500000000003, - 13.822785999999999, - 2.237689, - 0.42269300000000004, - 0.428486, - 0.5286109999999999, - 0.5319649999999999, - 0.268881, - 0.351444, - 0.372813, - 0.34087199999999995, - 5.716522, - 10.300478, - 2.4857, - 3.4099199999999996, - 0.792254, - 0.376853, - 2.065298, - 0.41115100000000004, - 0.29655, - 21.280839999999998, - 25.066761, - 0.245794, - 3.4726809999999997, - 31.579786, - 25.105785, - 24.72374, - 21.638634, - 37.41259 - ] - }, - { - "name": "Bacillales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 3.073316, - 1.7311299999999998, - 0.476054, - 0.35596500000000003, - 0.576521, - 7.383361999999999, - 8.638893, - 0.345056, - 0.404673, - 2.055846, - 1.391311, - 2.090114, - 9.217377, - 1.430388, - 2.0929990000000003, - 0.377633, - 0.392423, - 0.305742, - 0.501642, - 24.566545, - 0.364558, - 0.213734, - 3.470972, - 0.39729200000000003, - 1.228338, - 1.991785, - 1.362862, - 2.8225, - 2.489838, - 1.0675379999999999, - 1.515168, - 14.650991000000001, - 18.037031, - 0.345905, - 2.22011, - 19.892664, - 13.439032999999998, - 14.280351000000001, - 12.632455, - 22.672635999999997 - ] - }, - { - "name": "Burkholderiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 2.130952, - 1.2342469999999999, - 2.430358, - 2.061897, - 1.762071, - 1.227956, - 1.478106, - 2.200919, - 1.908066, - 1.579412, - 0.959741, - 1.820768, - 0.9421510000000001, - 1.224331, - 2.969061, - 2.307113, - 3.7798239999999996, - 2.374848, - 2.6132470000000003, - 1.886664, - 1.8114970000000001, - 2.859313, - 1.3928129999999999, - 2.118449, - 2.8469729999999998, - 0.963353, - 1.9169919999999998, - 4.697906, - 2.22805, - 2.6888, - 29.952244, - 1.3854600000000001, - 0.7432310000000001, - 3.559558, - 1.095073, - 0.457848, - 0.294159, - 1.100323, - 0.373722, - 0.261598 - ] - }, - { - "name": "Pseudomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.467793, - 0.404645, - 1.439999, - 0.476504, - 2.998338, - 0.42970200000000003, - 1.790241, - 2.416527, - 0.703758, - 0.518079, - 0.34525300000000003, - 0.333642, - 9.654401, - 12.575409, - 0.669662, - 0.6605949999999999, - 0.700721, - 0.41457, - 0.7734439999999999, - 0.309313, - 2.537113, - 0.514768, - 0.300078, - 0.710559, - 0.427559, - 0.28799600000000003, - 0.768282, - 0.534163, - 0.347954, - 0.3771, - 0.37113, - 0.169646, - 0.206878, - 0.658547, - 16.879753, - 0.120923, - 8.66898, - 0.15147, - 0.099348, - 0.076289 - ] - }, - { - "name": "Clostridiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.773432, - 0.455635, - 0.6406149999999999, - 0.656937, - 1.429184, - 0.659249, - 1.654939, - 1.707855, - 0.81113, - 1.057043, - 0.465247, - 1.182985, - 0.838791, - 0.450429, - 1.002205, - 1.0120930000000001, - 1.0493700000000001, - 0.651493, - 1.150334, - 0.380407, - 0.387733, - 1.440365, - 0.539081, - 0.711881, - 1.2850780000000002, - 0.608568, - 1.219241, - 1.173815, - 0.748484, - 0.385219, - 0.37445500000000004, - 3.643794, - 4.890878, - 0.7588, - 0.766888, - 3.8603730000000005, - 2.233518, - 4.607012, - 9.399075, - 2.534612 - ] - }, - { - "name": "Rhizobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 6.978133000000001, - 1.399912, - 1.508225, - 8.53331, - 1.392253, - 1.244444, - 1.20395, - 1.3180479999999999, - 1.01603, - 1.342552, - 1.107818, - 1.005428, - 1.417859, - 5.825324, - 1.180674, - 1.043503, - 0.722525, - 0.700576, - 1.001003, - 1.179359, - 1.3238159999999999, - 1.081815, - 1.116484, - 0.998233, - 0.794467, - 0.8597809999999999, - 0.6542899999999999, - 1.077136, - 0.706232, - 0.72213, - 0.707906, - 0.513605, - 0.42598500000000006, - 0.565742, - 5.755886, - 0.263308, - 0.22129200000000002, - 0.222027, - 0.06696, - 0.09529 - ] - }, - { - "name": "Neisseriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.119822, - 0.0771, - 0.160859, - 0.110108, - 0.162378, - 17.942175, - 0.091908, - 0.245919, - 0.193552, - 0.117745, - 0.064649, - 0.10000099999999999, - 0.05234199999999999, - 0.081354, - 0.10548900000000001, - 0.18044200000000002, - 0.16089900000000001, - 0.071703, - 0.140165, - 0.091812, - 0.085363, - 0.21421300000000001, - 0.073132, - 0.101969, - 0.118698, - 35.035247999999996, - 0.144608, - 0.09959, - 0.135677, - 0.069051, - 0.07258300000000001, - 0.073497, - 0.054702, - 0.15231, - 0.0584, - 0.024615, - 0.011156000000000001, - 0.075556, - 0.011349, - 0.006305 - ] - }, - { - "name": "Corynebacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.8756950000000001, - 3.768308, - 1.363917, - 0.880762, - 1.009692, - 0.699968, - 0.8403579999999999, - 1.053017, - 1.7260360000000001, - 0.840093, - 4.209596, - 5.170632, - 0.759256, - 0.718572, - 1.183158, - 2.747481, - 1.518016, - 0.49198000000000003, - 0.673567, - 0.8248530000000001, - 0.795726, - 0.958406, - 0.610745, - 0.5840069999999999, - 1.2725799999999998, - 0.638976, - 1.380105, - 0.91761, - 0.6032270000000001, - 0.6759569999999999, - 0.48618100000000003, - 0.507654, - 0.567399, - 1.356799, - 0.538213, - 0.43269799999999997, - 0.36842800000000003, - 0.661985, - 1.038322, - 0.37654 - ] - }, - { - "name": "Sporadotrichida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.159379, - 0.126566, - 0.143083, - 0.184977, - 0.135757, - 0.10753299999999999, - 0.082963, - 1.169983, - 0.799235, - 0.11907899999999999, - 0.142586, - 4.297626999999999, - 0.066841, - 0.113604, - 4.153802, - 0.8544700000000001, - 0.392316, - 1.9550040000000002, - 0.832142, - 0.9916590000000001, - 0.117099, - 0.926433, - 0.080419, - 1.188572, - 6.031435, - 0.21266100000000002, - 2.96113, - 3.3226809999999998, - 2.909505, - 2.479142, - 4.280697, - 0.283733, - 0.093503, - 0.745201, - 0.037515, - 0.017922999999999998, - 0.015698, - 0.65175, - 0.014218000000000001, - 0.01089 - ] - }, - { - "name": "Eurotiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.618016, - 0.794243, - 1.157692, - 1.164868, - 1.070776, - 0.723196, - 0.766596, - 0.993742, - 0.818576, - 0.855345, - 0.804107, - 0.830973, - 0.608006, - 0.804578, - 1.157851, - 0.924983, - 1.165509, - 0.753943, - 1.0222149999999999, - 0.883441, - 0.743395, - 0.925791, - 0.439212, - 0.870707, - 1.094751, - 0.831601, - 1.357098, - 0.515927, - 0.6899109999999999, - 0.8036800000000001, - 0.9198729999999999, - 0.32099099999999997, - 0.353362, - 0.642181, - 0.297408, - 0.052541, - 0.010414, - 0.107134, - 0.014197999999999999, - 0.014311 - ] - }, - { - "name": "Xanthomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.43184300000000003, - 0.296553, - 0.274452, - 0.32705, - 0.298176, - 0.451926, - 0.374107, - 0.293563, - 0.272512, - 0.300394, - 0.21174400000000002, - 0.16228900000000002, - 0.335228, - 0.296581, - 0.265387, - 0.209121, - 0.186448, - 0.148074, - 0.229469, - 0.220615, - 0.268124, - 0.28168499999999996, - 0.451427, - 0.185339, - 0.279276, - 0.188878, - 0.21779899999999996, - 0.266165, - 0.213335, - 17.036043, - 0.219584, - 0.8285950000000001, - 0.237143, - 0.162413, - 0.14229, - 0.245009, - 0.096353, - 0.12459, - 0.21076199999999998, - 0.261477 - ] - }, - { - "name": "Coriobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.026913, - 9.374651, - 0.319135, - 0.02865, - 0.031987, - 0.018137, - 0.02154, - 0.039413, - 0.043423, - 0.035949, - 13.985016, - 0.01399, - 0.017207, - 0.023787, - 0.016802, - 0.065985, - 0.267894, - 0.011793000000000001, - 0.023536, - 0.018391, - 0.051898, - 0.05985, - 0.059397000000000005, - 0.023757, - 0.017145, - 0.019759, - 0.025961, - 0.030161, - 0.184648, - 0.020256, - 0.012062999999999999, - 0.020878999999999998, - 0.017278, - 0.027761, - 0.017251, - 0.011482, - 0.009363, - 0.008144, - 0.017618, - 0.004629 - ] - }, - { - "name": "Streptomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.956594, - 2.3882369999999997, - 0.9061819999999999, - 0.71925, - 0.667613, - 0.751943, - 0.594569, - 0.45152600000000004, - 0.584065, - 0.6311939999999999, - 2.563663, - 0.278471, - 0.5562060000000001, - 0.688971, - 0.617129, - 0.410918, - 0.664238, - 0.305858, - 0.434965, - 0.486256, - 0.532747, - 0.324427, - 0.6669970000000001, - 0.31863800000000003, - 0.547787, - 0.45692299999999997, - 0.430241, - 0.339555, - 0.271565, - 0.362919, - 0.540503, - 0.26621, - 0.196139, - 0.21167199999999997, - 0.156334, - 0.11341199999999999, - 0.030458999999999996, - 0.129137, - 0.030394, - 0.034241 - ] - }, - { - "name": "Peronosporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.29462, - 0.384335, - 0.7127479999999999, - 0.592763, - 0.679421, - 0.30159400000000003, - 0.62841, - 0.471462, - 0.39728, - 0.363292, - 0.462678, - 0.811751, - 0.31772, - 0.454212, - 1.8196599999999998, - 0.43405699999999997, - 0.529523, - 0.442305, - 0.41302799999999995, - 0.435395, - 0.44441400000000003, - 0.31755, - 0.163197, - 0.390133, - 1.614531, - 0.37551799999999996, - 1.694123, - 0.735421, - 0.580653, - 0.8322790000000001, - 1.387025, - 0.208139, - 0.174387, - 0.5216890000000001, - 0.128698, - 0.028347000000000004, - 0.010320999999999999, - 0.166977, - 0.009113, - 0.010976999999999999 - ] - }, - { - "name": "Micrococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.465692, - 0.427151, - 0.5061939999999999, - 0.443116, - 0.447115, - 0.344679, - 0.358197, - 0.27770100000000003, - 0.328296, - 0.41305200000000003, - 0.29134699999999997, - 0.324761, - 0.312787, - 0.41441000000000006, - 0.500739, - 0.274359, - 0.267044, - 1.1507450000000001, - 0.299547, - 0.263087, - 0.335486, - 0.242274, - 0.286709, - 0.21165799999999999, - 0.642999, - 0.252895, - 0.30801799999999996, - 0.42413100000000004, - 0.32652600000000004, - 0.40334000000000003, - 0.5871, - 0.168676, - 0.12939, - 0.134857, - 0.13153, - 0.06864400000000001, - 0.014277000000000001, - 0.139456, - 0.015747999999999998, - 0.013321000000000001 - ] - }, - { - "name": "Haemosporida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.28625700000000004, - 0.319394, - 0.395283, - 0.26113800000000004, - 0.234194, - 0.21499400000000002, - 0.21102600000000002, - 0.236396, - 0.5629, - 0.236869, - 0.21877600000000003, - 0.469471, - 0.21321700000000002, - 0.236614, - 0.703842, - 0.521312, - 0.27523600000000004, - 0.201826, - 0.353665, - 0.22018000000000001, - 0.204735, - 0.17544400000000002, - 0.14374800000000001, - 0.317847, - 0.577304, - 0.23648200000000003, - 0.457904, - 0.413975, - 0.441934, - 0.47353900000000004, - 0.458161, - 0.159857, - 0.135287, - 0.21524200000000002, - 0.045857, - 0.018116999999999998, - 0.003636, - 0.040813999999999996, - 0.00339, - 0.005896 - ] - }, - { - "name": "Eucoccidiorida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.042292, - 0.053811000000000005, - 0.8812, - 0.038207, - 0.031068000000000002, - 0.029320999999999996, - 0.027032999999999998, - 0.024019, - 0.116722, - 0.031633, - 0.046360000000000005, - 0.039842, - 5.470311, - 0.033236, - 0.07618, - 0.101435, - 0.102362, - 0.019063999999999998, - 0.029799000000000003, - 0.050158, - 0.028599, - 0.019216, - 0.026106999999999998, - 0.02623, - 0.033399, - 0.023372, - 0.11362699999999999, - 0.015619999999999998, - 0.02539, - 0.015846000000000002, - 0.046416000000000006, - 0.014348, - 0.01122, - 0.068941, - 0.009337, - 0.004347, - 2.823113, - 0.007024, - 0.00339, - 0.001042 - ] - }, - { - "name": "Acidobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.481071, - 0.40057, - 0.429947, - 0.45805100000000004, - 0.371764, - 0.430491, - 0.341385, - 0.40058499999999997, - 0.23795999999999998, - 0.39365300000000003, - 0.31392800000000004, - 0.11897999999999999, - 0.289444, - 0.34321199999999996, - 0.44143699999999997, - 0.31348000000000004, - 0.391817, - 0.23281, - 0.29799899999999996, - 0.42923999999999995, - 0.376355, - 0.22489099999999998, - 0.260025, - 0.386166, - 0.101127, - 0.282719, - 0.079692, - 0.323575, - 0.109411, - 0.22414699999999999, - 0.09779299999999999, - 0.236959, - 0.12906900000000002, - 0.168077, - 0.143738, - 0.051949, - 0.014534, - 0.014791, - 0.009062, - 0.007347 - ] - }, - { - "name": "Saccharomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.092037, - 2.511086, - 0.110195, - 0.10693599999999999, - 0.089635, - 0.087962, - 0.083218, - 0.08705800000000001, - 0.19527, - 0.090751, - 3.7807199999999996, - 0.128469, - 0.06335199999999999, - 0.108924, - 0.172394, - 0.184373, - 0.135972, - 0.13708199999999998, - 0.123775, - 0.08279299999999999, - 0.070123, - 0.056140999999999996, - 0.051061, - 0.183344, - 0.127159, - 0.073232, - 0.406504, - 0.067737, - 0.23271399999999998, - 0.093078, - 0.106368, - 0.060798000000000005, - 0.026708999999999997, - 0.087667, - 0.020263999999999997, - 0.010662999999999999, - 0.0031309999999999997, - 0.021466, - 0.006249, - 0.002848 - ] - }, - { - "name": "Chlamydiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.360734, - 0.168711, - 0.26969699999999996, - 0.156978, - 0.22284099999999998, - 0.23055100000000003, - 0.23888299999999998, - 0.303442, - 0.443553, - 0.182748, - 0.144629, - 0.182788, - 0.119243, - 0.136037, - 0.141469, - 1.446421, - 0.21483000000000002, - 0.6274489999999999, - 0.210403, - 0.192552, - 0.246469, - 0.166305, - 0.176566, - 0.183061, - 0.106529, - 0.22503, - 0.06564600000000001, - 0.051024, - 0.128775, - 0.07845, - 0.13883299999999998, - 0.219072, - 0.252402, - 0.157899, - 0.042947000000000006, - 0.28499800000000003, - 0.109394, - 0.214146, - 0.6486310000000001, - 0.247209 - ] - }, - { - "name": "Rhodospirillales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.511077, - 0.388567, - 0.429166, - 0.387106, - 0.401888, - 0.44396800000000003, - 0.323494, - 0.328847, - 0.309662, - 0.405609, - 0.266072, - 0.185343, - 0.295039, - 0.406256, - 0.125166, - 0.262621, - 0.21744699999999997, - 0.24673, - 0.428559, - 0.270296, - 0.320942, - 0.261561, - 0.45913400000000004, - 0.242114, - 0.134217, - 0.252369, - 0.09048400000000001, - 0.10091, - 0.096373, - 0.08849, - 0.152341, - 0.10627, - 0.107982, - 0.180676, - 0.139496, - 0.054817, - 0.02364, - 0.059352999999999996, - 0.025629000000000002, - 0.010499 - ] - }, - { - "name": "Chitinophagales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.176621, - 0.119244, - 0.093957, - 0.15518800000000002, - 0.121796, - 0.18553, - 0.04718, - 0.124626, - 0.16559300000000002, - 0.10079099999999999, - 0.15939, - 1.21054, - 0.037781999999999996, - 0.098885, - 0.11284300000000001, - 0.138922, - 0.12316400000000001, - 0.10466800000000001, - 0.14088, - 0.123465, - 0.073386, - 0.079545, - 0.10233300000000001, - 0.10922899999999999, - 0.892525, - 0.097923, - 0.921243, - 0.136901, - 1.098539, - 0.111846, - 1.0409959999999998, - 0.095578, - 0.037287, - 0.076859, - 0.031929, - 0.010447, - 0.004017, - 0.12870399999999999, - 0.001169, - 0.001641 - ] - }, - { - "name": "Pseudonocardiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.506479, - 0.420813, - 0.519981, - 0.394467, - 0.351038, - 0.431208, - 0.344975, - 0.22832399999999997, - 0.291786, - 0.30738899999999997, - 0.23987199999999997, - 0.064417, - 0.340041, - 0.36275999999999997, - 0.193275, - 0.181558, - 0.172727, - 0.138316, - 0.17179, - 0.257377, - 0.285623, - 0.141769, - 0.30390500000000004, - 0.137796, - 0.086257, - 0.202796, - 0.058544000000000006, - 0.09122100000000001, - 0.052953999999999994, - 0.081966, - 0.074878, - 0.12768, - 0.107225, - 0.09115, - 0.09087200000000001, - 0.039306, - 0.004347, - 0.010506999999999999, - 0.002663, - 0.00713 - ] - }, - { - "name": "Pasteurellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.145705, - 0.075846, - 0.021741, - 0.011539, - 0.024361, - 0.331847, - 0.382641, - 0.013091, - 0.01942, - 0.10655, - 0.063929, - 0.017093, - 0.35839, - 0.063441, - 0.009101, - 0.009779000000000001, - 0.010775, - 0.011738, - 0.010395999999999999, - 0.011358, - 0.012661, - 0.009863, - 0.14752200000000001, - 0.013947, - 0.012798, - 0.134792, - 0.023508, - 0.007447, - 0.042667000000000004, - 0.004611, - 0.010472, - 0.530771, - 0.755966, - 0.00583, - 0.11512, - 1.027549, - 0.764524, - 0.642138, - 0.57468, - 1.054808 - ] - }, - { - "name": "Thalassiosirales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.037655, - 0.046511000000000004, - 0.052786, - 0.059487, - 0.075683, - 0.029392, - 0.031977, - 0.085681, - 0.23690799999999998, - 0.04152, - 0.064329, - 0.281512, - 0.019974000000000002, - 0.06966699999999999, - 0.48066099999999995, - 0.197414, - 0.21367399999999998, - 0.48487399999999997, - 0.677338, - 0.080289, - 0.030997000000000004, - 0.034969, - 0.018139, - 0.327279, - 0.550914, - 0.047031, - 1.086977, - 0.24425999999999998, - 0.194687, - 0.47878999999999994, - 0.807678, - 0.14291500000000001, - 0.013630000000000001, - 0.127297, - 0.011315, - 0.0050409999999999995, - 0.002822, - 0.06871100000000001, - 0.004935, - 0.001884 - ] - }, - { - "name": "Agaricales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.163938, - 0.20310599999999998, - 0.22837, - 0.450477, - 0.25543299999999997, - 0.23320300000000002, - 0.173772, - 0.37327, - 0.170295, - 0.187378, - 0.624842, - 0.131267, - 0.16580899999999998, - 0.246741, - 0.205706, - 0.212196, - 0.338192, - 0.364118, - 0.213534, - 0.141546, - 0.18874200000000002, - 0.129573, - 0.095465, - 0.206517, - 0.09579299999999999, - 0.203551, - 0.07522899999999999, - 0.125418, - 0.160045, - 0.17998699999999998, - 0.22315300000000002, - 0.06665800000000001, - 0.093962, - 0.18268900000000002, - 0.154691, - 0.013474000000000002, - 0.005779, - 0.009867, - 0.005162, - 0.0035689999999999997 - ] - }, - { - "name": "Kinetoplastida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.19905599999999998, - 0.171666, - 0.17699, - 0.17538, - 0.129174, - 0.12423699999999999, - 0.104307, - 0.651439, - 0.337567, - 0.145598, - 0.098588, - 0.579874, - 0.07827200000000001, - 0.13034, - 0.23888800000000002, - 0.261542, - 0.22810300000000003, - 0.261418, - 0.26373, - 0.470926, - 0.171647, - 0.557215, - 0.141494, - 0.096285, - 0.178788, - 0.21598699999999998, - 0.050548, - 0.13481700000000002, - 0.208498, - 0.045941, - 0.07739, - 0.16488, - 0.048897, - 0.295794, - 0.036882, - 0.013144, - 0.002936, - 0.008483, - 0.005686999999999999, - 0.003213 - ] - }, - { - "name": "Sphingomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.253398, - 0.178026, - 0.228756, - 0.22894899999999999, - 0.20435999999999999, - 0.162518, - 0.156529, - 0.19955699999999998, - 0.20319500000000001, - 0.193647, - 0.131501, - 0.191487, - 0.128749, - 0.17232, - 0.272926, - 0.172334, - 0.15951600000000002, - 0.128687, - 0.169854, - 0.169619, - 0.20369, - 0.183259, - 0.17494, - 0.147116, - 0.522994, - 0.12366600000000001, - 0.46615, - 0.279543, - 0.173981, - 0.192787, - 0.362799, - 0.09514700000000001, - 0.086734, - 0.136191, - 0.113633, - 0.049776, - 0.01574, - 0.075679, - 0.053788, - 0.029925 - ] - }, - { - "name": "Planctomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.315826, - 0.34817, - 0.345927, - 0.322272, - 0.310415, - 0.212127, - 0.275862, - 0.269629, - 0.219619, - 0.312395, - 0.254177, - 0.153834, - 0.269289, - 0.291695, - 0.234408, - 0.182685, - 0.161001, - 0.1131, - 0.157994, - 0.258142, - 0.29088, - 0.22538000000000002, - 0.192503, - 0.146549, - 0.081291, - 0.204268, - 0.100746, - 0.17699700000000002, - 0.08707100000000001, - 0.10755899999999999, - 0.079098, - 0.102499, - 0.093916, - 0.08392999999999999, - 0.095567, - 0.046646, - 0.005521, - 0.011722, - 0.0025399999999999997, - 0.005879 - ] - }, - { - "name": "Alteromonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.191921, - 0.156058, - 0.2369, - 0.16685999999999998, - 0.186797, - 0.130473, - 0.145092, - 0.17979, - 0.171934, - 0.21158600000000002, - 0.11636300000000001, - 0.102374, - 0.089823, - 0.181505, - 0.108852, - 0.15953399999999998, - 0.217685, - 0.127135, - 0.172674, - 0.142177, - 0.129718, - 0.9959520000000001, - 0.124298, - 0.190244, - 0.120121, - 0.127413, - 0.155049, - 0.12833599999999998, - 0.217808, - 0.139235, - 0.108554, - 0.81603, - 0.07122300000000001, - 0.195831, - 0.139626, - 0.047523, - 0.054161, - 0.083841, - 0.051784000000000004, - 0.037585 - ] - }, - { - "name": "Rhodobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.37900700000000004, - 0.282177, - 0.310909, - 0.291954, - 0.292131, - 0.279443, - 0.381758, - 0.226039, - 0.24954899999999997, - 0.257083, - 0.200213, - 0.100366, - 0.188551, - 0.295507, - 0.11891800000000001, - 0.409037, - 0.160485, - 0.168507, - 0.210655, - 0.175401, - 0.20455399999999999, - 0.16201500000000002, - 0.26747, - 0.16230799999999998, - 0.075308, - 0.168402, - 0.064323, - 0.087936, - 0.09622, - 0.075713, - 0.075249, - 0.09159099999999999, - 0.068584, - 0.12406099999999999, - 0.074384, - 0.038305, - 0.007324, - 0.021212, - 0.005605, - 0.007772 - ] - }, - { - "name": "Solibacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.290498, - 0.258754, - 0.316684, - 0.252913, - 0.238706, - 0.253778, - 0.25971700000000003, - 0.28899400000000003, - 0.12170399999999999, - 0.275837, - 0.20447200000000001, - 0.076461, - 0.219354, - 0.206837, - 0.299534, - 0.228962, - 0.355074, - 0.11110199999999999, - 0.128245, - 0.32979400000000003, - 0.252967, - 0.203097, - 0.141965, - 0.21929, - 0.042761, - 0.16841199999999998, - 0.043218, - 0.268092, - 0.056121000000000004, - 0.135819, - 0.047844, - 0.22116100000000002, - 0.087675, - 0.059486000000000004, - 0.10608, - 0.038965, - 0.005253, - 0.005046, - 0.0020039999999999997, - 0.005792 - ] - }, - { - "name": "Hypocreales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.154702, - 0.27624299999999996, - 0.303465, - 0.181998, - 0.31545700000000004, - 0.13233699999999998, - 0.45063500000000006, - 0.158843, - 0.18678499999999998, - 0.273839, - 0.231356, - 0.070743, - 0.25106, - 0.258002, - 0.104675, - 0.16338699999999998, - 0.285088, - 0.26682, - 0.6428510000000001, - 0.163216, - 0.212655, - 0.355076, - 0.121992, - 0.181804, - 0.062694, - 0.11706, - 0.036860000000000004, - 0.062190999999999996, - 0.047037, - 0.184051, - 0.048503, - 0.053313, - 0.043664999999999995, - 0.25915900000000003, - 0.06340499999999999, - 0.018652000000000002, - 0.00411, - 0.0058, - 0.0038740000000000003, - 0.00614 - ] - }, - { - "name": "Helotiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.074874, - 0.128224, - 0.260681, - 0.19451400000000002, - 0.39511399999999997, - 0.105813, - 0.178128, - 0.24783899999999998, - 0.340923, - 0.13914100000000001, - 0.160326, - 0.059976999999999996, - 0.11280499999999999, - 0.303617, - 0.041556, - 0.248315, - 0.44633199999999995, - 0.510604, - 0.511171, - 0.14996600000000002, - 0.121868, - 0.363553, - 0.044718, - 0.210471, - 0.069732, - 0.1175, - 0.039313, - 0.02476, - 0.035685, - 0.051192, - 0.06504800000000001, - 0.055858000000000005, - 0.041256, - 0.339248, - 0.07732, - 0.009161, - 0.004222999999999999, - 0.0046700000000000005, - 0.006259000000000001, - 0.004411 - ] - }, - { - "name": "Myxococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.386141, - 0.223417, - 0.278844, - 0.2101, - 0.22140900000000002, - 0.24660900000000002, - 0.186151, - 0.204183, - 0.253798, - 0.20556799999999997, - 0.13578199999999999, - 0.268495, - 0.145895, - 0.191455, - 0.106031, - 0.23525, - 0.193325, - 0.126377, - 0.190697, - 0.229169, - 0.25966, - 0.152998, - 0.234233, - 0.18453699999999998, - 0.128176, - 0.1574, - 0.105581, - 0.09408899999999999, - 0.054428, - 0.073369, - 0.052315999999999994, - 0.161051, - 0.067781, - 0.096226, - 0.07721599999999999, - 0.036164999999999996, - 0.0052640000000000004, - 0.00949, - 0.002359, - 0.004524 - ] - }, - { - "name": "Pucciniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.12763, - 0.181811, - 0.109883, - 0.128419, - 0.151597, - 0.092335, - 0.138147, - 0.100392, - 0.137129, - 0.156184, - 0.12916, - 0.085099, - 0.193364, - 0.1275, - 0.493612, - 0.13443, - 0.376992, - 0.094861, - 0.119112, - 0.123196, - 0.13054100000000002, - 0.240939, - 0.06401, - 0.087059, - 0.086344, - 0.10045599999999999, - 0.111925, - 0.300482, - 0.115532, - 0.338861, - 0.096808, - 0.042977, - 0.06718500000000001, - 0.149321, - 0.024558, - 0.013996999999999999, - 0.002513, - 0.015996, - 0.001891, - 0.0035520000000000005 - ] - }, - { - "name": "Thermoanaerobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.29228200000000004, - 0.10592, - 0.057121000000000005, - 0.155229, - 0.06072, - 0.532862, - 0.08772999999999999, - 0.229494, - 0.11748199999999999, - 0.661107, - 0.083451, - 0.018918, - 0.033451, - 0.352147, - 0.01063, - 0.063122, - 0.046895, - 0.093834, - 0.082065, - 0.09188500000000001, - 0.036128, - 0.102216, - 1.3149110000000002, - 0.04252, - 0.014047, - 0.08737, - 0.009161, - 0.00998, - 0.0092, - 0.005297, - 0.011033, - 0.01797, - 0.025493000000000002, - 0.07278899999999999, - 0.048068, - 0.069395, - 0.005006, - 0.003662, - 0.0021219999999999998, - 0.008415 - ] - }, - { - "name": "Perkinsida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.144397, - 0.112033, - 0.154698, - 0.073649, - 0.121076, - 0.076922, - 0.10513099999999999, - 0.11064600000000001, - 0.091761, - 0.098937, - 0.054637, - 0.383035, - 0.043317, - 0.086609, - 0.350733, - 0.23415300000000003, - 0.037225, - 0.070145, - 0.094448, - 0.079782, - 0.13174, - 0.082857, - 0.05902999999999999, - 0.11010199999999999, - 0.28724299999999997, - 0.082084, - 0.40981599999999996, - 0.21, - 0.176709, - 0.24879099999999998, - 0.218048, - 0.045182, - 0.0296, - 0.060239999999999995, - 0.015453999999999999, - 0.006998999999999999, - 0.002441, - 0.032878, - 0.0025399999999999997, - 0.002536 - ] - }, - { - "name": "Pyrenomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.012723, - 0.016413999999999998, - 0.045942000000000004, - 0.016531, - 0.019923, - 0.012546, - 0.028758999999999996, - 0.018672, - 0.013080000000000001, - 0.017159999999999998, - 0.012249, - 0.212777, - 0.010288, - 0.0131, - 0.659932, - 0.019105, - 0.034387, - 0.042851, - 0.039395, - 0.051575, - 0.014348, - 0.013612, - 0.007601999999999999, - 0.045808, - 0.608951, - 0.014444, - 0.5945729999999999, - 0.440213, - 0.22746799999999998, - 0.49290100000000003, - 0.385189, - 0.009598, - 0.009935, - 0.037913999999999996, - 0.005845, - 0.001661, - 0.002091, - 0.11258599999999999, - 0.000778, - 0.001172 - ] - }, - { - "name": "Desulfuromonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.085734, - 0.182997, - 0.153752, - 0.045944, - 0.12115799999999999, - 0.056419000000000004, - 0.117843, - 0.047560000000000005, - 0.06525399999999999, - 0.167406, - 0.03209, - 0.486929, - 0.144451, - 0.10564100000000001, - 0.325947, - 0.10563099999999999, - 0.144204, - 0.084981, - 0.207103, - 0.05355, - 0.051285000000000004, - 0.030312000000000002, - 0.046081, - 0.133747, - 0.155505, - 0.044583, - 0.068857, - 0.385267, - 0.069699, - 0.117498, - 0.08742899999999999, - 0.115521, - 0.016911000000000002, - 0.032003, - 0.014587000000000001, - 0.024978999999999998, - 0.0011539999999999999, - 0.022313999999999997, - 0.001417, - 0.0029530000000000003 - ] - }, - { - "name": "Cytophagales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.193071, - 0.13758399999999998, - 0.133294, - 0.146902, - 0.128901, - 0.155851, - 0.087024, - 0.126864, - 0.141511, - 0.112882, - 0.126398, - 0.159613, - 0.070631, - 0.11130799999999999, - 0.10665, - 0.119931, - 0.12783699999999998, - 0.07495399999999999, - 0.100222, - 0.135453, - 0.120223, - 0.09893500000000001, - 0.135622, - 0.101774, - 0.147267, - 0.118905, - 0.096884, - 0.085903, - 0.091879, - 0.047120999999999996, - 0.148085, - 0.078984, - 0.042839, - 0.057411000000000004, - 0.034619, - 0.015124, - 0.003379, - 0.063345, - 0.001715, - 0.002449 - ] - }, - { - "name": "Oceanospirillales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.118038, - 0.083527, - 0.115731, - 0.09689099999999999, - 0.101302, - 0.08387599999999999, - 0.078274, - 0.102415, - 0.094358, - 0.105117, - 0.058735, - 0.068918, - 0.061064999999999994, - 0.087154, - 0.08340399999999999, - 0.091843, - 0.098441, - 0.07965900000000001, - 0.099061, - 0.093126, - 0.098582, - 0.099709, - 0.082936, - 0.08429099999999999, - 0.069374, - 0.064256, - 0.071124, - 0.725308, - 0.07922699999999999, - 0.08913, - 0.052389, - 0.0543, - 0.24790399999999999, - 0.105021, - 0.066819, - 0.03175, - 0.021683, - 0.055445, - 0.029245999999999998, - 0.018844 - ] - }, - { - "name": "Sphingobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.182527, - 0.112548, - 0.11551700000000001, - 0.157445, - 0.108009, - 0.19485, - 0.06105, - 0.117369, - 0.135344, - 0.091486, - 0.146672, - 0.203653, - 0.05781699999999999, - 0.091363, - 0.155777, - 0.114264, - 0.11873900000000001, - 0.07587, - 0.100332, - 0.117155, - 0.077639, - 0.064028, - 0.102228, - 0.094573, - 0.164392, - 0.090438, - 0.136255, - 0.082517, - 0.115627, - 0.067131, - 0.190155, - 0.08075700000000001, - 0.032216, - 0.055219000000000004, - 0.033933, - 0.010583, - 0.0029460000000000003, - 0.02286, - 0.000907, - 0.0015630000000000002 - ] - }, - { - "name": "Pleosporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.08212699999999999, - 0.139443, - 0.135474, - 0.127219, - 0.190722, - 0.115777, - 0.184013, - 0.13785799999999998, - 0.108517, - 0.167209, - 0.124046, - 0.034185, - 0.160274, - 0.118903, - 0.066558, - 0.162694, - 0.187609, - 0.215482, - 0.17993, - 0.08555399999999999, - 0.13782, - 0.218635, - 0.056461000000000004, - 0.09692200000000001, - 0.032538, - 0.096805, - 0.024294, - 0.037101999999999996, - 0.061389, - 0.062944, - 0.037299, - 0.053545, - 0.035176, - 0.119201, - 0.057339999999999995, - 0.008671, - 0.002493, - 0.004416, - 0.0027660000000000002, - 0.003917 - ] - }, - { - "name": "Verrucomicrobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.171231, - 0.114855, - 0.108205, - 0.13711099999999998, - 0.105252, - 0.147249, - 0.091438, - 0.138129, - 0.131907, - 0.11498599999999999, - 0.103531, - 0.026277999999999996, - 0.082965, - 0.090304, - 0.05803200000000001, - 0.17516700000000002, - 0.26586, - 0.105028, - 0.130838, - 0.12220299999999999, - 0.11087999999999999, - 0.10421300000000001, - 0.090432, - 0.160603, - 0.022963, - 0.10628699999999999, - 0.023536, - 0.06004299999999999, - 0.016146, - 0.036719, - 0.029646, - 0.147822, - 0.038962000000000004, - 0.060036, - 0.049102, - 0.014555000000000002, - 0.010167, - 0.005771, - 0.004312, - 0.002414 - ] - }, - { - "name": "Micromonosporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.19033599999999998, - 0.15841, - 0.19833699999999999, - 0.187712, - 0.15293800000000002, - 0.165027, - 0.129927, - 0.106919, - 0.097475, - 0.138559, - 0.112071, - 0.057848000000000004, - 0.116897, - 0.154083, - 0.08560599999999999, - 0.083945, - 0.078891, - 0.061273, - 0.093943, - 0.103201, - 0.125926, - 0.071038, - 0.101074, - 0.068083, - 0.039692000000000005, - 0.09018999999999999, - 0.033333999999999996, - 0.068678, - 0.035729000000000004, - 0.050275, - 0.042847, - 0.058352999999999995, - 0.045226, - 0.038865, - 0.058775, - 0.021599, - 0.002874, - 0.0053289999999999995, - 0.001097, - 0.003065 - ] - }, - { - "name": "Flavobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.149391, - 0.1164, - 0.10866500000000001, - 0.112884, - 0.09990299999999999, - 0.11111700000000001, - 0.073527, - 0.085204, - 0.152566, - 0.09199600000000001, - 0.08770900000000001, - 0.125367, - 0.071233, - 0.087551, - 0.095694, - 0.145234, - 0.181004, - 0.077575, - 0.08768, - 0.108021, - 0.09412000000000001, - 0.066728, - 0.084823, - 0.11648900000000001, - 0.10254100000000001, - 0.080765, - 0.12607100000000002, - 0.062475, - 0.066277, - 0.044176, - 0.09384400000000001, - 0.127059, - 0.035084, - 0.05231, - 0.021855, - 0.012062999999999999, - 0.001967, - 0.013359999999999999, - 0.0012980000000000001, - 0.002284 - ] - }, - { - "name": "Streptosporangiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.171191, - 0.19401500000000002, - 0.22917600000000002, - 0.19598800000000002, - 0.15688, - 0.143592, - 0.138873, - 0.098051, - 0.12828399999999998, - 0.137905, - 0.110198, - 0.036254, - 0.142827, - 0.165108, - 0.055136000000000004, - 0.077181, - 0.07966799999999999, - 0.057416999999999996, - 0.095971, - 0.094936, - 0.11531400000000001, - 0.074879, - 0.097772, - 0.065988, - 0.023225, - 0.095858, - 0.022363, - 0.039654, - 0.020983, - 0.03338, - 0.026998, - 0.056786, - 0.045913999999999996, - 0.035431, - 0.037877999999999995, - 0.017787, - 0.002215, - 0.003145, - 0.0010199999999999999, - 0.003013 - ] - }, - { - "name": "Rickettsiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.05767100000000001, - 0.038651, - 0.029020999999999998, - 0.021188, - 0.018175, - 0.135492, - 0.15492, - 0.028495, - 0.01625, - 0.054865, - 0.035161000000000005, - 0.011497, - 0.157807, - 0.035695, - 0.0114, - 0.015788999999999997, - 0.016474000000000003, - 0.011738, - 0.014731000000000001, - 0.016219, - 0.011253, - 0.014173, - 0.07942300000000001, - 0.027824, - 0.011462, - 0.050577, - 0.014854, - 0.012126999999999999, - 0.024777, - 0.011713, - 0.024902, - 0.148029, - 0.214587, - 0.009418000000000001, - 0.036985000000000004, - 0.326945, - 0.257396, - 0.140068, - 0.556134, - 0.423868 - ] - }, - { - "name": "Propionibacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.150342, - 0.124327, - 0.126532, - 0.178725, - 0.112232, - 0.103375, - 0.103032, - 0.09045700000000001, - 0.09008300000000001, - 0.102215, - 0.114628, - 0.07116900000000001, - 0.099329, - 0.114193, - 0.144148, - 0.06428500000000001, - 0.0592, - 0.041739, - 0.066711, - 0.082255, - 0.10948599999999999, - 0.083234, - 0.083984, - 0.046505, - 0.055162, - 0.084827, - 0.035601, - 0.157417, - 0.040216, - 0.19229300000000002, - 0.048882999999999996, - 0.041708999999999996, - 0.045111, - 0.027754, - 0.055800999999999996, - 0.015704, - 0.003616, - 0.013078, - 0.002107, - 0.0027530000000000002 - ] - }, - { - "name": "Nitrospirales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.2161, - 0.10536, - 0.10039, - 0.121892, - 0.09977799999999999, - 0.174275, - 0.06944600000000001, - 0.141247, - 0.205566, - 0.09437899999999999, - 0.08212699999999999, - 0.01174, - 0.064314, - 0.085255, - 0.014025, - 0.13939200000000002, - 0.088777, - 0.09979199999999999, - 0.122529, - 0.128554, - 0.096044, - 0.090295, - 0.149095, - 0.16386099999999998, - 0.010175, - 0.094099, - 0.009126, - 0.012134, - 0.008675, - 0.007618000000000001, - 0.013761, - 0.06253, - 0.032216, - 0.136469, - 0.054935000000000005, - 0.013349000000000001, - 0.0029980000000000002, - 0.001789, - 0.0014939999999999999, - 0.0019370000000000001 - ] - }, - { - "name": "Neocallimastigales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.070236, - 0.069195, - 0.065347, - 0.14674, - 0.086132, - 0.06717200000000001, - 0.044355, - 0.154001, - 0.071421, - 0.089309, - 0.091899, - 0.043431, - 0.029901, - 0.09439600000000001, - 0.087418, - 0.157352, - 0.11214, - 0.131522, - 0.088176, - 0.059704999999999994, - 0.039754000000000005, - 0.06350800000000001, - 0.045242000000000004, - 0.331646, - 0.06443600000000001, - 0.087532, - 0.069036, - 0.051870000000000006, - 0.094622, - 0.12931099999999998, - 0.059301, - 0.088781, - 0.033500999999999996, - 0.077359, - 0.017781, - 0.005553, - 0.001731, - 0.007127, - 0.0048530000000000005, - 0.0013460000000000002 - ] - }, - { - "name": "Tremellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.136945, - 0.161634, - 0.073754, - 0.155198, - 0.057209, - 0.128251, - 0.135283, - 0.12394300000000001, - 0.050456, - 0.113043, - 0.157107, - 0.18674200000000002, - 0.08868, - 0.127176, - 0.068923, - 0.052365999999999996, - 0.046918, - 0.056232000000000004, - 0.057637, - 0.09115, - 0.128226, - 0.082928, - 0.073656, - 0.07153, - 0.081475, - 0.071836, - 0.035315, - 0.054504, - 0.057754999999999994, - 0.046357999999999996, - 0.046189999999999995, - 0.023663999999999998, - 0.051398, - 0.034664999999999994, - 0.020406999999999998, - 0.010981999999999999, - 0.0022660000000000002, - 0.007353, - 0.001056, - 0.002023 - ] - }, - { - "name": "Ectocarpales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.088628, - 0.08744600000000001, - 0.15668800000000002, - 0.11073800000000002, - 0.085387, - 0.093052, - 0.09832300000000001, - 0.08694500000000001, - 0.10293599999999999, - 0.079216, - 0.067788, - 0.096108, - 0.049454000000000005, - 0.089435, - 0.135926, - 0.096618, - 0.07362300000000001, - 0.048668, - 0.07736, - 0.076834, - 0.094148, - 0.066198, - 0.057614, - 0.077515, - 0.12298699999999999, - 0.081673, - 0.117346, - 0.07622000000000001, - 0.10566800000000001, - 0.100341, - 0.074887, - 0.03599, - 0.041714999999999995, - 0.052266999999999994, - 0.025838, - 0.004404, - 0.0012259999999999999, - 0.007956, - 0.001808, - 0.001598 - ] - }, - { - "name": "Vibrionales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.10194600000000001, - 0.07082999999999999, - 0.0613, - 0.050337, - 0.055751999999999996, - 0.12222899999999999, - 0.12084400000000001, - 0.049105, - 0.066866, - 0.071335, - 0.045824000000000004, - 0.030962, - 0.11701700000000001, - 0.065148, - 0.028268, - 0.051287, - 0.043179, - 0.052273, - 0.045869, - 0.038893000000000004, - 0.050518, - 0.031087, - 0.086448, - 0.048972, - 0.022102, - 0.060404, - 0.020947, - 0.017054, - 0.025981, - 0.013641, - 0.194646, - 0.128832, - 0.129321, - 0.029224, - 0.020458, - 0.167683, - 0.075937, - 0.13484300000000002, - 0.139525, - 0.174376 - ] - }, - { - "name": "Mucorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.087399, - 0.09011, - 0.092337, - 0.063269, - 0.078249, - 0.093052, - 0.070133, - 0.069453, - 0.11603, - 0.068487, - 0.062274, - 0.134491, - 0.046686, - 0.07211000000000001, - 0.150125, - 0.118086, - 0.039349, - 0.071728, - 0.086661, - 0.060739, - 0.078503, - 0.048652, - 0.068833, - 0.069347, - 0.072888, - 0.073528, - 0.133959, - 0.052464, - 0.057675, - 0.061964, - 0.11101199999999999, - 0.032533, - 0.038824000000000004, - 0.045998000000000004, - 0.014547999999999998, - 0.0207, - 0.011918000000000002, - 0.017200999999999998, - 0.005342, - 0.018271000000000003 - ] - }, - { - "name": "Sordariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.043125, - 0.090581, - 0.050178, - 0.055827, - 0.087871, - 0.033048, - 0.143208, - 0.084642, - 0.097009, - 0.11169100000000001, - 0.051475, - 0.117702, - 0.11804, - 0.153303, - 0.073012, - 0.051926, - 0.07556, - 0.081467, - 0.082755, - 0.07007000000000001, - 0.082756, - 0.22744899999999998, - 0.020498, - 0.053581, - 0.1144, - 0.049726, - 0.053301999999999995, - 0.025075999999999998, - 0.137245, - 0.038762, - 0.044364999999999995, - 0.018782, - 0.009958, - 0.075889, - 0.016501, - 0.005258, - 0.001308, - 0.013247, - 0.001035, - 0.002345 - ] - }, - { - "name": "Polyporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.083951, - 0.10506900000000001, - 0.11486800000000001, - 0.11231400000000001, - 0.089585, - 0.11233599999999999, - 0.101619, - 0.085756, - 0.07421900000000001, - 0.085127, - 0.08294800000000001, - 0.042397000000000004, - 0.063171, - 0.08809600000000001, - 0.10610699999999999, - 0.04978, - 0.042686, - 0.082426, - 0.074161, - 0.048047, - 0.074906, - 0.042926, - 0.056985, - 0.056828, - 0.118872, - 0.063625, - 0.051235, - 0.057561, - 0.06274600000000001, - 0.104521, - 0.081203, - 0.033652, - 0.09862, - 0.042626, - 0.028502, - 0.013064, - 0.0017510000000000002, - 0.008088, - 0.0008349999999999999, - 0.001572 - ] - }, - { - "name": "Fusobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.014269, - 0.020087, - 0.019446, - 0.021422, - 0.014325, - 0.016416999999999998, - 0.016538, - 0.020151, - 0.00979, - 0.019739, - 0.012431999999999999, - 0.199273, - 0.019252000000000002, - 0.019209, - 0.3804, - 0.011021, - 0.022122, - 0.015734, - 0.014277000000000001, - 0.028776999999999997, - 0.013930000000000001, - 0.017067, - 0.007916, - 0.021083, - 0.352667, - 0.011939, - 0.30841799999999997, - 0.155338, - 0.138172, - 0.145334, - 0.470242, - 0.007543000000000001, - 0.010601000000000001, - 0.012222, - 0.0036340000000000005, - 0.0028899999999999998, - 0.0024, - 0.042519, - 0.002184, - 0.001832 - ] - }, - { - "name": "Capnodiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.060684, - 0.06756000000000001, - 0.083173, - 0.065526, - 0.09794, - 0.065523, - 0.09954, - 0.087348, - 0.098541, - 0.072508, - 0.06375800000000001, - 0.03157, - 0.11611400000000001, - 0.057523000000000005, - 0.012789, - 0.098686, - 0.19864500000000002, - 0.306664, - 0.15582200000000002, - 0.061577, - 0.064866, - 0.104029, - 0.035858, - 0.066189, - 0.016564, - 0.046830000000000004, - 0.00831, - 0.010447, - 0.016511, - 0.013994999999999999, - 0.052063, - 0.026557, - 0.020054, - 0.151284, - 0.034037, - 0.005383, - 0.001422, - 0.0017699999999999999, - 0.0017620000000000001, - 0.002188 - ] - }, - { - "name": "Rhodocyclales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.16730699999999998, - 0.098082, - 0.11198, - 0.069349, - 0.102105, - 0.105956, - 0.093831, - 0.094324, - 0.115444, - 0.11109000000000001, - 0.03975, - 0.022141, - 0.076287, - 0.068651, - 0.025686, - 0.086761, - 0.07220700000000001, - 0.09816, - 0.140602, - 0.07974099999999999, - 0.093395, - 0.08732000000000001, - 0.14028800000000002, - 0.075668, - 0.018558, - 0.065872, - 0.013488, - 0.031885000000000004, - 0.01546, - 0.012953999999999999, - 0.016273, - 0.047975, - 0.026456, - 0.078613, - 0.036377, - 0.020507, - 0.002575, - 0.003766, - 0.000742, - 0.002605 - ] - }, - { - "name": "Isochrysidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.023703000000000002, - 0.025618000000000002, - 0.025106, - 0.038085, - 0.013952, - 0.023227, - 0.020146999999999998, - 0.020189, - 0.012121, - 0.021342, - 0.026907, - 0.23212, - 0.01468, - 0.022933000000000002, - 0.8213389999999999, - 0.015247, - 0.018196, - 0.011939, - 0.019597, - 0.013623, - 0.014988999999999999, - 0.008559, - 0.014155000000000001, - 0.025190999999999998, - 0.042383, - 0.01995, - 0.019303, - 0.2314, - 0.119414, - 0.561327, - 0.02502, - 0.008214, - 0.019641, - 0.016391, - 0.0058189999999999995, - 0.001377, - 0.000865, - 0.009706999999999999, - 0.00044800000000000005, - 0.00048600000000000005 - ] - }, - { - "name": "Bacteroidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.10293699999999999, - 0.0829, - 0.096688, - 0.060391999999999994, - 0.06663200000000001, - 0.09756799999999999, - 0.077391, - 0.059565, - 0.070715, - 0.072114, - 0.052548000000000004, - 0.10565799999999999, - 0.072256, - 0.063676, - 0.045016, - 0.060873000000000003, - 0.121815, - 0.045515, - 0.062275, - 0.060874, - 0.05767100000000001, - 0.035783999999999996, - 0.070563, - 0.101939, - 0.053371, - 0.057593, - 0.034364, - 0.026851, - 0.042682, - 0.020896, - 0.046443, - 0.075544, - 0.044652, - 0.030324, - 0.015699, - 0.036416000000000004, - 0.025802999999999996, - 0.031945, - 0.021302, - 0.050289 - ] - }, - { - "name": "Caulobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.086369, - 0.06565700000000001, - 0.054777, - 0.056090999999999995, - 0.047538, - 0.05613200000000001, - 0.042668, - 0.045528, - 0.039201, - 0.047816000000000004, - 0.039123000000000005, - 0.156693, - 0.041753, - 0.045482999999999996, - 0.167991, - 0.063218, - 0.026529, - 0.027013, - 0.029841000000000003, - 0.047872000000000005, - 0.046126, - 0.037709, - 0.051376, - 0.041569999999999996, - 0.13658800000000001, - 0.040148, - 0.105324, - 0.1612, - 0.10998699999999999, - 0.077456, - 0.098281, - 0.038029, - 0.016314, - 0.016471, - 0.017083, - 0.007215000000000001, - 0.001401, - 0.022747, - 0.000567, - 0.001216 - ] - }, - { - "name": "Onygenales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.028974, - 0.05914, - 0.322862, - 0.102849, - 0.178127, - 0.033335000000000004, - 0.130888, - 0.038074000000000004, - 0.09312000000000001, - 0.054471000000000006, - 0.096933, - 0.016789, - 0.058960000000000005, - 0.06336699999999999, - 0.028463, - 0.067197, - 0.138131, - 0.123896, - 0.101712, - 0.041179, - 0.041483, - 0.033461000000000005, - 0.015046, - 0.053109, - 0.008916, - 0.06804099999999999, - 0.007988, - 0.011692000000000001, - 0.009521, - 0.020395, - 0.009939, - 0.025762, - 0.022923, - 0.05726900000000001, - 0.010229, - 0.004222, - 0.001349, - 0.004011, - 0.001726, - 0.000999 - ] - }, - { - "name": "Chytridiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.024377, - 0.030723, - 0.036441, - 0.038218, - 0.028533999999999997, - 0.025378, - 0.028444999999999998, - 0.04212, - 0.030396, - 0.034785, - 0.021633000000000003, - 0.24805700000000003, - 0.022922, - 0.035886, - 0.182341, - 0.070097, - 0.036285000000000005, - 0.049589999999999995, - 0.033553, - 0.024246, - 0.020441, - 0.018675999999999998, - 0.013368000000000001, - 0.122733, - 0.16112, - 0.027855, - 0.130498, - 0.08673, - 0.159272, - 0.148342, - 0.103774, - 0.016909, - 0.014983000000000002, - 0.026217, - 0.009052, - 0.002344, - 0.000999, - 0.024715, - 0.0013390000000000001, - 0.000799 - ] - }, - { - "name": "Anaerolineales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.091799, - 0.125671, - 0.14261400000000002, - 0.046188, - 0.099406, - 0.051472000000000004, - 0.12722, - 0.057504999999999994, - 0.048205, - 0.133221, - 0.03902, - 0.01028, - 0.101615, - 0.07181599999999999, - 0.013656999999999999, - 0.064183, - 0.154877, - 0.052253999999999995, - 0.064859, - 0.0758, - 0.081389, - 0.038575, - 0.057248, - 0.061172000000000004, - 0.0077540000000000005, - 0.06091, - 0.006365, - 0.010378, - 0.004757, - 0.006940000000000001, - 0.008069, - 0.079597, - 0.02625, - 0.024253, - 0.02192, - 0.017764, - 0.0010710000000000001, - 0.001111, - 0.000587, - 0.002301 - ] - }, - { - "name": "Sebacinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.06278500000000001, - 0.097791, - 0.214081, - 0.101273, - 0.154114, - 0.057351, - 0.074821, - 0.06951900000000001, - 0.112194, - 0.06375800000000001, - 0.10193300000000001, - 0.003771, - 0.085311, - 0.087139, - 0.027507999999999998, - 0.052878999999999995, - 0.031804, - 0.047824, - 0.048958, - 0.052444000000000005, - 0.11209300000000001, - 0.035223000000000004, - 0.029410000000000002, - 0.019714, - 0.005896, - 0.054697, - 0.006572, - 0.038372, - 0.004472, - 0.109787, - 0.005783, - 0.027112999999999998, - 0.021454, - 0.018633, - 0.013449000000000001, - 0.009502, - 0.0010199999999999999, - 0.00064, - 0.001056, - 0.001216 - ] - }, - { - "name": "Mortierellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.074002, - 0.086147, - 0.032838, - 0.161807, - 0.05051, - 0.07599, - 0.038607, - 0.096337, - 0.031049, - 0.071908, - 0.112196, - 0.025244, - 0.027614999999999997, - 0.09051000000000001, - 0.048617, - 0.090655, - 0.079956, - 0.05846799999999999, - 0.051761, - 0.075583, - 0.036756, - 0.048663, - 0.050065, - 0.08063200000000001, - 0.052926, - 0.045597000000000006, - 0.022821, - 0.035991, - 0.022151, - 0.042186, - 0.046551999999999996, - 0.036429, - 0.015557, - 0.063185, - 0.024661000000000002, - 0.004586, - 0.001452, - 0.003333, - 0.002081, - 0.001442 - ] - }, - { - "name": "Mixiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.042372, - 0.044831, - 0.02513, - 0.045101, - 0.033428, - 0.07685, - 0.02515, - 0.15676400000000001, - 0.045114999999999995, - 0.030101, - 0.049157, - 0.273544, - 0.012694, - 0.041538, - 0.050494, - 0.185211, - 0.07885199999999999, - 0.158957, - 0.027619, - 0.020677, - 0.016119, - 0.018829, - 0.023381, - 0.055358000000000004, - 0.029043, - 0.035674000000000004, - 0.037933, - 0.036774, - 0.060067999999999996, - 0.058387, - 0.033313999999999996, - 0.011156999999999999, - 0.008398000000000001, - 0.047987, - 0.006337, - 0.0022530000000000002, - 0.00067, - 0.004397, - 0.002947, - 0.0009119999999999999 - ] - }, - { - "name": "Chromatiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.119703, - 0.08153400000000001, - 0.10025, - 0.076283, - 0.082232, - 0.080076, - 0.070113, - 0.066148, - 0.075777, - 0.072087, - 0.051418, - 0.021351, - 0.058838999999999995, - 0.064471, - 0.060538, - 0.050702, - 0.054225999999999996, - 0.037627, - 0.057662, - 0.07247999999999999, - 0.085837, - 0.052788999999999996, - 0.064063, - 0.042756999999999996, - 0.018113, - 0.059380999999999996, - 0.014861000000000001, - 0.02265, - 0.015059000000000001, - 0.017365000000000002, - 0.01902, - 0.033139, - 0.02625, - 0.029521, - 0.025165, - 0.013178, - 0.002503, - 0.003728, - 0.002437, - 0.00231 - ] - }, - { - "name": "Opitutales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.138729, - 0.12468499999999999, - 0.099773, - 0.059029, - 0.064363, - 0.09126000000000001, - 0.101286, - 0.052757000000000005, - 0.073086, - 0.092847, - 0.038381, - 0.01028, - 0.109136, - 0.06625199999999999, - 0.01665, - 0.048435, - 0.07543, - 0.035762999999999996, - 0.043663, - 0.063346, - 0.091011, - 0.042794, - 0.077641, - 0.035792000000000004, - 0.007298999999999999, - 0.064246, - 0.005836, - 0.018134, - 0.004443, - 0.010078, - 0.009424, - 0.041693, - 0.026548000000000002, - 0.028366000000000002, - 0.014962, - 0.009604999999999999, - 0.000824, - 0.00128, - 0.000453, - 0.001789 - ] - }, - { - "name": "Auriculariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.165166, - 0.155275, - 0.11314, - 0.118628, - 0.068446, - 0.12746300000000002, - 0.12004000000000001, - 0.049096, - 0.051108999999999995, - 0.078947, - 0.055436, - 0.004258, - 0.110399, - 0.13324, - 0.018071, - 0.027491, - 0.025748000000000004, - 0.026029000000000004, - 0.032038, - 0.044861, - 0.06199400000000001, - 0.025146, - 0.090485, - 0.031063999999999998, - 0.005325, - 0.036057, - 0.00442, - 0.004832, - 0.0038299999999999996, - 0.010032, - 0.006162, - 0.020142, - 0.015855, - 0.018009, - 0.012169, - 0.007681, - 0.000762, - 0.0008849999999999999, - 0.000392, - 0.001667 - ] - }, - { - "name": "Gemmatimonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.08296, - 0.048884, - 0.064599, - 0.053458000000000006, - 0.05032, - 0.061509, - 0.044238, - 0.048122000000000005, - 0.054572, - 0.048694, - 0.033026, - 0.09988, - 0.041392, - 0.039522, - 0.059128, - 0.049563, - 0.068949, - 0.03927, - 0.050482, - 0.05475, - 0.054604, - 0.039024, - 0.048335, - 0.041995, - 0.069161, - 0.032157, - 0.053051999999999995, - 0.05313300000000001, - 0.058565, - 0.036519, - 0.084935, - 0.045655, - 0.017713999999999997, - 0.021054, - 0.020898, - 0.008137, - 0.0010609999999999999, - 0.009726, - 0.000443, - 0.001059 - ] - }, - { - "name": "Desulfobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.073487, - 0.074771, - 0.08806699999999999, - 0.045344999999999996, - 0.061738, - 0.052548000000000004, - 0.070329, - 0.046689, - 0.046606, - 0.070359, - 0.029499, - 0.070074, - 0.057696000000000004, - 0.051414999999999995, - 0.036208, - 0.05450700000000001, - 0.094431, - 0.039845, - 0.049387, - 0.050871, - 0.054116, - 0.034856, - 0.039843, - 0.057371000000000005, - 0.036923000000000004, - 0.040492, - 0.042732, - 0.032523, - 0.029279000000000003, - 0.021097, - 0.029194, - 0.041518, - 0.018058, - 0.02253, - 0.014341, - 0.011676, - 0.003698, - 0.028961, - 0.005239, - 0.003812 - ] - }, - { - "name": "Chlamydomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.037655, - 0.029671, - 0.033710000000000004, - 0.035828, - 0.028145, - 0.026955, - 0.023855, - 0.040247000000000005, - 0.032780000000000004, - 0.026125, - 0.022113, - 0.380845, - 0.019493, - 0.026407, - 0.089869, - 0.046784, - 0.027855, - 0.036673000000000004, - 0.036255, - 0.035055, - 0.0303, - 0.029802999999999996, - 0.021337000000000002, - 0.050134, - 0.109608, - 0.029020999999999998, - 0.047666, - 0.042527999999999996, - 0.118349, - 0.047268, - 0.08573, - 0.021468, - 0.01223, - 0.022758, - 0.0052759999999999994, - 0.003016, - 0.000834, - 0.014584, - 0.000665, - 0.000573 - ] - }, - { - "name": "Gigartinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.013992, - 0.013569999999999999, - 0.013063, - 0.023099, - 0.031010000000000003, - 0.043227999999999996, - 0.133517, - 0.010151, - 0.009111, - 0.010407, - 0.019327, - 0.038261, - 0.659205, - 0.012511, - 0.037152, - 0.018563, - 0.008492, - 0.030012999999999998, - 0.010085, - 0.010695999999999999, - 0.25412399999999996, - 0.004717, - 0.024902, - 0.043937000000000004, - 0.017581, - 0.015304, - 0.009776, - 0.009317, - 0.028031, - 0.027936000000000002, - 0.017475, - 0.004468, - 0.007181999999999999, - 0.00675, - 0.006659999999999999, - 0.001536, - 0.000412, - 0.0019399999999999999, - 0.00047400000000000003, - 0.000677 - ] - }, - { - "name": "Viruses", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.10329300000000001, - 0.06263400000000001, - 0.076304, - 0.061876, - 0.061755, - 0.069108, - 0.045179000000000004, - 0.030330000000000003, - 0.06729199999999999, - 0.045935000000000004, - 0.041166, - 0.042457999999999996, - 0.049152999999999995, - 0.078984, - 0.043909, - 0.059052, - 0.052378999999999995, - 0.047647, - 0.058647000000000005, - 0.035511, - 0.051229, - 0.030628, - 0.055465, - 0.039639999999999995, - 0.020843, - 0.041114, - 0.029186, - 0.025707999999999998, - 0.017744, - 0.028831, - 0.023466, - 0.032567, - 0.017599, - 0.028743, - 0.008794, - 0.0060539999999999995, - 0.00067, - 0.00499, - 0.000453, - 0.001259 - ] - }, - { - "name": "Jaapiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.021443, - 0.025372, - 0.055822000000000004, - 0.091279, - 0.061672000000000005, - 0.043587, - 0.045199, - 0.0938, - 0.035177999999999994, - 0.032045, - 0.094125, - 0.00955, - 0.023163, - 0.065825, - 0.036219, - 0.25869000000000003, - 0.027668, - 0.07874199999999999, - 0.035127, - 0.027411, - 0.060139, - 0.036955, - 0.014207, - 0.025593, - 0.010136, - 0.034996, - 0.014632, - 0.011508, - 0.005231, - 0.016509, - 0.010192, - 0.014704, - 0.021546, - 0.032083999999999994, - 0.019178, - 0.002754, - 0.0007, - 0.0011769999999999999, - 0.000644, - 0.000886 - ] - }, - { - "name": "Rhizophydiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.045860000000000005, - 0.047317000000000005, - 0.030789999999999998, - 0.06354299999999999, - 0.032086, - 0.044304, - 0.03282, - 0.043102999999999995, - 0.011895000000000001, - 0.042505, - 0.065859, - 0.034246, - 0.023163, - 0.035914999999999996, - 0.089934, - 0.013155000000000002, - 0.023306, - 0.016730000000000002, - 0.016802, - 0.065673, - 0.044369, - 0.03938, - 0.029934, - 0.027493, - 0.041434, - 0.061876, - 0.033062, - 0.04724, - 0.025624, - 0.100526, - 0.0564, - 0.00615, - 0.05624, - 0.013493999999999999, - 0.014497, - 0.004381, - 0.000752, - 0.003568, - 0.000659, - 0.0007469999999999999 - ] - }, - { - "name": "Atheliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.045701, - 0.08337, - 0.069024, - 0.065638, - 0.057449, - 0.030468000000000002, - 0.035684, - 0.037821, - 0.033645999999999995, - 0.042845999999999995, - 0.040732, - 0.008638, - 0.026351, - 0.072758, - 0.009165999999999999, - 0.126274, - 0.131973, - 0.088665, - 0.03059, - 0.041086000000000004, - 0.033925, - 0.020735, - 0.03266, - 0.028544, - 0.005141, - 0.036057, - 0.007788, - 0.013568, - 0.0047420000000000006, - 0.004696, - 0.006704000000000001, - 0.017, - 0.011817, - 0.034641000000000005, - 0.0146, - 0.004495, - 0.00067, - 0.000603, - 0.000938, - 0.000842 - ] - }, - { - "name": "Legionellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.060248, - 0.050071, - 0.058865, - 0.042762, - 0.0586, - 0.063946, - 0.041628, - 0.036951, - 0.059846, - 0.046777, - 0.036771, - 0.022811, - 0.038865, - 0.058775, - 0.016628999999999998, - 0.042497, - 0.036517, - 0.033551, - 0.054345000000000004, - 0.031652, - 0.036351, - 0.029874, - 0.072451, - 0.038678, - 0.017203, - 0.034221, - 0.016069999999999997, - 0.011464, - 0.022872999999999998, - 0.008752, - 0.022246000000000002, - 0.027469, - 0.023978, - 0.023221000000000002, - 0.014484, - 0.022931, - 0.007983, - 0.017117, - 0.005291, - 0.011072 - ] - }, - { - "name": "Desulfovibrionales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.067977, - 0.063395, - 0.08101799999999999, - 0.046646, - 0.057515, - 0.049609, - 0.066582, - 0.04374, - 0.037136, - 0.056647, - 0.033974000000000004, - 0.020925, - 0.045182, - 0.048309, - 0.022768, - 0.035956, - 0.052147000000000006, - 0.029151999999999997, - 0.038293, - 0.040941000000000005, - 0.042291, - 0.031351, - 0.038217, - 0.039457, - 0.015402, - 0.036554, - 0.014046000000000001, - 0.018981, - 0.012119, - 0.012137, - 0.014258000000000002, - 0.02843, - 0.015672, - 0.018991, - 0.012014, - 0.008512, - 0.004234, - 0.005574, - 0.004786, - 0.002284 - ] - }, - { - "name": "Wallemiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.009315, - 0.026536, - 0.031506, - 0.026007, - 0.019103, - 0.022654, - 0.044002, - 0.014383000000000002, - 0.010829, - 0.018691, - 0.019407, - 0.206511, - 0.011792, - 0.023477, - 0.142673, - 0.008706, - 0.016988999999999997, - 0.005707, - 0.009487, - 0.009289, - 0.024945, - 0.009729999999999999, - 0.011691, - 0.011828, - 0.096238, - 0.01627, - 0.018022, - 0.01936, - 0.26314499999999996, - 0.043296, - 0.075402, - 0.004252000000000001, - 0.01005, - 0.007955, - 0.005625, - 0.0011949999999999999, - 0.00047400000000000003, - 0.011486, - 0.000118, - 0.000452 - ] - }, - { - "name": "Campylobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.029648, - 0.029716000000000003, - 0.047168, - 0.018667, - 0.073331, - 0.025378, - 0.025954, - 0.017828999999999998, - 0.020499, - 0.069687, - 0.018186, - 0.013382, - 0.02232, - 0.025478999999999998, - 0.069314, - 0.020227000000000002, - 0.019408, - 0.058071000000000005, - 0.017223, - 0.017005000000000003, - 0.019354, - 0.344021, - 0.019187, - 0.016887, - 0.011433, - 0.019587, - 0.009247, - 0.07906200000000001, - 0.007019, - 0.015699, - 0.016725, - 0.010651, - 0.036483999999999996, - 0.010190000000000001, - 0.010721, - 0.0273, - 0.004563, - 0.00402, - 0.003307, - 0.001511 - ] - }, - { - "name": "Bacillariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.011732, - 0.014712000000000001, - 0.010126000000000001, - 0.011529000000000001, - 0.010897, - 0.009248000000000001, - 0.008161, - 0.039675999999999996, - 0.012866999999999998, - 0.019041, - 0.005149, - 0.039417, - 0.008242, - 0.011951999999999999, - 0.153802, - 0.013661000000000001, - 0.027526, - 0.041757, - 0.035582, - 0.012485, - 0.004183, - 0.007070999999999999, - 0.009856, - 0.086564, - 0.09574500000000001, - 0.015811000000000002, - 0.144458, - 0.097954, - 0.041522, - 0.119788, - 0.12199000000000002, - 0.006291, - 0.003488, - 0.020547, - 0.0029230000000000003, - 0.0011380000000000001, - 0.000762, - 0.015328, - 0.0009220000000000001, - 0.000495 - ] - }, - { - "name": "Nitrosomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.070355, - 0.039591, - 0.04665, - 0.038613999999999996, - 0.041245, - 0.046741000000000005, - 0.043394, - 0.046071, - 0.034192, - 0.044001, - 0.027604000000000004, - 0.027069, - 0.033812, - 0.032014999999999995, - 0.030860000000000002, - 0.030198000000000003, - 0.02756, - 0.033184, - 0.033191000000000005, - 0.040195999999999996, - 0.044494, - 0.033379, - 0.040472, - 0.033053, - 0.019139, - 0.037118, - 0.025424000000000002, - 0.038587, - 0.025179, - 0.016038999999999998, - 0.022761, - 0.020424, - 0.014708, - 0.021881, - 0.016113, - 0.005952000000000001, - 0.003935, - 0.08212799999999999, - 0.004642, - 0.001068 - ] - }, - { - "name": "Albuginales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004479, - 0.00421, - 0.00584, - 0.0060799999999999995, - 0.005340999999999999, - 0.004516, - 0.0064540000000000005, - 0.004963, - 0.0038090000000000003, - 0.00352, - 0.004121, - 0.019465, - 0.003068, - 0.003592, - 0.354074, - 0.004256, - 0.006124, - 0.005438, - 0.00713, - 0.005151, - 0.007626999999999999, - 0.003128, - 0.002621, - 0.006292, - 0.12448699999999999, - 0.004693999999999999, - 0.072311, - 0.140413, - 0.029519999999999998, - 0.2588, - 0.082351, - 0.002503, - 0.005599, - 0.006645, - 0.001849, - 0.00044400000000000006, - 0.00047400000000000003, - 0.017352, - 0.00023199999999999997, - 0.000295 - ] - }, - { - "name": "Solirubrobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.052875, - 0.046959, - 0.064985, - 0.072145, - 0.053582000000000005, - 0.034339, - 0.043355, - 0.038992, - 0.023056999999999998, - 0.048067, - 0.041964999999999995, - 0.038504000000000004, - 0.038202999999999994, - 0.046675, - 0.054041, - 0.022174, - 0.020049, - 0.014561000000000001, - 0.024967, - 0.040145, - 0.05042, - 0.031932, - 0.022752, - 0.017559, - 0.023931, - 0.028543000000000002, - 0.019703000000000002, - 0.047606, - 0.020173, - 0.039495, - 0.021207, - 0.015981, - 0.018127, - 0.009498999999999999, - 0.025695999999999997, - 0.008284999999999999, - 0.001051, - 0.0032670000000000004, - 0.000227, - 0.001007 - ] - }, - { - "name": "Boletales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.044076, - 0.038158, - 0.029605000000000003, - 0.045446, - 0.031706, - 0.035773, - 0.028406, - 0.034076, - 0.058088, - 0.029626999999999997, - 0.040264, - 0.037226999999999996, - 0.025449, - 0.039345, - 0.036815, - 0.111491, - 0.032958999999999995, - 0.036275999999999996, - 0.044757, - 0.022012, - 0.026591000000000004, - 0.018483000000000003, - 0.019712, - 0.056049, - 0.025471, - 0.0362, - 0.055733000000000005, - 0.01905, - 0.025675, - 0.028444999999999998, - 0.02118, - 0.022247, - 0.012345, - 0.02563, - 0.009958, - 0.0032090000000000005, - 0.0008029999999999999, - 0.003116, - 0.000907, - 0.000729 - ] - }, - { - "name": "Nostocales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.059217, - 0.051975, - 0.049372000000000006, - 0.045202, - 0.051537, - 0.065022, - 0.040667, - 0.040724, - 0.031488, - 0.042031, - 0.037798000000000005, - 0.025547999999999998, - 0.040429, - 0.041479, - 0.018938999999999998, - 0.029318, - 0.031826, - 0.026573000000000003, - 0.027551, - 0.041510000000000005, - 0.089839, - 0.03129, - 0.031035000000000004, - 0.026136000000000003, - 0.013194999999999998, - 0.040530000000000004, - 0.017021, - 0.015652000000000003, - 0.011156000000000001, - 0.011165000000000001, - 0.014240000000000001, - 0.023698, - 0.014525, - 0.013853, - 0.011432, - 0.007431, - 0.001452, - 0.002834, - 0.001113, - 0.001902 - ] - }, - { - "name": "Frankiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.067819, - 0.048907, - 0.06079, - 0.061724, - 0.048076, - 0.048963, - 0.040510000000000004, - 0.034535, - 0.032074, - 0.042111, - 0.037456, - 0.019283, - 0.034714, - 0.042950999999999996, - 0.029298, - 0.027870999999999996, - 0.022502, - 0.01907, - 0.029301999999999998, - 0.032882999999999996, - 0.041678, - 0.025258000000000003, - 0.03785, - 0.02646, - 0.011917, - 0.032175999999999996, - 0.01012, - 0.022959999999999998, - 0.00982, - 0.019478, - 0.013453999999999999, - 0.018186, - 0.015441999999999999, - 0.012543, - 0.018557, - 0.00759, - 0.000886, - 0.001836, - 0.000433, - 0.001094 - ] - }, - { - "name": "Synechococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.06084199999999999, - 0.049355, - 0.055278999999999995, - 0.039438, - 0.045029, - 0.043443, - 0.040667, - 0.034937, - 0.037442, - 0.042828, - 0.029191, - 0.020256, - 0.037121, - 0.037181, - 0.020913, - 0.032001, - 0.036788999999999995, - 0.023934, - 0.032518, - 0.038995999999999996, - 0.041943, - 0.025442, - 0.031193000000000002, - 0.054903999999999994, - 0.010059, - 0.029432, - 0.010749, - 0.014648, - 0.009332, - 0.011951999999999999, - 0.012279, - 0.023175, - 0.012894999999999998, - 0.013198, - 0.010824, - 0.006122, - 0.000865, - 0.001356, - 0.000484, - 0.001042 - ] - }, - { - "name": "Dictyosteliida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.027666000000000003, - 0.018855, - 0.018581999999999998, - 0.028203, - 0.016594, - 0.021865, - 0.011653, - 0.016584, - 0.037362, - 0.015163, - 0.02241, - 0.08224, - 0.008964, - 0.016324, - 0.042293, - 0.033792, - 0.017987, - 0.017677000000000002, - 0.024008, - 0.022653, - 0.023244, - 0.01077, - 0.015203, - 0.049201999999999996, - 0.053815999999999996, - 0.017837000000000002, - 0.096956, - 0.026503, - 0.07689299999999999, - 0.027304000000000002, - 0.074463, - 0.017166, - 0.006953, - 0.011777, - 0.00419, - 0.001627, - 0.000515, - 0.006901000000000001, - 0.000227, - 0.000408 - ] - }, - { - "name": "Mamiellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.036466000000000005, - 0.024856, - 0.021749, - 0.027573, - 0.020013999999999997, - 0.026668, - 0.020206000000000002, - 0.021715, - 0.023337, - 0.022533, - 0.022661, - 0.033942, - 0.017506999999999998, - 0.02336, - 0.140677, - 0.017978, - 0.015681, - 0.017836, - 0.022686, - 0.020584, - 0.023802, - 0.012502, - 0.0173, - 0.021519999999999997, - 0.039072, - 0.022387, - 0.030423000000000002, - 0.067389, - 0.036757, - 0.083647, - 0.038926, - 0.009996, - 0.011679, - 0.012709999999999999, - 0.0035299999999999997, - 0.002333, - 0.000484, - 0.005263, - 0.000283, - 0.000443 - ] - }, - { - "name": "Xylariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.019500999999999998, - 0.032514999999999995, - 0.040406, - 0.03714, - 0.048523000000000004, - 0.046526, - 0.047102, - 0.040133999999999996, - 0.02628, - 0.037794, - 0.036782, - 0.011314, - 0.034352999999999995, - 0.045586, - 0.008461, - 0.038361, - 0.041757, - 0.057490999999999993, - 0.070103, - 0.035976, - 0.036811, - 0.054939, - 0.011323999999999999, - 0.021402, - 0.006186, - 0.019902, - 0.007595, - 0.0065060000000000005, - 0.007098999999999999, - 0.008274, - 0.005177, - 0.012027, - 0.008811, - 0.030842, - 0.015053, - 0.002799, - 0.000587, - 0.0009130000000000001, - 0.000788, - 0.001068 - ] - }, - { - "name": "Chaetothyriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.037536, - 0.03715, - 0.03705, - 0.034568, - 0.028087, - 0.026597000000000003, - 0.027347000000000003, - 0.023448, - 0.025774000000000002, - 0.028838, - 0.023311000000000002, - 0.012591, - 0.025569, - 0.028983, - 0.065441, - 0.177681, - 0.020479, - 0.025858, - 0.019512, - 0.021836, - 0.026507, - 0.018055, - 0.023329, - 0.014909, - 0.009970999999999999, - 0.021881, - 0.012272, - 0.024735, - 0.008981, - 0.04069, - 0.013038, - 0.018608, - 0.010417000000000001, - 0.010345, - 0.007811, - 0.003915, - 0.000608, - 0.001572, - 0.00034500000000000004, - 0.001007 - ] - }, - { - "name": "Chloroflexales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.031036, - 0.080571, - 0.06903200000000001, - 0.039956, - 0.056282000000000006, - 0.026597000000000003, - 0.053595000000000004, - 0.026331999999999998, - 0.017183, - 0.053575, - 0.025663, - 0.023297, - 0.043077, - 0.066193, - 0.018755, - 0.019449, - 0.023765, - 0.017414, - 0.024235, - 0.022446, - 0.030969, - 0.021468, - 0.014469, - 0.018268, - 0.008645, - 0.019271, - 0.009526, - 0.01881, - 0.009696, - 0.01115, - 0.008385, - 0.019263, - 0.012001000000000001, - 0.007751000000000001, - 0.012311, - 0.006487000000000001, - 0.0005769999999999999, - 0.0016190000000000002, - 0.000278, - 0.000842 - ] - }, - { - "name": "Methylococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.064568, - 0.0451, - 0.045127999999999995, - 0.035147000000000005, - 0.039862, - 0.040719, - 0.032585, - 0.033879, - 0.028664, - 0.040077999999999996, - 0.024088, - 0.012166, - 0.027675, - 0.033016000000000004, - 0.013222999999999999, - 0.025641000000000004, - 0.027696, - 0.018868, - 0.030043, - 0.037393, - 0.03755, - 0.026410000000000003, - 0.038217, - 0.020027, - 0.00758, - 0.030981, - 0.006951000000000001, - 0.012671, - 0.006508, - 0.0073950000000000005, - 0.008204000000000001, - 0.016478, - 0.011886, - 0.014637, - 0.01094, - 0.005952000000000001, - 0.0011949999999999999, - 0.0016190000000000002, - 0.001144, - 0.0009029999999999999 - ] - }, - { - "name": "Nevskiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.056799, - 0.022953, - 0.023592, - 0.025945999999999997, - 0.02364, - 0.029894, - 0.014988, - 0.030302, - 0.060126, - 0.019747999999999998, - 0.016747, - 0.010402, - 0.015763, - 0.016662, - 0.00717, - 0.024308, - 0.033191000000000005, - 0.020714, - 0.071105, - 0.041303, - 0.03168, - 0.032218000000000004, - 0.024168000000000002, - 0.11381500000000001, - 0.004415, - 0.022884, - 0.00329, - 0.008647, - 0.003247, - 0.003478, - 0.004418, - 0.022181, - 0.010806999999999999, - 0.035480000000000005, - 0.010733, - 0.00297, - 0.000515, - 0.000697, - 0.000263, - 0.000495 - ] - }, - { - "name": "Actinomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.05255800000000001, - 0.040218000000000004, - 0.040274000000000004, - 0.035452, - 0.033511, - 0.044375, - 0.030014999999999997, - 0.029477999999999997, - 0.035351, - 0.034283999999999995, - 0.024990000000000002, - 0.01466, - 0.030262, - 0.031617, - 0.020924, - 0.023819999999999997, - 0.023901, - 0.019711000000000003, - 0.029193, - 0.027638999999999997, - 0.028585000000000003, - 0.020561000000000003, - 0.027208, - 0.022411, - 0.014212, - 0.028706, - 0.012129000000000001, - 0.013359000000000001, - 0.010309, - 0.011651, - 0.017177, - 0.014224, - 0.012368, - 0.013748, - 0.008870999999999999, - 0.00511, - 0.002112, - 0.008069, - 0.000891, - 0.001094 - ] - }, - { - "name": "Chlorellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.035039, - 0.038202999999999994, - 0.02963, - 0.020344, - 0.023939, - 0.017634999999999998, - 0.03284, - 0.018382, - 0.019727, - 0.028982, - 0.015068999999999999, - 0.024635, - 0.021598, - 0.020519, - 0.029992, - 0.019527000000000003, - 0.010815, - 0.016406, - 0.018629, - 0.037528, - 0.043881, - 0.013877, - 0.012739, - 0.030007, - 0.029245999999999998, - 0.020734, - 0.02963, - 0.020636, - 0.099182, - 0.044969999999999996, - 0.024766999999999997, - 0.010311, - 0.009293000000000001, - 0.011852, - 0.004384000000000001, - 0.002868, - 0.000721, - 0.003945000000000001, - 0.000562, - 0.000773 - ] - }, - { - "name": "Schizosaccharomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.044314, - 0.047451, - 0.088857, - 0.051546, - 0.064272, - 0.035629, - 0.042608999999999994, - 0.019421, - 0.033913, - 0.028658999999999997, - 0.025286000000000003, - 0.003346, - 0.049995, - 0.043569, - 0.008222, - 0.024682, - 0.024309, - 0.01654, - 0.023393, - 0.021029, - 0.027971, - 0.013419, - 0.017929, - 0.023562, - 0.003679, - 0.017053, - 0.005993, - 0.002337, - 0.002568, - 0.001974, - 0.003244, - 0.027486, - 0.007732999999999999, - 0.009492, - 0.0038280000000000002, - 0.003334, - 0.000165, - 0.000518, - 0.00018, - 0.00066 - ] - }, - { - "name": "Thiotrichales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.047682999999999996, - 0.032381, - 0.037107, - 0.029199, - 0.032757, - 0.032618, - 0.024502, - 0.030470999999999998, - 0.043302999999999994, - 0.032887, - 0.021177, - 0.010888, - 0.020094, - 0.028673, - 0.009665, - 0.032236, - 0.033718, - 0.022772999999999998, - 0.032072, - 0.026273, - 0.027594999999999998, - 0.026307999999999998, - 0.041152999999999995, - 0.019348, - 0.01365, - 0.024624, - 0.008911, - 0.007673999999999999, - 0.007756, - 0.005691, - 0.013463, - 0.016569, - 0.009568, - 0.021480000000000003, - 0.010745999999999999, - 0.004484, - 0.000443, - 0.00161, - 0.000335, - 0.000773 - ] - }, - { - "name": "Oscillatoriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.043838, - 0.037598, - 0.037535, - 0.028051, - 0.034405, - 0.029033999999999997, - 0.032016, - 0.027905000000000003, - 0.025161000000000003, - 0.031704, - 0.020709, - 0.016363, - 0.02599, - 0.026672, - 0.013916999999999999, - 0.026786, - 0.029673, - 0.01786, - 0.025725, - 0.034259, - 0.034315, - 0.02154, - 0.021389, - 0.033094, - 0.010048999999999999, - 0.024538, - 0.009011, - 0.012071, - 0.006975, - 0.009577, - 0.00853, - 0.021484, - 0.009752, - 0.010061, - 0.008031, - 0.00511, - 0.000556, - 0.001309, - 0.00035, - 0.000669 - ] - }, - { - "name": "Sporidiobolales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.011415, - 0.011219, - 0.012166, - 0.011966, - 0.010847, - 0.008531, - 0.007690000000000001, - 0.011377, - 0.011295, - 0.009037, - 0.011016, - 0.16131600000000001, - 0.005354, - 0.011525, - 0.006487000000000001, - 0.008302, - 0.00656, - 0.00611, - 0.010395999999999999, - 0.008823000000000001, - 0.009049, - 0.00591, - 0.008334999999999999, - 0.005336, - 0.007687, - 0.008106, - 0.011514, - 0.070686, - 0.187194, - 0.069035, - 0.018080000000000002, - 0.004045, - 0.004864, - 0.005299, - 0.002936, - 0.001297, - 0.00035, - 0.03766, - 0.000242, - 0.00034700000000000003 - ] - }, - { - "name": "Geodermatophilales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.047682999999999996, - 0.042502, - 0.047036, - 0.036275999999999996, - 0.036268, - 0.032260000000000004, - 0.034526999999999995, - 0.022708000000000002, - 0.02335, - 0.033531, - 0.022090000000000002, - 0.012713, - 0.0296, - 0.03381, - 0.01908, - 0.019057, - 0.017613, - 0.013668000000000001, - 0.022518, - 0.024401, - 0.029212000000000002, - 0.015844, - 0.033657, - 0.013894, - 0.008064, - 0.023726, - 0.006944, - 0.015083000000000001, - 0.007697, - 0.014273, - 0.009036, - 0.012938999999999999, - 0.009109, - 0.009054000000000001, - 0.007914000000000001, - 0.005599, - 0.000793, - 0.001911, - 0.000412, - 0.000643 - ] - }, - { - "name": "Cellvibrionales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.048634, - 0.041852999999999994, - 0.035857, - 0.030175, - 0.029528, - 0.035629, - 0.03182, - 0.024431, - 0.027532, - 0.032582, - 0.020709, - 0.008942, - 0.031044, - 0.027627999999999996, - 0.013049000000000002, - 0.020558, - 0.018434, - 0.013491, - 0.019058000000000002, - 0.025818, - 0.030606, - 0.021896000000000002, - 0.024377, - 0.017211, - 0.006573000000000001, - 0.022808000000000002, - 0.0073230000000000005, - 0.010498, - 0.006114, - 0.008081, - 0.008006000000000001, - 0.013253999999999998, - 0.010027, - 0.009659000000000001, - 0.008496, - 0.0045520000000000005, - 0.000505, - 0.0012519999999999999, - 0.000433, - 0.000669 - ] - }, - { - "name": "Ktedonobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.038012, - 0.033902999999999996, - 0.039707, - 0.057513999999999996, - 0.031623000000000005, - 0.029392, - 0.036233999999999995, - 0.027624, - 0.013666, - 0.052652, - 0.02677, - 0.011009999999999999, - 0.024065, - 0.038771, - 0.009318, - 0.017363, - 0.013715, - 0.011267000000000001, - 0.013947999999999999, - 0.024432, - 0.027567, - 0.016353, - 0.016094, - 0.018823, - 0.0035240000000000002, - 0.022300999999999998, - 0.006208, - 0.007201000000000001, - 0.005676, - 0.0052899999999999996, - 0.00394, - 0.01056, - 0.011106, - 0.006145, - 0.010320000000000001, - 0.004393, - 0.000433, - 0.00047999999999999996, - 0.000118, - 0.000582 - ] - }, - { - "name": "Hymenostomatida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006778, - 0.0036950000000000004, - 0.006326, - 0.008317, - 0.006045, - 0.004229999999999999, - 0.004453, - 0.010947, - 0.032607, - 0.005992, - 0.005308, - 0.020925, - 0.002226, - 0.004298, - 0.055764999999999995, - 0.032911, - 0.025629000000000002, - 0.023756, - 0.036668, - 0.014563999999999999, - 0.007404000000000001, - 0.007204, - 0.003827, - 0.033018, - 0.07595700000000001, - 0.009196, - 0.095111, - 0.027741000000000002, - 0.021487, - 0.029147000000000003, - 0.044772, - 0.015359000000000001, - 0.00475, - 0.016909999999999998, - 0.0027670000000000004, - 0.000512, - 0.00024700000000000004, - 0.013368999999999999, - 0.0008810000000000001, - 0.000278 - ] - }, - { - "name": "Nitrososphaerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.058425, - 0.026961000000000002, - 0.007790000000000001, - 0.024238, - 0.019806999999999998, - 0.035701, - 0.0055130000000000005, - 0.039029, - 0.02339, - 0.017419, - 0.035858, - 0.021776, - 0.006137, - 0.015764, - 0.013938999999999998, - 0.021637, - 0.007348, - 0.009068000000000001, - 0.014234, - 0.052371, - 0.010458, - 0.013806, - 0.039895, - 0.032652, - 0.01546, - 0.060365999999999996, - 0.013081, - 0.007781999999999999, - 0.006209, - 0.009053, - 0.013599000000000002, - 0.008537000000000001, - 0.005576, - 0.016013999999999997, - 0.007745999999999999, - 0.001627, - 0.0006389999999999999, - 0.0020050000000000003, - 0.000149, - 0.000269 - ] - }, - { - "name": "Deinococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.046454, - 0.03883, - 0.046979, - 0.034435, - 0.032889999999999996, - 0.03355, - 0.031879000000000005, - 0.021266, - 0.019034, - 0.027601999999999998, - 0.019613, - 0.009307, - 0.030924, - 0.029071, - 0.015522, - 0.018098, - 0.021306, - 0.012147, - 0.016996, - 0.02405, - 0.027733999999999998, - 0.013409, - 0.026369999999999998, - 0.015883, - 0.006254, - 0.020915, - 0.005593, - 0.010624, - 0.005187, - 0.008204000000000001, - 0.007102, - 0.013966999999999999, - 0.008559, - 0.007325, - 0.006944, - 0.004222, - 0.000505, - 0.0008470000000000001, - 0.000294, - 0.0007030000000000001 - ] - }, - { - "name": "Gallionellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.053708000000000006, - 0.024655, - 0.031101999999999998, - 0.010797, - 0.022407, - 0.025449, - 0.025894999999999998, - 0.022221, - 0.017969, - 0.025122, - 0.009087, - 0.0038929999999999998, - 0.021659, - 0.013969, - 0.0061070000000000004, - 0.030711000000000002, - 0.036925, - 0.017335, - 0.028502999999999997, - 0.045554000000000004, - 0.041566000000000006, - 0.012318, - 0.033814, - 0.023750999999999998, - 0.004211, - 0.026469, - 0.002739, - 0.005862, - 0.0029620000000000002, - 0.002545, - 0.004193, - 0.020871, - 0.007756, - 0.015241999999999999, - 0.007732999999999999, - 0.003744, - 0.000505, - 0.0007160000000000001, - 0.000196, - 0.000443 - ] - }, - { - "name": "Syntrophobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.031155000000000002, - 0.033589999999999995, - 0.043565, - 0.016206, - 0.029255, - 0.018066, - 0.0359, - 0.018672, - 0.016384, - 0.031686, - 0.012409, - 0.006874, - 0.028216, - 0.01996, - 0.0077989999999999995, - 0.020124, - 0.06349400000000001, - 0.015184, - 0.018948, - 0.022498, - 0.021125, - 0.012797, - 0.016723, - 0.020350999999999998, - 0.004511, - 0.016461, - 0.0033829999999999997, - 0.006714, - 0.003057, - 0.003817, - 0.003551, - 0.020415, - 0.005850999999999999, - 0.010326, - 0.006285, - 0.004347, - 0.00040199999999999996, - 0.0008380000000000001, - 0.00023199999999999997, - 0.000877 - ] - }, - { - "name": "Bdellovibrionales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.023624000000000003, - 0.022147, - 0.027467000000000002, - 0.014478, - 0.020544, - 0.016058000000000003, - 0.018852, - 0.019908000000000002, - 0.027386, - 0.018906, - 0.010514, - 0.016363, - 0.014438999999999999, - 0.013012000000000001, - 0.035785000000000004, - 0.027895, - 0.026177999999999996, - 0.019846000000000003, - 0.018334, - 0.024753, - 0.021334, - 0.01618, - 0.012058, - 0.016515000000000002, - 0.024967, - 0.011796, - 0.009426, - 0.020869, - 0.00688, - 0.023025, - 0.026673000000000002, - 0.014862, - 0.005736, - 0.00843, - 0.0039829999999999996, - 0.003107, - 0.000299, - 0.004143, - 0.000196, - 0.000426 - ] - }, - { - "name": "Nitrosopumilales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.06916599999999999, - 0.024073, - 0.013572999999999998, - 0.008378, - 0.018002, - 0.030611000000000003, - 0.009670999999999999, - 0.024478, - 0.069064, - 0.022747999999999997, - 0.00605, - 0.005657, - 0.012574, - 0.005902, - 0.009372, - 0.043028, - 0.005943, - 0.012422, - 0.0125, - 0.023646, - 0.01142, - 0.012543, - 0.036854000000000005, - 0.023019, - 0.0052179999999999995, - 0.036295999999999995, - 0.006966, - 0.008578, - 0.0036119999999999998, - 0.0031309999999999997, - 0.006217, - 0.008297, - 0.009293000000000001, - 0.012012, - 0.004797999999999999, - 0.003152, - 0.0008759999999999999, - 0.001167, - 0.0006799999999999999, - 0.00048600000000000005 - ] - }, - { - "name": "Longamoebia", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.017123, - 0.012383, - 0.010768000000000002, - 0.014752000000000001, - 0.009647, - 0.016130000000000002, - 0.009396999999999999, - 0.009327, - 0.021312, - 0.010479, - 0.010286, - 0.043127, - 0.005475, - 0.009288, - 0.015587, - 0.023482, - 0.011720999999999999, - 0.011292, - 0.023763, - 0.014657, - 0.014571, - 0.0071319999999999995, - 0.011585999999999999, - 0.030427, - 0.03215, - 0.009807999999999999, - 0.063965, - 0.018027, - 0.039756, - 0.015052000000000001, - 0.043543, - 0.013269999999999999, - 0.00374, - 0.007139, - 0.004203, - 0.001206, - 0.000319, - 0.003333, - 0.00010800000000000001, - 0.00020800000000000001 - ] - }, - { - "name": "Bifidobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.019858, - 0.014802000000000001, - 0.021791, - 0.022803999999999998, - 0.018432, - 0.02122, - 0.022796, - 0.029327999999999996, - 0.022231, - 0.016246, - 0.013893, - 0.011314, - 0.013236000000000001, - 0.014556999999999999, - 0.017506999999999998, - 0.029939, - 0.016825, - 0.010851999999999999, - 0.021608000000000002, - 0.016136, - 0.014278, - 0.010678, - 0.011585999999999999, - 0.019537, - 0.01941, - 0.013947, - 0.021190999999999998, - 0.010648999999999999, - 0.012564, - 0.023372, - 0.009876000000000001, - 0.011918999999999999, - 0.008352, - 0.011629, - 0.005574, - 0.004393, - 0.0027300000000000002, - 0.006072999999999999, - 0.005296, - 0.003135 - ] - }, - { - "name": "Ustilaginales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.030639, - 0.037643, - 0.032172000000000006, - 0.033886, - 0.035324, - 0.026381, - 0.016479, - 0.014224, - 0.024482, - 0.024208, - 0.021759, - 0.005657, - 0.015763, - 0.052136, - 0.007669, - 0.014391, - 0.010327, - 0.011487, - 0.013603, - 0.013944, - 0.015478, - 0.008773, - 0.032556, - 0.009284, - 0.005538, - 0.019109, - 0.004999, - 0.005539, - 0.00394, - 0.004526, - 0.005566, - 0.007103, - 0.004314, - 0.006706999999999999, - 0.0034270000000000004, - 0.002731, - 0.00035, - 0.00064, - 0.000227, - 0.000408 - ] - }, - { - "name": "Chthoniobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.018629, - 0.014197, - 0.011245, - 0.017375, - 0.011212, - 0.013763999999999998, - 0.009337999999999999, - 0.017238999999999997, - 0.012694, - 0.011455, - 0.012752, - 0.024818, - 0.008543, - 0.008935, - 0.035416, - 0.014112999999999999, - 0.015097, - 0.012391, - 0.011516, - 0.015081, - 0.014418, - 0.013531, - 0.009489000000000001, - 0.012967, - 0.034871, - 0.010716, - 0.0118, - 0.046501, - 0.018729, - 0.022323, - 0.057476, - 0.009415999999999999, - 0.004383, - 0.005693999999999999, - 0.005393, - 0.001309, - 0.0004940000000000001, - 0.001111, - 0.000144, - 0.000295 - ] - }, - { - "name": "Marinilabiliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.013477000000000001, - 0.012943000000000001, - 0.011984999999999999, - 0.006141, - 0.009315, - 0.009033, - 0.006062, - 0.005815, - 0.015478, - 0.009359000000000001, - 0.0061189999999999994, - 0.101948, - 0.0051140000000000005, - 0.008684, - 0.023441, - 0.019190000000000002, - 0.040827999999999996, - 0.012355, - 0.01958, - 0.007872, - 0.007348, - 0.003933, - 0.007181999999999999, - 0.032817, - 0.039518, - 0.006385, - 0.008282, - 0.005451, - 0.036552999999999995, - 0.0039020000000000005, - 0.039513, - 0.023648, - 0.002088, - 0.004718, - 0.001539, - 0.001286, - 0.000185, - 0.003145, - 0.00010800000000000001, - 0.000174 - ] - }, - { - "name": "Spirochaetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.032780000000000004, - 0.022931, - 0.025525, - 0.018341, - 0.020013999999999997, - 0.023657, - 0.021167, - 0.017427, - 0.016011, - 0.022954, - 0.015297, - 0.008212, - 0.015823, - 0.019091, - 0.011889, - 0.019479, - 0.036993, - 0.012642, - 0.016069999999999997, - 0.021774, - 0.024206000000000002, - 0.01023, - 0.017143000000000002, - 0.02273, - 0.005905, - 0.018105, - 0.005493, - 0.006323, - 0.004633, - 0.005822, - 0.0056560000000000004, - 0.018591999999999997, - 0.005599, - 0.00688, - 0.005638000000000001, - 0.0035280000000000003, - 0.000618, - 0.001431, - 0.00021600000000000002, - 0.000478 - ] - }, - { - "name": "Erysipelotrichales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.014031, - 0.017937, - 0.041434, - 0.02314, - 0.035845999999999996, - 0.012473999999999999, - 0.020128, - 0.013278, - 0.022777000000000002, - 0.015986, - 0.012877000000000001, - 0.004258, - 0.020576, - 0.016486, - 0.006855, - 0.014391, - 0.024592, - 0.010235, - 0.009731, - 0.014263999999999999, - 0.016258, - 0.013194999999999998, - 0.007654, - 0.014602, - 0.00396, - 0.019711000000000003, - 0.003819, - 0.0038909999999999995, - 0.0043479999999999994, - 0.004326, - 0.003858, - 0.013577, - 0.013951, - 0.007645999999999999, - 0.006531, - 0.010697, - 0.005336, - 0.007278, - 0.002926, - 0.006539 - ] - }, - { - "name": "Glomerellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.032225, - 0.023961, - 0.028964, - 0.02192, - 0.02085, - 0.020718, - 0.018303, - 0.016584, - 0.017036000000000003, - 0.019469999999999998, - 0.014931999999999999, - 0.0058390000000000004, - 0.019673, - 0.019665000000000002, - 0.008320000000000001, - 0.011937, - 0.013572999999999998, - 0.010015000000000001, - 0.017138999999999998, - 0.017098, - 0.017248, - 0.012339, - 0.01882, - 0.009739, - 0.005683, - 0.015964, - 0.005721, - 0.005211, - 0.004385, - 0.005907, - 0.007219, - 0.00799, - 0.006448000000000001, - 0.007856, - 0.006026, - 0.002799, - 0.00046399999999999995, - 0.0008, - 0.00035, - 0.000452 - ] - }, - { - "name": "Cantharellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.019145, - 0.01516, - 0.017694, - 0.029799000000000003, - 0.017363999999999997, - 0.017994, - 0.012536, - 0.033374, - 0.013267, - 0.0169, - 0.020275, - 0.010706, - 0.008784, - 0.021005000000000003, - 0.007539, - 0.015590999999999999, - 0.012287000000000001, - 0.015819, - 0.017181000000000002, - 0.013116, - 0.010486, - 0.011544, - 0.011323999999999999, - 0.013552000000000002, - 0.008045, - 0.013593000000000001, - 0.011386, - 0.006222, - 0.011491, - 0.008883, - 0.010816, - 0.007186, - 0.009867, - 0.014969999999999999, - 0.010358, - 0.002003, - 0.000525, - 0.000951, - 0.000258, - 0.000365 - ] - }, - { - "name": "Methylophilales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.040271, - 0.017265, - 0.017793, - 0.012953000000000001, - 0.017372, - 0.028030000000000003, - 0.012496, - 0.020844, - 0.017276, - 0.020724, - 0.009337999999999999, - 0.005414, - 0.011672, - 0.011363, - 0.006259000000000001, - 0.01371, - 0.010798, - 0.011023, - 0.015531, - 0.027939, - 0.021961, - 0.016954, - 0.023853, - 0.010961, - 0.003553, - 0.016432, - 0.003547, - 0.006745999999999999, - 0.003247, - 0.0033079999999999997, - 0.003759, - 0.0076170000000000005, - 0.00927, - 0.008387, - 0.007449, - 0.003312, - 0.00035, - 0.0008, - 0.00021099999999999998, - 0.000252 - ] - }, - { - "name": "Selenomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.01851, - 0.018721, - 0.020713, - 0.013258, - 0.017033, - 0.018424, - 0.019009, - 0.013437000000000001, - 0.010003, - 0.020053, - 0.010320000000000001, - 0.020012000000000002, - 0.014740000000000001, - 0.014381, - 0.01383, - 0.011093, - 0.017709, - 0.008951, - 0.010783, - 0.011978, - 0.013149000000000001, - 0.009068000000000001, - 0.010747, - 0.013965, - 0.007667, - 0.016595, - 0.006594, - 0.014622, - 0.009244, - 0.006229999999999999, - 0.007861, - 0.009225, - 0.005943, - 0.00533, - 0.004345, - 0.002447, - 0.002091, - 0.003785, - 0.0011949999999999999, - 0.000695 - ] - }, - { - "name": "Cyanidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.007016, - 0.005397, - 0.005166, - 0.005754, - 0.005159, - 0.007025, - 0.00512, - 0.0062829999999999995, - 0.006154, - 0.0050869999999999995, - 0.004783, - 0.0441, - 0.002226, - 0.006064, - 0.051079, - 0.009676, - 0.008594, - 0.007393, - 0.011044, - 0.004717, - 0.003932, - 0.002262, - 0.005085, - 0.019247999999999998, - 0.016738, - 0.0054009999999999996, - 0.026125, - 0.033862, - 0.036911, - 0.022739, - 0.036585, - 0.003622, - 0.001423, - 0.0064659999999999995, - 0.0008539999999999999, - 0.00044400000000000006, - 0.000185, - 0.003549, - 0.000149, - 0.000182 - ] - }, - { - "name": "Acidimicrobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.023148, - 0.016325, - 0.016148, - 0.02316, - 0.015309999999999999, - 0.013477000000000001, - 0.013065, - 0.015441, - 0.008578, - 0.016246, - 0.013128, - 0.016424, - 0.013475999999999998, - 0.015161, - 0.01677, - 0.007776999999999999, - 0.0067870000000000005, - 0.006025, - 0.009706000000000001, - 0.013364, - 0.014988999999999999, - 0.014112000000000001, - 0.009174, - 0.007266, - 0.009507, - 0.010783, - 0.007223, - 0.01828, - 0.0070409999999999995, - 0.011613, - 0.009894, - 0.005587, - 0.005850999999999999, - 0.003909, - 0.008199, - 0.002845, - 0.000391, - 0.001328, - 0.000103, - 0.000417 - ] - }, - { - "name": "Holophagales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.01744, - 0.014153, - 0.024505000000000002, - 0.007513, - 0.013489, - 0.009893, - 0.025091, - 0.009991, - 0.009404000000000001, - 0.018046, - 0.005845, - 0.00146, - 0.019733, - 0.007963, - 0.001963, - 0.023928, - 0.03582, - 0.012972, - 0.022299, - 0.014037, - 0.027846, - 0.008528, - 0.009646, - 0.026555000000000002, - 0.000842, - 0.008919, - 0.001008, - 0.0016300000000000002, - 0.00081, - 0.0009789999999999998, - 0.0008759999999999999, - 0.023971, - 0.00475, - 0.004743, - 0.0044740000000000005, - 0.0024690000000000003, - 0.000144, - 0.000122, - 0.00019099999999999998, - 0.000295 - ] - }, - { - "name": "Holosporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.023188, - 0.01469, - 0.011047, - 0.006243, - 0.008992, - 0.012903999999999999, - 0.0070030000000000005, - 0.0060490000000000006, - 0.025521000000000002, - 0.011061, - 0.005639, - 0.049697000000000005, - 0.008002, - 0.008979000000000001, - 0.002419, - 0.011774, - 0.005886, - 0.00468, - 0.006869, - 0.007551, - 0.007502, - 0.0044729999999999995, - 0.014836000000000002, - 0.009337, - 0.023254, - 0.007732999999999999, - 0.002074, - 0.05765599999999999, - 0.013775, - 0.001966, - 0.003822, - 0.0042439999999999995, - 0.0036479999999999998, - 0.00268, - 0.0019920000000000003, - 0.001058, - 8.2e-05, - 0.0012619999999999999, - 0.000134, - 0.000148 - ] - }, - { - "name": "Caldilineales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.012327, - 0.023625, - 0.021856, - 0.010197, - 0.01594, - 0.010251, - 0.021442, - 0.009158, - 0.004489, - 0.023268, - 0.007078, - 0.020925, - 0.019011, - 0.014734, - 0.014980000000000002, - 0.006324000000000001, - 0.01163, - 0.0055969999999999995, - 0.008014, - 0.00963, - 0.013093, - 0.00702, - 0.006501000000000001, - 0.005979, - 0.008345, - 0.009148, - 0.008031, - 0.015115, - 0.004538, - 0.008582, - 0.007436, - 0.007956999999999999, - 0.003993, - 0.002094, - 0.0034270000000000004, - 0.003084, - 0.000227, - 0.0010539999999999998, - 7.7e-05, - 0.000356 - ] - }, - { - "name": "Glomerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005985, - 0.004725, - 0.004516, - 0.013044, - 0.0064670000000000005, - 0.019069, - 0.003747, - 0.017792, - 0.011428, - 0.0053560000000000005, - 0.012797, - 0.009915, - 0.001925, - 0.007978, - 0.026511, - 0.006781999999999999, - 0.006492, - 0.005627, - 0.005463, - 0.006124, - 0.004713, - 0.004453, - 0.004142, - 0.007626000000000001, - 0.012227, - 0.009023999999999999, - 0.015962999999999998, - 0.022713999999999998, - 0.013438999999999998, - 0.067609, - 0.008864, - 0.002545, - 0.006861, - 0.006756, - 0.005069, - 0.00044400000000000006, - 0.0006900000000000001, - 0.002203, - 0.000278, - 0.000182 - ] - }, - { - "name": "Saprolegniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.015419, - 0.011868, - 0.014362999999999999, - 0.012190000000000001, - 0.013041999999999998, - 0.012832, - 0.009259, - 0.010197, - 0.012308, - 0.009923000000000001, - 0.009167, - 0.012226, - 0.007039, - 0.010245, - 0.010001000000000001, - 0.013752, - 0.00907, - 0.011176, - 0.012634999999999999, - 0.011668000000000001, - 0.011267000000000001, - 0.00811, - 0.009803000000000001, - 0.011114, - 0.013572999999999998, - 0.009463, - 0.016485, - 0.006815000000000001, - 0.012199, - 0.006161, - 0.019228, - 0.006920999999999999, - 0.003029, - 0.006336, - 0.002897, - 0.001354, - 0.00024700000000000004, - 0.001732, - 0.00021600000000000002, - 0.000269 - ] - }, - { - "name": "Aeromonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.021363999999999998, - 0.021274, - 0.022506, - 0.013115, - 0.018522999999999998, - 0.018424, - 0.012457, - 0.010947, - 0.016663, - 0.014482, - 0.01379, - 0.004684000000000001, - 0.013175999999999998, - 0.011319, - 0.005413, - 0.010171, - 0.008962000000000001, - 0.005841, - 0.010228000000000001, - 0.011647, - 0.015784, - 0.00807, - 0.013054, - 0.006664, - 0.0033009999999999997, - 0.015438, - 0.002582, - 0.0037329999999999998, - 0.0029690000000000003, - 0.003046, - 0.003786, - 0.006938, - 0.004956, - 0.003996, - 0.0029230000000000003, - 0.002242, - 0.000113, - 0.000697, - 7.7e-05, - 0.000399 - ] - }, - { - "name": "Dacrymycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.018233000000000003, - 0.014511000000000001, - 0.01261, - 0.016481, - 0.011874, - 0.017419999999999998, - 0.011967, - 0.015086000000000002, - 0.008578, - 0.012995, - 0.015606, - 0.0046229999999999995, - 0.011972, - 0.01444, - 0.007462999999999999, - 0.015416, - 0.010849, - 0.019412000000000002, - 0.009984, - 0.011275, - 0.011016, - 0.006592, - 0.01038, - 0.011173, - 0.0054210000000000005, - 0.01323, - 0.00364, - 0.003285, - 0.00394, - 0.004588, - 0.003714, - 0.004012, - 0.006149, - 0.005614, - 0.0076170000000000005, - 0.001377, - 0.000443, - 0.000395, - 0.000258, - 0.00019099999999999998 - ] - }, - { - "name": "Methanosarcinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.019145, - 0.017825, - 0.022218, - 0.016999, - 0.013637999999999999, - 0.01656, - 0.017537999999999998, - 0.01001, - 0.009617, - 0.014348, - 0.010172, - 0.00517, - 0.012754999999999999, - 0.015087, - 0.007094, - 0.009676, - 0.01627, - 0.007448000000000001, - 0.009588, - 0.00962, - 0.011643, - 0.005899000000000001, - 0.009908, - 0.010978, - 0.003669, - 0.012905000000000002, - 0.003168, - 0.00415, - 0.002379, - 0.003046, - 0.003822, - 0.007344, - 0.0041530000000000004, - 0.00441, - 0.003091, - 0.001957, - 0.000165, - 0.000499, - 0.000118, - 0.000226 - ] - }, - { - "name": "Haloferacales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.02069, - 0.021386000000000002, - 0.021503, - 0.015281, - 0.016602000000000002, - 0.014553, - 0.014634999999999999, - 0.009467, - 0.011189, - 0.015333000000000001, - 0.010617, - 0.0050490000000000005, - 0.012454, - 0.015956, - 0.006975, - 0.009013, - 0.009908, - 0.0063549999999999995, - 0.010413, - 0.011616, - 0.01195, - 0.0078049999999999994, - 0.010431999999999999, - 0.007348, - 0.003785, - 0.009511, - 0.003633, - 0.004939, - 0.0031739999999999997, - 0.0034700000000000004, - 0.00525, - 0.007758, - 0.004107, - 0.004007999999999999, - 0.002948, - 0.002139, - 0.000278, - 0.000537, - 0.00021600000000000002, - 0.00045999999999999996 - ] - }, - { - "name": "Hydrogenophilales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.02723, - 0.015562999999999999, - 0.017809000000000002, - 0.012333, - 0.014284, - 0.015843, - 0.014203, - 0.011771, - 0.011401999999999999, - 0.014177, - 0.008025, - 0.004075, - 0.010768999999999999, - 0.010759999999999999, - 0.005185, - 0.010761, - 0.011007, - 0.009342, - 0.013216, - 0.013571000000000001, - 0.013678999999999998, - 0.009058, - 0.013944999999999999, - 0.009225, - 0.002343, - 0.009033, - 0.0019879999999999997, - 0.005615, - 0.0020870000000000003, - 0.002329, - 0.002503, - 0.007236, - 0.004520000000000001, - 0.006701, - 0.004693999999999999, - 0.002515, - 0.000288, - 0.000471, - 9.300000000000001e-05, - 0.000217 - ] - }, - { - "name": "Thermales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.01855, - 0.01825, - 0.021503, - 0.012719, - 0.017331, - 0.012402, - 0.01487, - 0.009598, - 0.010643000000000001, - 0.016219, - 0.008653000000000001, - 0.003832, - 0.012934999999999999, - 0.013983, - 0.006248, - 0.009193999999999999, - 0.012361, - 0.006856, - 0.010177, - 0.010561, - 0.012577, - 0.006827, - 0.00713, - 0.008476000000000001, - 0.002924, - 0.008689, - 0.0028539999999999998, - 0.004472, - 0.0021449999999999998, - 0.0032770000000000004, - 0.003009, - 0.007286, - 0.0037630000000000003, - 0.004305, - 0.0031940000000000002, - 0.002322, - 0.00023700000000000001, - 0.000367, - 0.000165, - 0.000304 - ] - }, - { - "name": "Halobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0153, - 0.018094, - 0.018846, - 0.013654, - 0.01493, - 0.013549, - 0.01438, - 0.008877, - 0.011828, - 0.014195, - 0.009521, - 0.004258, - 0.013356, - 0.014086000000000001, - 0.005521, - 0.007976, - 0.009211, - 0.0060490000000000006, - 0.009655, - 0.009226999999999999, - 0.009607, - 0.005492, - 0.007969, - 0.006546, - 0.0032240000000000003, - 0.00868, - 0.002954, - 0.00372, - 0.00251, - 0.003208, - 0.004292, - 0.006623, - 0.003694, - 0.0036560000000000004, - 0.002729, - 0.002435, - 0.000165, - 0.00049, - 0.000124, - 0.000252 - ] - }, - { - "name": "Pelagomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006302, - 0.007994, - 0.009419, - 0.010401, - 0.006881, - 0.008101, - 0.0038060000000000004, - 0.012773, - 0.0068200000000000005, - 0.008311, - 0.006964, - 0.009489000000000001, - 0.00367, - 0.00627, - 0.019991, - 0.008959, - 0.007523, - 0.007742, - 0.013064, - 0.015102, - 0.00555, - 0.0032909999999999997, - 0.005347, - 0.015736, - 0.008742, - 0.014969, - 0.008539, - 0.004333, - 0.007726, - 0.017195, - 0.012017, - 0.003117, - 0.004107, - 0.007609, - 0.001565, - 0.000683, - 0.000175, - 0.001271, - 0.0005200000000000001, - 0.000174 - ] - }, - { - "name": "Ardenticatenales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.012406, - 0.019169, - 0.022473, - 0.009476, - 0.015791, - 0.007886, - 0.020206000000000002, - 0.008025, - 0.005647999999999999, - 0.018941999999999997, - 0.007203, - 0.002616, - 0.014559, - 0.013645, - 0.003797, - 0.0066560000000000005, - 0.013647, - 0.0072959999999999995, - 0.008569, - 0.009992000000000001, - 0.012898, - 0.00645, - 0.005295, - 0.006640000000000001, - 0.001442, - 0.008211, - 0.0016309999999999999, - 0.0032090000000000005, - 0.001394, - 0.001912, - 0.001373, - 0.008362999999999999, - 0.0037630000000000003, - 0.002989, - 0.0038020000000000003, - 0.002913, - 0.000124, - 0.000207, - 8.2e-05, - 0.00038199999999999996 - ] - }, - { - "name": "Bangiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.014309, - 0.018362, - 0.024555, - 0.011529000000000001, - 0.019252000000000002, - 0.008961, - 0.017656, - 0.00663, - 0.007006, - 0.015009999999999999, - 0.008939, - 0.005475, - 0.016784999999999998, - 0.015985, - 0.005065999999999999, - 0.005203, - 0.004220000000000001, - 0.003966, - 0.006044, - 0.008337, - 0.009481999999999999, - 0.005033, - 0.007497, - 0.0051649999999999995, - 0.005044, - 0.006558, - 0.006336, - 0.0029690000000000003, - 0.004531, - 0.002845, - 0.00543, - 0.0035060000000000004, - 0.0026850000000000003, - 0.002291, - 0.002147, - 0.001639, - 0.000155, - 0.00064, - 9.8e-05, - 0.000226 - ] - }, - { - "name": "Choanoflagellida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.011812000000000001, - 0.008465, - 0.007593000000000001, - 0.006781000000000001, - 0.00621, - 0.010323, - 0.004787, - 0.0055899999999999995, - 0.011562000000000001, - 0.005508, - 0.00484, - 0.011801, - 0.005836, - 0.00577, - 0.012126999999999999, - 0.012636, - 0.005994, - 0.006788, - 0.008578, - 0.007386, - 0.0063030000000000004, - 0.004422, - 0.006239, - 0.01197, - 0.014376, - 0.004693999999999999, - 0.022378, - 0.008167, - 0.012877000000000001, - 0.007225, - 0.013825, - 0.006490000000000001, - 0.0014, - 0.003786, - 0.001526, - 0.000819, - 0.000196, - 0.001243, - 7.2e-05, - 0.00020800000000000001 - ] - }, - { - "name": "Candidatus Brocadiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.015775, - 0.012831, - 0.015794, - 0.008173999999999999, - 0.01305, - 0.009821, - 0.009573, - 0.009579, - 0.012055, - 0.012028, - 0.00685, - 0.0032240000000000003, - 0.010709, - 0.01023, - 0.00282, - 0.010339, - 0.014469, - 0.007998, - 0.009647, - 0.009082, - 0.008436, - 0.008131000000000001, - 0.012320000000000001, - 0.006764, - 0.0034560000000000003, - 0.007427, - 0.002975, - 0.002539, - 0.0026190000000000002, - 0.00148, - 0.004093, - 0.007833, - 0.002845, - 0.006386, - 0.003117, - 0.001696, - 0.00024700000000000004, - 0.000697, - 0.000489, - 0.000295 - ] - }, - { - "name": "Russulales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.009434, - 0.009405, - 0.010102, - 0.008845, - 0.0069310000000000005, - 0.009104000000000001, - 0.005983, - 0.008053, - 0.005940999999999999, - 0.007809999999999999, - 0.007614, - 0.088322, - 0.005715, - 0.008567, - 0.006074, - 0.007005, - 0.005082, - 0.005267, - 0.00633, - 0.005741, - 0.005661, - 0.003536, - 0.006658, - 0.0052829999999999995, - 0.002759, - 0.007227, - 0.002203, - 0.00288, - 0.002517, - 0.004272, - 0.002747, - 0.003382, - 0.002042, - 0.00394, - 0.002961, - 0.0009220000000000001, - 0.00023700000000000001, - 0.000471, - 0.000175, - 0.000226 - ] - }, - { - "name": "Natrialbales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.014943000000000001, - 0.011868, - 0.014486, - 0.010482, - 0.010905, - 0.014338, - 0.011319, - 0.008520999999999999, - 0.008112000000000001, - 0.010389, - 0.007238, - 0.011436, - 0.009205, - 0.009906, - 0.006519, - 0.009061, - 0.0076760000000000005, - 0.004821, - 0.007079, - 0.008379000000000001, - 0.009426, - 0.004911, - 0.007969, - 0.00566, - 0.004627, - 0.007829000000000001, - 0.0031899999999999997, - 0.006581999999999999, - 0.003006, - 0.005035, - 0.009189, - 0.004799, - 0.002983, - 0.0033539999999999998, - 0.0023539999999999998, - 0.001559, - 0.000443, - 0.000668, - 0.00044800000000000005, - 0.000504 - ] - }, - { - "name": "Chroococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.014903, - 0.011106999999999999, - 0.010653, - 0.0122, - 0.01035, - 0.009176, - 0.008768999999999999, - 0.011640000000000001, - 0.009777, - 0.010908, - 0.006758, - 0.0059, - 0.006137, - 0.007934, - 0.004588, - 0.01345, - 0.012242, - 0.006470999999999999, - 0.009251, - 0.010561, - 0.009537, - 0.008284, - 0.007811, - 0.009674, - 0.00335, - 0.010534, - 0.002796, - 0.003619, - 0.002597, - 0.0035009999999999998, - 0.002964, - 0.0070290000000000005, - 0.003511, - 0.005145, - 0.0038020000000000003, - 0.001354, - 0.000525, - 0.0008849999999999999, - 0.0006230000000000001, - 0.000339 - ] - }, - { - "name": "Aquificales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.010345, - 0.01095, - 0.012997, - 0.00851, - 0.010367, - 0.013477000000000001, - 0.010417000000000001, - 0.011845999999999999, - 0.00662, - 0.012449, - 0.006222, - 0.002372, - 0.010468, - 0.007301, - 0.003124, - 0.006372, - 0.012843, - 0.010247, - 0.009082999999999999, - 0.007272, - 0.008059, - 0.006246, - 0.007864, - 0.015116, - 0.003582, - 0.013019, - 0.002954, - 0.002084, - 0.002991, - 0.0018510000000000002, - 0.003135, - 0.003423, - 0.0053, - 0.005849, - 0.002561, - 0.001696, - 0.002421, - 0.003098, - 0.002143, - 0.001198 - ] - }, - { - "name": "Thermotogales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006619, - 0.007098999999999999, - 0.014625999999999998, - 0.005968, - 0.00963, - 0.008029000000000001, - 0.008102, - 0.010712000000000001, - 0.0043289999999999995, - 0.010298999999999999, - 0.00685, - 0.005414, - 0.008002, - 0.005667, - 0.002636, - 0.00451, - 0.013969999999999998, - 0.014891, - 0.014403000000000001, - 0.004779, - 0.005257, - 0.0037090000000000005, - 0.00367, - 0.032438999999999996, - 0.006331, - 0.010008, - 0.0041340000000000005, - 0.00216, - 0.005472, - 0.001396, - 0.004988, - 0.003208, - 0.005622, - 0.006479, - 0.0035689999999999997, - 0.001309, - 0.0015140000000000002, - 0.00225, - 0.001391, - 0.001129 - ] - }, - { - "name": "Suessiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.012208, - 0.012988, - 0.013753999999999999, - 0.011489, - 0.010681999999999999, - 0.010537999999999999, - 0.009926, - 0.0076879999999999995, - 0.009604000000000001, - 0.009134999999999999, - 0.0076939999999999995, - 0.006083, - 0.009987000000000001, - 0.010024, - 0.00627, - 0.008235, - 0.006968000000000001, - 0.004833, - 0.007517, - 0.008947, - 0.009551, - 0.005186, - 0.006815000000000001, - 0.007201000000000001, - 0.005944, - 0.00758, - 0.006837, - 0.003853, - 0.005063000000000001, - 0.003339, - 0.005647, - 0.005089, - 0.002432, - 0.002853, - 0.002134, - 0.001286, - 0.000288, - 0.0015630000000000002, - 0.000144, - 0.00020800000000000001 - ] - }, - { - "name": "Peniculida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001387, - 0.001187, - 0.001185, - 0.001098, - 0.001143, - 0.001362, - 0.000549, - 0.001995, - 0.014985, - 0.000985, - 0.0011300000000000001, - 0.0077859999999999995, - 0.000241, - 0.001119, - 0.022757, - 0.011437000000000001, - 0.007755, - 0.0072959999999999995, - 0.011911, - 0.004872, - 0.001255, - 0.00109, - 0.001206, - 0.010235, - 0.036855, - 0.001338, - 0.040779, - 0.013226, - 0.008251999999999999, - 0.013262999999999999, - 0.017728, - 0.007369, - 0.00062, - 0.002186, - 0.000168, - 0.00022799999999999999, - 2.1e-05, - 0.006468000000000001, - 7.7e-05, - 9.6e-05 - ] - }, - { - "name": "Sphaerobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.010543, - 0.011936, - 0.010973, - 0.009089, - 0.010508, - 0.006094, - 0.010043999999999999, - 0.006414, - 0.004515, - 0.009601, - 0.0056170000000000005, - 0.010218999999999999, - 0.008483, - 0.00892, - 0.009491, - 0.004564, - 0.004832, - 0.003611, - 0.0058, - 0.005896, - 0.008798, - 0.004982, - 0.007077, - 0.003901, - 0.005034, - 0.005783, - 0.004312, - 0.008381999999999999, - 0.004232, - 0.006931999999999999, - 0.003732, - 0.0037049999999999995, - 0.002203, - 0.002822, - 0.002548, - 0.001855, - 0.000278, - 0.001007, - 0.00034500000000000004, - 0.000399 - ] - }, - { - "name": "Chthonomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.012643999999999999, - 0.008375, - 0.009401999999999999, - 0.009618000000000002, - 0.009340000000000001, - 0.011327, - 0.007514, - 0.008015999999999999, - 0.006913, - 0.008329000000000001, - 0.008277, - 0.0063869999999999994, - 0.005234, - 0.007859999999999999, - 0.005239, - 0.007384999999999999, - 0.006288, - 0.004638000000000001, - 0.005084, - 0.007075, - 0.0063030000000000004, - 0.00647, - 0.009122, - 0.005342, - 0.0039109999999999995, - 0.0058119999999999995, - 0.004906000000000001, - 0.004175, - 0.004064, - 0.002236, - 0.004111, - 0.0036299999999999995, - 0.001675, - 0.004014, - 0.002379, - 0.001036, - 0.00024700000000000004, - 0.000414, - 7.7e-05, - 0.000139 - ] - }, - { - "name": "Ophiostomatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.014547, - 0.012787, - 0.011944, - 0.009679, - 0.009556, - 0.009104000000000001, - 0.010456, - 0.006227, - 0.008924, - 0.008965, - 0.006233, - 0.002372, - 0.008662999999999999, - 0.0092, - 0.0037530000000000003, - 0.006957, - 0.0061070000000000004, - 0.0033, - 0.006398, - 0.008482, - 0.0076549999999999995, - 0.0037700000000000003, - 0.006343, - 0.005306, - 0.002072, - 0.007848, - 0.0019100000000000002, - 0.002255, - 0.00162, - 0.002059, - 0.002358, - 0.004468, - 0.002455, - 0.002606, - 0.0016809999999999998, - 0.001639, - 0.000155, - 0.000245, - 8.2e-05, - 0.00024300000000000002 - ] - }, - { - "name": "Methanomicrobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0109, - 0.008017, - 0.009501, - 0.0065980000000000006, - 0.007982, - 0.005807, - 0.005826, - 0.008634000000000001, - 0.005501, - 0.007872, - 0.005377000000000001, - 0.003589, - 0.006919, - 0.006845, - 0.00307, - 0.005764, - 0.013296, - 0.00922, - 0.008401, - 0.0052439999999999995, - 0.005103, - 0.003393, - 0.005714, - 0.018864, - 0.003514, - 0.006701, - 0.0019379999999999998, - 0.002804, - 0.002794, - 0.0014730000000000001, - 0.0035689999999999997, - 0.0036799999999999997, - 0.00195, - 0.004366, - 0.001668, - 0.001058, - 0.00021600000000000002, - 0.00032, - 0.00043799999999999997, - 0.000165 - ] - }, - { - "name": "Veillonellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.008641, - 0.00795, - 0.009172, - 0.0077269999999999995, - 0.008752, - 0.007025, - 0.007788, - 0.005497, - 0.005102000000000001, - 0.0072629999999999995, - 0.005982, - 0.0046229999999999995, - 0.005776, - 0.008832, - 0.003699, - 0.0051, - 0.006311, - 0.0033, - 0.005362, - 0.005037, - 0.004546, - 0.003148, - 0.005557, - 0.0044859999999999995, - 0.003282, - 0.006634, - 0.002682, - 0.002457, - 0.003137, - 0.002128, - 0.002982, - 0.004675, - 0.005804999999999999, - 0.002588, - 0.0033490000000000004, - 0.004256, - 0.004903, - 0.005188, - 0.005909, - 0.005158 - ] - }, - { - "name": "Chlorobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.01086, - 0.00954, - 0.009962, - 0.0064150000000000006, - 0.007916, - 0.007025, - 0.007514, - 0.006527, - 0.007459, - 0.009126, - 0.004327, - 0.002798, - 0.006137, - 0.006064, - 0.0032649999999999997, - 0.009640000000000001, - 0.014253, - 0.005444, - 0.006809999999999999, - 0.007561, - 0.006651000000000001, - 0.004921, - 0.006448000000000001, - 0.007065000000000001, - 0.0024010000000000004, - 0.004818, - 0.0020670000000000003, - 0.002571, - 0.001598, - 0.00175, - 0.002259, - 0.0070209999999999995, - 0.002891, - 0.002798, - 0.0022760000000000002, - 0.0014, - 0.000175, - 0.00035800000000000003, - 0.000129, - 0.000174 - ] - }, - { - "name": "Blastocladiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.010742, - 0.009068999999999999, - 0.008440000000000001, - 0.007381, - 0.006856, - 0.006954000000000001, - 0.006592, - 0.004635, - 0.007139, - 0.006931999999999999, - 0.005388, - 0.007359999999999999, - 0.006076, - 0.007213, - 0.005521, - 0.006215999999999999, - 0.0046229999999999995, - 0.003636, - 0.005371, - 0.006082, - 0.006414, - 0.0036369999999999996, - 0.0054, - 0.005241, - 0.006302, - 0.004913, - 0.009576000000000001, - 0.003164, - 0.006690000000000001, - 0.0032770000000000004, - 0.007319, - 0.003498, - 0.001629, - 0.002211, - 0.0017460000000000002, - 0.0010810000000000001, - 0.000124, - 0.000791, - 7.2e-05, - 0.0002 - ] - }, - { - "name": "Saprospirales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.010820999999999999, - 0.006964, - 0.007436, - 0.0060090000000000005, - 0.0064010000000000004, - 0.006667, - 0.004335, - 0.005899000000000001, - 0.008551000000000001, - 0.006421, - 0.005365999999999999, - 0.008881, - 0.004753, - 0.005034, - 0.0036009999999999996, - 0.00703, - 0.0075120000000000004, - 0.003904, - 0.005817, - 0.0069819999999999995, - 0.006233, - 0.004656, - 0.006186, - 0.006197, - 0.007821999999999999, - 0.005305, - 0.004098, - 0.003297, - 0.003334, - 0.001905, - 0.00628, - 0.004857, - 0.0022719999999999997, - 0.002989, - 0.001164, - 0.001001, - 8.2e-05, - 0.000734, - 4.1e-05, - 0.000174 - ] - }, - { - "name": "Nakamurellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.007412, - 0.00627, - 0.008465, - 0.010269, - 0.007436, - 0.00595, - 0.0052770000000000004, - 0.005019, - 0.005275, - 0.00566, - 0.005365999999999999, - 0.009732, - 0.005475, - 0.006226, - 0.008287000000000001, - 0.005239, - 0.0034219999999999997, - 0.006097999999999999, - 0.0077280000000000005, - 0.003507, - 0.009412, - 0.006633, - 0.004037, - 0.0033759999999999997, - 0.003214, - 0.0036710000000000002, - 0.001795, - 0.012228, - 0.0034289999999999998, - 0.004989, - 0.003054, - 0.0023539999999999998, - 0.001537, - 0.00147, - 0.003013, - 0.000819, - 0.000103, - 0.000687, - 4.6e-05, - 0.000174 - ] - }, - { - "name": "Gaiellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.007333, - 0.008284999999999999, - 0.007148000000000001, - 0.013654, - 0.006111, - 0.005233, - 0.007141, - 0.0055899999999999995, - 0.002264, - 0.007442, - 0.00774, - 0.006995, - 0.006737999999999999, - 0.007918999999999999, - 0.008602, - 0.002068, - 0.001592, - 0.001436, - 0.002769, - 0.006940999999999999, - 0.010081, - 0.004982, - 0.002621, - 0.002367, - 0.003776, - 0.005076, - 0.0046630000000000005, - 0.007087, - 0.004596, - 0.006469, - 0.0034700000000000004, - 0.0016, - 0.002455, - 0.0008460000000000001, - 0.004992, - 0.001286, - 0.000196, - 0.000593, - 2.1e-05, - 0.000148 - ] - }, - { - "name": "Bacteroidetes Order II. Incertae sedis", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.008006999999999998, - 0.011622, - 0.01178, - 0.005582, - 0.00857, - 0.0061649999999999995, - 0.008436, - 0.004991, - 0.006154, - 0.009028, - 0.003824, - 0.00292, - 0.0063170000000000006, - 0.006431999999999999, - 0.003471, - 0.005999, - 0.009512, - 0.0050409999999999995, - 0.006776000000000001, - 0.0053170000000000005, - 0.0063030000000000004, - 0.0035659999999999997, - 0.005033, - 0.0051530000000000005, - 0.002275, - 0.00411, - 0.0016809999999999998, - 0.002564, - 0.0014449999999999999, - 0.002074, - 0.002313, - 0.00615, - 0.001698, - 0.003193, - 0.0017460000000000002, - 0.001468, - 0.00033, - 0.000471, - 0.000185, - 0.000261 - ] - }, - { - "name": "Parachlamydiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.011178, - 0.008284999999999999, - 0.006523, - 0.008449, - 0.006012, - 0.0119, - 0.005414, - 0.006817, - 0.006687, - 0.007102, - 0.006336, - 0.003771, - 0.004211, - 0.00605, - 0.002245, - 0.00592, - 0.004072999999999999, - 0.002921, - 0.004605, - 0.008565000000000001, - 0.006776999999999999, - 0.0053289999999999995, - 0.007181999999999999, - 0.006162, - 0.003572, - 0.006940000000000001, - 0.002775, - 0.001964, - 0.001145, - 0.001843, - 0.001825, - 0.002951, - 0.00335, - 0.0025440000000000003, - 0.002069, - 0.000808, - 0.000278, - 0.00032, - 0.000149, - 0.000113 - ] - }, - { - "name": "Tissierellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006619, - 0.005374, - 0.0048119999999999994, - 0.004036, - 0.004033, - 0.007742, - 0.006552, - 0.0034549999999999997, - 0.003343, - 0.005499, - 0.0034020000000000005, - 0.005535, - 0.005475, - 0.0034439999999999996, - 0.003699, - 0.0037619999999999997, - 0.005257, - 0.003483, - 0.003889, - 0.004024, - 0.003486, - 0.002262, - 0.005033, - 0.004326, - 0.0027300000000000002, - 0.004636, - 0.0032329999999999998, - 0.002804, - 0.002386, - 0.0027370000000000003, - 0.002566, - 0.0074930000000000005, - 0.006998000000000001, - 0.001847, - 0.001772, - 0.007807, - 0.008457, - 0.007287, - 0.004956, - 0.007476999999999999 - ] - }, - { - "name": "Eustigmatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004638000000000001, - 0.003493, - 0.005676, - 0.0035789999999999997, - 0.003925, - 0.004158, - 0.006219, - 0.004991, - 0.004954999999999999, - 0.004065999999999999, - 0.0026829999999999996, - 0.006691, - 0.002948, - 0.0029289999999999997, - 0.004415, - 0.007916, - 0.0058119999999999995, - 0.0071730000000000006, - 0.005741, - 0.0057929999999999995, - 0.003193, - 0.002384, - 0.002516, - 0.022022, - 0.0063219999999999995, - 0.0039380000000000005, - 0.005872, - 0.003367, - 0.005778, - 0.004064, - 0.007174, - 0.001948, - 0.0010550000000000002, - 0.004965, - 0.00066, - 0.000398, - 0.00023700000000000001, - 0.001139, - 0.001097, - 6.9e-05 - ] - }, - { - "name": "Fimbriimonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.008522, - 0.004971, - 0.005569, - 0.007402, - 0.005531, - 0.006595, - 0.00361, - 0.005534000000000001, - 0.005581, - 0.006484, - 0.004795000000000001, - 0.004684000000000001, - 0.003008, - 0.005063000000000001, - 0.0038829999999999997, - 0.009254, - 0.01214, - 0.002872, - 0.003855, - 0.0056890000000000005, - 0.004936, - 0.0044729999999999995, - 0.004823, - 0.007306999999999999, - 0.003805, - 0.004043, - 0.003547, - 0.003423, - 0.00251, - 0.001997, - 0.0039310000000000005, - 0.007137, - 0.001583, - 0.00231, - 0.001953, - 0.000785, - 9.300000000000001e-05, - 0.000433, - 4.1e-05, - 0.00010400000000000001 - ] - }, - { - "name": "Entomophthorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.017995, - 0.005979, - 0.006285, - 0.00916, - 0.005175, - 0.003728, - 0.0053950000000000005, - 0.007388, - 0.003144, - 0.003779, - 0.006187, - 0.01028, - 0.006919, - 0.0070209999999999995, - 0.008504000000000001, - 0.004226, - 0.002357, - 0.002707, - 0.004764, - 0.002286, - 0.003054, - 0.0033520000000000004, - 0.001363, - 0.002739, - 0.0030399999999999997, - 0.003699, - 0.004034, - 0.0038090000000000003, - 0.004261, - 0.005459, - 0.003542, - 0.002644, - 0.002111, - 0.002378, - 0.00119, - 0.000296, - 9.300000000000001e-05, - 0.000621, - 8.2e-05, - 0.00010400000000000001 - ] - }, - { - "name": "Synergistales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.008284, - 0.007614, - 0.008958, - 0.005175, - 0.0074849999999999995, - 0.005878, - 0.007494, - 0.004915999999999999, - 0.004635, - 0.008275, - 0.003915999999999999, - 0.003102, - 0.005234, - 0.006624, - 0.003493, - 0.004793, - 0.009047, - 0.0035810000000000004, - 0.005, - 0.006248, - 0.006065999999999999, - 0.0035759999999999998, - 0.004771, - 0.005407, - 0.0019649999999999997, - 0.004674, - 0.0017879999999999999, - 0.0029059999999999997, - 0.0019039999999999999, - 0.0016190000000000002, - 0.002774, - 0.005305, - 0.002111, - 0.002316, - 0.0018620000000000002, - 0.001127, - 8.2e-05, - 0.00033, - 8.2e-05, - 0.000122 - ] - }, - { - "name": "Catenulisporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.010820999999999999, - 0.0070090000000000005, - 0.00705, - 0.008723, - 0.006359, - 0.006954000000000001, - 0.0060030000000000005, - 0.005141, - 0.005368, - 0.005992, - 0.005034, - 0.002616, - 0.005054, - 0.006609, - 0.003915999999999999, - 0.005547, - 0.004107, - 0.0034159999999999998, - 0.004672, - 0.005555, - 0.007069, - 0.003587, - 0.006553, - 0.0038420000000000004, - 0.001917, - 0.004531, - 0.001516, - 0.003682, - 0.001342, - 0.002606, - 0.001997, - 0.002545, - 0.002226, - 0.002841, - 0.002897, - 0.0008990000000000001, - 0.000165, - 0.000254, - 5.6999999999999996e-05, - 0.00013000000000000002 - ] - }, - { - "name": "Thermogemmatisporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.007135, - 0.007815, - 0.009312, - 0.011895000000000001, - 0.0073030000000000005, - 0.006739, - 0.00716, - 0.005497, - 0.00297, - 0.0151, - 0.005776, - 0.001703, - 0.005776, - 0.009052, - 0.002983, - 0.003617, - 0.0034270000000000004, - 0.0021449999999999998, - 0.0027530000000000002, - 0.005658, - 0.006149, - 0.0030670000000000003, - 0.003512, - 0.0034939999999999997, - 0.000958, - 0.00498, - 0.001452, - 0.001819, - 0.001291, - 0.0011330000000000001, - 0.000958, - 0.002188, - 0.001836, - 0.001254, - 0.001823, - 0.0011949999999999999, - 0.000113, - 0.000122, - 4.6e-05, - 0.000122 - ] - }, - { - "name": "Thermococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0065, - 0.008756, - 0.008654, - 0.005012, - 0.0055060000000000005, - 0.005878, - 0.005493, - 0.005871, - 0.003556, - 0.007389, - 0.003436, - 0.003406, - 0.005595, - 0.005638000000000001, - 0.0048270000000000006, - 0.003147, - 0.006481000000000001, - 0.00366, - 0.00511, - 0.004769, - 0.003751, - 0.002323, - 0.0039840000000000006, - 0.006599, - 0.003776, - 0.007628, - 0.002303, - 0.00199, - 0.001831, - 0.002375, - 0.0036049999999999997, - 0.0021219999999999998, - 0.003144, - 0.0020629999999999997, - 0.001254, - 0.0007059999999999999, - 0.00033, - 0.0005269999999999999, - 0.000252, - 0.00013000000000000002 - ] - }, - { - "name": "Acidiferrobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.010068, - 0.008084000000000001, - 0.009221, - 0.005632, - 0.007022, - 0.005305, - 0.0082, - 0.005965, - 0.0060609999999999995, - 0.006654, - 0.00379, - 0.000791, - 0.004452, - 0.005005, - 0.0019850000000000002, - 0.004582, - 0.005184, - 0.004338, - 0.006263, - 0.006299, - 0.006651000000000001, - 0.004055, - 0.005452, - 0.004096, - 0.000833, - 0.004665, - 0.000729, - 0.001573, - 0.000606, - 0.001026, - 0.0006320000000000001, - 0.003175, - 0.00218, - 0.00323, - 0.002341, - 0.0009220000000000001, - 7.2e-05, - 0.00014099999999999998, - 5.6999999999999996e-05, - 0.000165 - ] - }, - { - "name": "Corticiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.009235, - 0.00571, - 0.004598, - 0.013705000000000002, - 0.005838, - 0.010251, - 0.0021379999999999997, - 0.011340000000000001, - 0.0036630000000000005, - 0.004783, - 0.004407, - 0.0016420000000000002, - 0.003489, - 0.005652, - 0.0010630000000000001, - 0.002834, - 0.003019, - 0.004894, - 0.0063549999999999995, - 0.002814, - 0.0052710000000000005, - 0.005828, - 0.0059240000000000004, - 0.003246, - 0.0011710000000000002, - 0.004684000000000001, - 0.001738, - 0.000935, - 0.0009339999999999999, - 0.001056, - 0.001066, - 0.00131, - 0.0036710000000000002, - 0.007145, - 0.004164, - 0.0005690000000000001, - 0.000206, - 0.000151, - 9.8e-05, - 8.7e-05 - ] - }, - { - "name": "Philasterida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000991, - 0.000582, - 0.000469, - 0.0006, - 0.000646, - 0.000789, - 0.000392, - 0.0009460000000000001, - 0.013959000000000001, - 0.000466, - 0.000571, - 0.005292, - 0.000301, - 0.000471, - 0.011889, - 0.010418, - 0.006215, - 0.00512, - 0.005876, - 0.002607, - 0.000683, - 0.000642, - 0.000524, - 0.004456, - 0.018355, - 0.000583, - 0.025389, - 0.007087, - 0.004706, - 0.006169, - 0.009795, - 0.0036799999999999997, - 0.0005740000000000001, - 0.001371, - 0.00011599999999999999, - 0.00011399999999999999, - 5.2000000000000004e-05, - 0.0035020000000000003, - 4.1e-05, - 8.7e-05 - ] - }, - { - "name": "Jiangellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.008284, - 0.007390000000000001, - 0.009238, - 0.007585, - 0.007476999999999999, - 0.006954000000000001, - 0.00618, - 0.004261, - 0.004649, - 0.0061259999999999995, - 0.004783, - 0.0027370000000000003, - 0.004933, - 0.006756, - 0.0033729999999999997, - 0.003708, - 0.0039369999999999995, - 0.002786, - 0.005076, - 0.005079, - 0.006149, - 0.003311, - 0.004142, - 0.003052, - 0.00151, - 0.003785, - 0.0016309999999999999, - 0.003543, - 0.0013570000000000001, - 0.002745, - 0.001861, - 0.002744, - 0.002318, - 0.0015689999999999999, - 0.0025989999999999997, - 0.000956, - 6.2e-05, - 0.00028199999999999997, - 6.2e-05, - 0.000139 - ] - }, - { - "name": "Heterotrichida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002457, - 0.001859, - 0.001538, - 0.001505, - 0.001449, - 0.001936, - 0.0008039999999999999, - 0.0016760000000000002, - 0.006687, - 0.0012720000000000001, - 0.00121, - 0.007908, - 0.001023, - 0.001178, - 0.010131, - 0.006903, - 0.002617, - 0.003691, - 0.004967, - 0.003827, - 0.001841, - 0.00108, - 0.001153, - 0.0048579999999999995, - 0.017251, - 0.001118, - 0.017221, - 0.005609, - 0.006683, - 0.005151, - 0.009289, - 0.004111, - 0.000459, - 0.0016179999999999999, - 0.000272, - 0.00025, - 9.300000000000001e-05, - 0.002768, - 3.6e-05, - 4.3e-05 - ] - }, - { - "name": "Acidithiobacillales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.008879000000000001, - 0.006225, - 0.008695, - 0.0051649999999999995, - 0.006343, - 0.0062369999999999995, - 0.0060810000000000005, - 0.005525, - 0.004942, - 0.005606, - 0.0036299999999999995, - 0.001338, - 0.004452, - 0.005314, - 0.0020829999999999998, - 0.004383, - 0.005263, - 0.003336, - 0.005278, - 0.0061649999999999995, - 0.00594, - 0.0039020000000000005, - 0.00367, - 0.0037240000000000003, - 0.0010550000000000002, - 0.003871, - 0.001016, - 0.0018510000000000002, - 0.000883, - 0.001265, - 0.002114, - 0.0032329999999999998, - 0.001813, - 0.0024519999999999998, - 0.001526, - 0.0009220000000000001, - 4.1e-05, - 0.000273, - 4.6e-05, - 0.00010400000000000001 - ] - }, - { - "name": "Herpetosiphonales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0057079999999999995, - 0.01001, - 0.008489, - 0.006436, - 0.006956, - 0.003728, - 0.006572, - 0.004654, - 0.002784, - 0.007012999999999999, - 0.00395, - 0.003102, - 0.005776, - 0.007712999999999999, - 0.003005, - 0.003304, - 0.004453, - 0.0022489999999999997, - 0.0033840000000000003, - 0.004779, - 0.005619, - 0.003841, - 0.0026739999999999997, - 0.003105, - 0.001384, - 0.00434, - 0.001209, - 0.0026969999999999997, - 0.0018170000000000003, - 0.001912, - 0.001482, - 0.003009, - 0.002042, - 0.001359, - 0.001604, - 0.000956, - 8.2e-05, - 0.000198, - 4.1e-05, - 0.000139 - ] - }, - { - "name": "Hymenochaetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006144, - 0.004703, - 0.0051329999999999995, - 0.008754000000000001, - 0.005432, - 0.008316, - 0.003786, - 0.009036, - 0.003636, - 0.0044329999999999994, - 0.004715, - 0.0021899999999999997, - 0.003489, - 0.007345, - 0.0023539999999999998, - 0.0035810000000000004, - 0.002963, - 0.006428, - 0.003628, - 0.004520000000000001, - 0.005187, - 0.002822, - 0.004351, - 0.003175, - 0.002314, - 0.004177, - 0.0022530000000000002, - 0.001668, - 0.001663, - 0.001241, - 0.003054, - 0.002288, - 0.0019039999999999999, - 0.002612, - 0.002431, - 0.000535, - 0.000175, - 0.000226, - 0.000103, - 8.7e-05 - ] - }, - { - "name": "Halanaerobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004717, - 0.004277, - 0.004804, - 0.003975, - 0.0039, - 0.0032979999999999997, - 0.0043159999999999995, - 0.003146, - 0.003117, - 0.004326, - 0.0029219999999999997, - 0.0038929999999999998, - 0.003971, - 0.003179, - 0.014091, - 0.003672, - 0.006587999999999999, - 0.00209, - 0.0027949999999999997, - 0.0038689999999999996, - 0.004058, - 0.001987, - 0.002149, - 0.003128, - 0.005092, - 0.0027429999999999998, - 0.002796, - 0.009835, - 0.0030789999999999997, - 0.004379999999999999, - 0.0077069999999999994, - 0.0030670000000000003, - 0.0013310000000000002, - 0.001217, - 0.0011769999999999999, - 0.00058, - 0.000103, - 0.000499, - 2.6000000000000002e-05, - 0.000113 - ] - }, - { - "name": "Thermodesulfobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006976, - 0.005598, - 0.007996, - 0.00728, - 0.005291, - 0.007956999999999999, - 0.005179, - 0.004072999999999999, - 0.004169, - 0.005186, - 0.006279, - 0.0016420000000000002, - 0.005294, - 0.004224, - 0.0011710000000000002, - 0.003907, - 0.0066170000000000005, - 0.0040880000000000005, - 0.005354, - 0.00361, - 0.00435, - 0.00218, - 0.0059240000000000004, - 0.003872, - 0.001578, - 0.004053, - 0.001416, - 0.000916, - 0.001277, - 0.001072, - 0.001391, - 0.00286, - 0.001101, - 0.001865, - 0.0011769999999999999, - 0.00074, - 0.000206, - 0.000424, - 0.000165, - 0.000217 - ] - }, - { - "name": "Amylocorticiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0037649999999999997, - 0.004994, - 0.004442, - 0.004951, - 0.004182, - 0.005305, - 0.0032170000000000002, - 0.004748, - 0.00325, - 0.003421, - 0.0032189999999999996, - 0.001034, - 0.002226, - 0.0038420000000000004, - 0.005304, - 0.0022789999999999998, - 0.003711, - 0.0026579999999999998, - 0.002761, - 0.005327, - 0.0034020000000000005, - 0.002384, - 0.002726, - 0.002207, - 0.012643000000000001, - 0.002935, - 0.013488, - 0.003082, - 0.002546, - 0.00556, - 0.0008039999999999999, - 0.001276, - 0.0014, - 0.002748, - 0.0017329999999999997, - 0.00041, - 5.2000000000000004e-05, - 0.001864, - 8.2e-05, - 8.7e-05 - ] - }, - { - "name": "Schizopyrenida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0037259999999999997, - 0.001859, - 0.001884, - 0.0018, - 0.001697, - 0.002724, - 0.0011970000000000001, - 0.001611, - 0.004795000000000001, - 0.001478, - 0.0017920000000000002, - 0.009003, - 0.000782, - 0.001501, - 0.003363, - 0.004696, - 0.00264, - 0.002139, - 0.004377000000000001, - 0.0026579999999999998, - 0.002482, - 0.001314, - 0.001468, - 0.004279, - 0.012662999999999999, - 0.0015869999999999999, - 0.010577, - 0.005483, - 0.010302, - 0.0024980000000000002, - 0.019418, - 0.00305, - 0.000872, - 0.001538, - 0.000375, - 0.000171, - 8.2e-05, - 0.0008849999999999999, - 2.1e-05, - 3.5e-05 - ] - }, - { - "name": "Naviculales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0045579999999999996, - 0.003964, - 0.0027719999999999997, - 0.002898, - 0.002956, - 0.002581, - 0.003237, - 0.007061, - 0.0037700000000000003, - 0.0070480000000000004, - 0.0031850000000000003, - 0.001946, - 0.002407, - 0.003886, - 0.003721, - 0.0038829999999999997, - 0.003932, - 0.00446, - 0.00532, - 0.004706, - 0.005187, - 0.0034340000000000004, - 0.00346, - 0.008907, - 0.003214, - 0.007504, - 0.004556, - 0.00156, - 0.00278, - 0.0024980000000000002, - 0.003235, - 0.001807, - 0.001193, - 0.002699, - 0.000892, - 0.00022799999999999999, - 0.00046399999999999995, - 0.00161, - 0.0010609999999999999, - 7.8e-05 - ] - }, - { - "name": "Magnaporthales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006976, - 0.005845, - 0.007312999999999999, - 0.007717, - 0.006185, - 0.003871, - 0.004453, - 0.003689, - 0.004249, - 0.006456999999999999, - 0.0051140000000000005, - 0.0027370000000000003, - 0.00355, - 0.006064, - 0.002896, - 0.0038399999999999997, - 0.0038350000000000003, - 0.00275, - 0.003965, - 0.004365, - 0.005159, - 0.0029649999999999998, - 0.004718, - 0.003258, - 0.0014810000000000001, - 0.003833, - 0.001216, - 0.001889, - 0.0015609999999999999, - 0.001866, - 0.002006, - 0.002147, - 0.001491, - 0.002075, - 0.001099, - 0.000671, - 0.000134, - 0.00017900000000000001, - 7.2e-05, - 0.00013000000000000002 - ] - }, - { - "name": "Eugregarinorida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001467, - 0.001993, - 0.001974, - 0.001698, - 0.00183, - 0.001505, - 0.0011970000000000001, - 0.002285, - 0.002065, - 0.0024809999999999997, - 0.004464, - 0.00365, - 0.0012029999999999999, - 0.001766, - 0.004816, - 0.004045, - 0.0008550000000000001, - 0.0015890000000000001, - 0.001667, - 0.001893, - 0.001115, - 0.001182, - 0.0005769999999999999, - 0.017925, - 0.019004, - 0.002629, - 0.015147, - 0.0032530000000000002, - 0.004589, - 0.002198, - 0.009072, - 0.001243, - 0.000413, - 0.001143, - 0.000259, - 0.00011399999999999999, - 7.2e-05, - 0.00885, - 2.6000000000000002e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Pezizales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006698999999999999, - 0.005397, - 0.008604, - 0.007107, - 0.006972, - 0.003513, - 0.002982, - 0.002538, - 0.007379000000000001, - 0.0040479999999999995, - 0.004954999999999999, - 0.002251, - 0.003489, - 0.007051000000000001, - 0.001714, - 0.003979, - 0.002657, - 0.003208, - 0.004882, - 0.003258, - 0.0035, - 0.001895, - 0.00346, - 0.0026620000000000003, - 0.005692, - 0.005363000000000001, - 0.00201, - 0.001592, - 0.0040490000000000005, - 0.000956, - 0.002919, - 0.001393, - 0.001216, - 0.002081, - 0.000789, - 0.00058, - 5.2000000000000004e-05, - 0.000217, - 7.2e-05, - 9.6e-05 - ] - }, - { - "name": "Methanobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0057469999999999995, - 0.003964, - 0.004829, - 0.005622, - 0.004231, - 0.003011, - 0.0048850000000000005, - 0.0081, - 0.010403, - 0.003654, - 0.0035280000000000003, - 0.001399, - 0.00367, - 0.003106, - 0.002137, - 0.010435999999999999, - 0.005031, - 0.002016, - 0.005497, - 0.004075, - 0.004002, - 0.002252, - 0.002464, - 0.0037600000000000003, - 0.003059, - 0.00281, - 0.003954999999999999, - 0.001573, - 0.001744, - 0.001596, - 0.00159, - 0.0025109999999999998, - 0.000895, - 0.001989, - 0.001448, - 0.0007509999999999999, - 0.00024700000000000004, - 0.000452, - 0.0005769999999999999, - 0.00019099999999999998 - ] - }, - { - "name": "Orbales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.003647, - 0.0033810000000000003, - 0.002402, - 0.002613, - 0.002029, - 0.0035840000000000004, - 0.0044729999999999995, - 0.0024530000000000003, - 0.002238, - 0.002382, - 0.001929, - 0.002859, - 0.004572, - 0.0021780000000000002, - 0.001952, - 0.0020859999999999997, - 0.0019489999999999998, - 0.00179, - 0.001583, - 0.0017690000000000002, - 0.002315, - 0.0015279999999999998, - 0.003145, - 0.002432, - 0.001927, - 0.0022649999999999997, - 0.0031320000000000002, - 0.0017809999999999998, - 0.001977, - 0.001342, - 0.001102, - 0.005239, - 0.005874, - 0.001099, - 0.001578, - 0.00577, - 0.008169, - 0.007523, - 0.012426000000000001, - 0.007520000000000001 - ] - }, - { - "name": "Sphaeropleales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006737999999999999, - 0.004277, - 0.005857, - 0.0051340000000000005, - 0.004463, - 0.0062369999999999995, - 0.003237, - 0.003203, - 0.004249, - 0.003815, - 0.002911, - 0.004866, - 0.002888, - 0.004063000000000001, - 0.0038179999999999998, - 0.003768, - 0.0029010000000000004, - 0.0021079999999999996, - 0.003662, - 0.0032270000000000003, - 0.0037229999999999997, - 0.002007, - 0.004089, - 0.0033049999999999998, - 0.004831, - 0.002849, - 0.004162, - 0.002855, - 0.003568, - 0.002036, - 0.0044, - 0.002313, - 0.00117, - 0.001303, - 0.001099, - 0.00058, - 0.000103, - 0.000734, - 4.1e-05, - 0.00013000000000000002 - ] - }, - { - "name": "Glycomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.007372, - 0.00627, - 0.007107, - 0.006212, - 0.005796, - 0.006451999999999999, - 0.0046689999999999995, - 0.0034649999999999998, - 0.00329, - 0.005902, - 0.0038929999999999998, - 0.001338, - 0.004873, - 0.005299, - 0.003406, - 0.003189, - 0.003314, - 0.002187, - 0.003535, - 0.004448, - 0.005257, - 0.002506, - 0.002726, - 0.002532, - 0.001462, - 0.0031739999999999997, - 0.0013160000000000001, - 0.002482, - 0.001124, - 0.0018739999999999998, - 0.001265, - 0.00247, - 0.0015140000000000002, - 0.0013830000000000001, - 0.0016940000000000002, - 0.0009449999999999999, - 9.300000000000001e-05, - 0.000151, - 4.6e-05, - 8.7e-05 - ] - }, - { - "name": "Trechisporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002933, - 0.00365, - 0.004129, - 0.003406, - 0.003006, - 0.002079, - 0.0024129999999999998, - 0.0056, - 0.006793, - 0.0047020000000000005, - 0.00234, - 0.001521, - 0.002046, - 0.003179, - 0.003992, - 0.006933, - 0.004147, - 0.00655, - 0.006187, - 0.002203, - 0.00198, - 0.001182, - 0.001468, - 0.019979, - 0.0018679999999999999, - 0.005344, - 0.001402, - 0.0015789999999999999, - 0.0012109999999999998, - 0.0033469999999999997, - 0.001382, - 0.001384, - 0.000711, - 0.00365, - 0.000504, - 0.000307, - 6.2e-05, - 0.000226, - 0.000113, - 9.6e-05 - ] - }, - { - "name": "Botryosphaeriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006421, - 0.005285, - 0.007156999999999999, - 0.005592, - 0.005076, - 0.004588, - 0.004277, - 0.004148, - 0.004862, - 0.005033, - 0.004338, - 0.002068, - 0.00355, - 0.004975, - 0.002484, - 0.003129, - 0.003654, - 0.002853, - 0.005135, - 0.0039, - 0.004811, - 0.0028940000000000003, - 0.003565, - 0.0026030000000000003, - 0.001423, - 0.004932, - 0.001302, - 0.001371, - 0.000897, - 0.0013570000000000001, - 0.0016809999999999998, - 0.0023710000000000003, - 0.001491, - 0.0018280000000000002, - 0.00128, - 0.000592, - 0.000113, - 0.00017900000000000001, - 7.2e-05, - 0.000182 - ] - }, - { - "name": "Dothideales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006421, - 0.005688, - 0.005561, - 0.004504, - 0.005217, - 0.005162, - 0.004728, - 0.004045, - 0.004129, - 0.004872, - 0.0034700000000000004, - 0.0021899999999999997, - 0.004873, - 0.004416, - 0.0028420000000000003, - 0.004419, - 0.00298, - 0.002762, - 0.004192, - 0.004613, - 0.004629, - 0.0029649999999999998, - 0.003722, - 0.0032700000000000003, - 0.001491, - 0.0036130000000000003, - 0.0014880000000000002, - 0.001655, - 0.0008900000000000001, - 0.001403, - 0.001925, - 0.002313, - 0.001491, - 0.001556, - 0.0012029999999999999, - 0.0009789999999999998, - 9.300000000000001e-05, - 0.000264, - 2.1e-05, - 0.000182 - ] - }, - { - "name": "Dehalococcoidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006342, - 0.00365, - 0.008348999999999999, - 0.004016, - 0.007418999999999999, - 0.0040149999999999995, - 0.003257, - 0.003137, - 0.005568, - 0.005705, - 0.0029219999999999997, - 0.000365, - 0.0019850000000000002, - 0.006109000000000001, - 0.00064, - 0.005257, - 0.006220000000000001, - 0.0048270000000000006, - 0.004327, - 0.00242, - 0.002845, - 0.0032600000000000003, - 0.009174, - 0.00255, - 0.0009289999999999999, - 0.00325, - 0.000608, - 0.000442, - 0.000496, - 0.000362, - 0.0011380000000000001, - 0.001923, - 0.001216, - 0.0040950000000000005, - 0.001423, - 0.0006940000000000001, - 0.00024700000000000004, - 0.000245, - 0.00010800000000000001, - 0.00020800000000000001 - ] - }, - { - "name": "Ignavibacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005232, - 0.004501, - 0.00445, - 0.0030600000000000002, - 0.003817, - 0.004588, - 0.003001, - 0.0035020000000000003, - 0.004089, - 0.0045049999999999995, - 0.0022600000000000003, - 0.002007, - 0.002527, - 0.003489, - 0.001139, - 0.005221, - 0.012084000000000001, - 0.002982, - 0.003822, - 0.004138, - 0.0035700000000000003, - 0.0021190000000000002, - 0.001835, - 0.008989, - 0.0012, - 0.0027719999999999997, - 0.000822, - 0.001067, - 0.000868, - 0.000709, - 0.001193, - 0.0050149999999999995, - 0.001124, - 0.002131, - 0.000944, - 0.0006940000000000001, - 7.2e-05, - 8.499999999999999e-05, - 2.1e-05, - 6.9e-05 - ] - }, - { - "name": "Taphrinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004677000000000001, - 0.00692, - 0.006235, - 0.006141, - 0.004455, - 0.005592, - 0.004767, - 0.0032770000000000004, - 0.003743, - 0.005678, - 0.003379, - 0.001034, - 0.0045119999999999995, - 0.004033, - 0.0014210000000000002, - 0.007241, - 0.001864, - 0.003513, - 0.00213, - 0.00391, - 0.003737, - 0.001905, - 0.003093, - 0.0019420000000000001, - 0.001956, - 0.002543, - 0.003304, - 0.001358, - 0.001423, - 0.0008560000000000001, - 0.002015, - 0.002006, - 0.00156, - 0.001155, - 0.000711, - 0.00044400000000000006, - 6.2e-05, - 0.00028199999999999997, - 4.1e-05, - 7.8e-05 - ] - }, - { - "name": "Sulfolobales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0037649999999999997, - 0.002866, - 0.007790000000000001, - 0.0034869999999999996, - 0.005275, - 0.003154, - 0.002472, - 0.004457, - 0.0057009999999999995, - 0.003994, - 0.0045320000000000004, - 0.001277, - 0.001564, - 0.004681, - 0.000889, - 0.0043950000000000005, - 0.005195, - 0.0028350000000000003, - 0.012837000000000001, - 0.006403, - 0.0034579999999999997, - 0.001977, - 0.004928, - 0.0029690000000000003, - 0.0006, - 0.004493, - 0.000637, - 0.0005679999999999999, - 0.00054, - 0.000493, - 0.00056, - 0.001334, - 0.000849, - 0.002149, - 0.00128, - 0.000398, - 2.1e-05, - 7.5e-05, - 3.1e-05, - 3.5e-05 - ] - }, - { - "name": "Mycoplasmatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004162, - 0.005531, - 0.005413, - 0.0034869999999999996, - 0.0040409999999999995, - 0.002868, - 0.004277, - 0.00441, - 0.003064, - 0.005365, - 0.002546, - 0.00146, - 0.0039109999999999995, - 0.0040479999999999995, - 0.0020829999999999998, - 0.003159, - 0.003858, - 0.002945, - 0.003889, - 0.0032170000000000002, - 0.0035280000000000003, - 0.001977, - 0.002778, - 0.0051649999999999995, - 0.002169, - 0.004215999999999999, - 0.0015300000000000001, - 0.001731, - 0.00151, - 0.001149, - 0.002349, - 0.0019149999999999998, - 0.002042, - 0.002273, - 0.000698, - 0.0005009999999999999, - 0.000288, - 0.0030789999999999997, - 0.000278, - 0.00013000000000000002 - ] - }, - { - "name": "Rubrobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006144, - 0.004658, - 0.00677, - 0.004382, - 0.005497999999999999, - 0.003871, - 0.005336, - 0.003418, - 0.002624, - 0.0056240000000000005, - 0.003014, - 0.0018859999999999999, - 0.004031, - 0.004915999999999999, - 0.0038179999999999998, - 0.002665, - 0.0029170000000000003, - 0.0015949999999999998, - 0.002601, - 0.003403, - 0.003974, - 0.002364, - 0.003145, - 0.00275, - 0.001975, - 0.0026100000000000003, - 0.0015300000000000001, - 0.002647, - 0.001065, - 0.0021739999999999997, - 0.0012380000000000002, - 0.002039, - 0.001744, - 0.001044, - 0.0011380000000000001, - 0.001036, - 5.2000000000000004e-05, - 0.000377, - 2.1e-05, - 6.1e-05 - ] - }, - { - "name": "Tilletiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.007095000000000001, - 0.005464, - 0.0055850000000000006, - 0.004301, - 0.004157, - 0.004229999999999999, - 0.004414, - 0.002912, - 0.005901, - 0.005069, - 0.0028539999999999998, - 0.001946, - 0.004392, - 0.0040479999999999995, - 0.002506, - 0.003195, - 0.002799, - 0.0019489999999999998, - 0.0028870000000000002, - 0.0035479999999999995, - 0.004336, - 0.0017629999999999998, - 0.003565, - 0.002455, - 0.001578, - 0.0031829999999999996, - 0.002153, - 0.001535, - 0.001656, - 0.0014960000000000002, - 0.0017530000000000002, - 0.002255, - 0.001124, - 0.001068, - 0.000944, - 0.0005009999999999999, - 0.000113, - 0.000245, - 6.7e-05, - 0.000139 - ] - }, - { - "name": "Umbilicariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002576, - 0.002553, - 0.002616, - 0.005053, - 0.002111, - 0.003154, - 0.001667, - 0.003549, - 0.002251, - 0.003573, - 0.0020210000000000002, - 0.0009119999999999999, - 0.001685, - 0.003135, - 0.001269, - 0.034105, - 0.002079, - 0.009544, - 0.001524, - 0.001789, - 0.0013390000000000001, - 0.003016, - 0.001835, - 0.00131, - 0.000532, - 0.00196, - 0.001437, - 0.0020210000000000002, - 0.000868, - 0.000725, - 0.000379, - 0.001359, - 0.001698, - 0.0019760000000000003, - 0.001759, - 0.00033, - 5.2000000000000004e-05, - 0.000113, - 4.1e-05, - 7.8e-05 - ] - }, - { - "name": "Diaporthales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005311, - 0.004411, - 0.004993, - 0.0041990000000000005, - 0.004604, - 0.004516, - 0.002825, - 0.003071, - 0.0039689999999999994, - 0.00446, - 0.00548, - 0.001703, - 0.0027670000000000004, - 0.005034, - 0.003406, - 0.003539, - 0.003116, - 0.0023710000000000003, - 0.0028870000000000002, - 0.003589, - 0.004364, - 0.0017120000000000002, - 0.002097, - 0.002326, - 0.003214, - 0.002916, - 0.004026, - 0.002167, - 0.001372, - 0.00155, - 0.001175, - 0.002288, - 0.000941, - 0.0014199999999999998, - 0.0009310000000000001, - 0.000546, - 0.000103, - 0.000386, - 7.7e-05, - 6.1e-05 - ] - }, - { - "name": "Eggerthellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006976, - 0.004837, - 0.005882, - 0.00424, - 0.0039829999999999996, - 0.0036560000000000004, - 0.004296, - 0.003118, - 0.004182, - 0.004218, - 0.0032189999999999996, - 0.001521, - 0.003489, - 0.003547, - 0.002137, - 0.0034240000000000004, - 0.004555, - 0.0018329999999999998, - 0.003182, - 0.004303, - 0.004058, - 0.0026190000000000002, - 0.002936, - 0.002585, - 0.00122, - 0.002457, - 0.001366, - 0.001819, - 0.001036, - 0.0011330000000000001, - 0.001274, - 0.002561, - 0.001101, - 0.001186, - 0.00119, - 0.000637, - 7.2e-05, - 0.000169, - 4.1e-05, - 0.00010400000000000001 - ] - }, - { - "name": "Chroococcidiopsidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002101, - 0.00215, - 0.002007, - 0.002318, - 0.002418, - 0.0017920000000000002, - 0.001726, - 0.001508, - 0.000986, - 0.001827, - 0.001667, - 0.060037, - 0.0009630000000000001, - 0.002223, - 0.001247, - 0.001037, - 0.001739, - 0.000807, - 0.000918, - 0.0019760000000000003, - 0.0019100000000000002, - 0.000805, - 0.000682, - 0.000791, - 0.000455, - 0.0013289999999999999, - 0.0019309999999999998, - 0.001194, - 0.000343, - 0.0005780000000000001, - 0.000551, - 0.001086, - 0.000872, - 0.000562, - 0.00042699999999999997, - 0.000319, - 2.1e-05, - 3.8e-05, - 1.4999999999999999e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Prymnesiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0057469999999999995, - 0.0032920000000000002, - 0.004343, - 0.005266, - 0.0032619999999999997, - 0.003011, - 0.0021780000000000002, - 0.002304, - 0.0037159999999999997, - 0.002857, - 0.002797, - 0.003954, - 0.002587, - 0.00315, - 0.002983, - 0.0041, - 0.002668, - 0.0019489999999999998, - 0.002727, - 0.0034649999999999998, - 0.003737, - 0.00164, - 0.002936, - 0.003187, - 0.0034270000000000004, - 0.002438, - 0.004384000000000001, - 0.00168, - 0.0034289999999999998, - 0.001558, - 0.003994, - 0.0019149999999999998, - 0.0012619999999999999, - 0.0014140000000000001, - 0.000517, - 0.000376, - 8.2e-05, - 0.000377, - 4.6e-05, - 0.000156 - ] - }, - { - "name": "Harpellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002735, - 0.0022170000000000002, - 0.002501, - 0.002328, - 0.001847, - 0.0016489999999999999, - 0.001923, - 0.001629, - 0.006540000000000001, - 0.001917, - 0.0017469999999999999, - 0.006204, - 0.0012029999999999999, - 0.00212, - 0.0026899999999999997, - 0.005806, - 0.006118, - 0.0018030000000000001, - 0.002172, - 0.002327, - 0.001924, - 0.001355, - 0.0019399999999999999, - 0.00942, - 0.004831, - 0.001281, - 0.006422, - 0.001819, - 0.004465, - 0.001519, - 0.0064329999999999995, - 0.0018399999999999998, - 0.000459, - 0.00118, - 0.000491, - 0.000148, - 7.2e-05, - 0.000621, - 3.6e-05, - 6.1e-05 - ] - }, - { - "name": "Orbiliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004201, - 0.003157, - 0.004278, - 0.004148, - 0.003428, - 0.002868, - 0.003963, - 0.0027719999999999997, - 0.00293, - 0.0033590000000000004, - 0.003048, - 0.003589, - 0.0034289999999999998, - 0.003871, - 0.003981, - 0.002948, - 0.0027649999999999997, - 0.0038619999999999995, - 0.0034340000000000004, - 0.003031, - 0.002635, - 0.002405, - 0.001573, - 0.002579, - 0.001859, - 0.0028870000000000002, - 0.003619, - 0.0021850000000000003, - 0.002554, - 0.0031850000000000003, - 0.002259, - 0.001533, - 0.001101, - 0.001902, - 0.0009699999999999999, - 0.000364, - 5.2000000000000004e-05, - 0.000226, - 4.6e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Kineosporiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005628, - 0.00365, - 0.005273, - 0.005195, - 0.0038009999999999997, - 0.0036560000000000004, - 0.0037270000000000003, - 0.002865, - 0.002691, - 0.003833, - 0.00266, - 0.002555, - 0.002527, - 0.0035329999999999997, - 0.0039700000000000004, - 0.002255, - 0.002306, - 0.001534, - 0.00298, - 0.002731, - 0.0035700000000000003, - 0.002211, - 0.003303, - 0.001906, - 0.001568, - 0.002332, - 0.001402, - 0.0035689999999999997, - 0.00135, - 0.0026449999999999998, - 0.002042, - 0.001384, - 0.001285, - 0.0012289999999999998, - 0.001927, - 0.000558, - 7.2e-05, - 0.00016, - 1.4999999999999999e-05, - 0.000139 - ] - }, - { - "name": "Basidiobolales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00329, - 0.002105, - 0.0023769999999999998, - 0.002928, - 0.002037, - 0.002437, - 0.001648, - 0.0022660000000000002, - 0.003476, - 0.00214, - 0.002101, - 0.00517, - 0.000782, - 0.001678, - 0.0032869999999999996, - 0.0033520000000000004, - 0.0016710000000000002, - 0.0019920000000000003, - 0.002879, - 0.002576, - 0.002022, - 0.0015689999999999999, - 0.0015199999999999999, - 0.005436, - 0.005024, - 0.002514, - 0.0075239999999999994, - 0.002204, - 0.005567, - 0.0029219999999999997, - 0.006361, - 0.00213, - 0.001124, - 0.0017170000000000002, - 0.000491, - 0.000205, - 0.000113, - 0.00047999999999999996, - 3.6e-05, - 3.5e-05 - ] - }, - { - "name": "Actinopolysporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005906000000000001, - 0.004568, - 0.006581, - 0.004626, - 0.00525, - 0.00509, - 0.0042369999999999994, - 0.0028190000000000003, - 0.0028239999999999997, - 0.003672, - 0.0038810000000000003, - 0.001217, - 0.0033090000000000003, - 0.004651, - 0.002343, - 0.002369, - 0.002045, - 0.001607, - 0.002466, - 0.002793, - 0.0035840000000000004, - 0.0017530000000000002, - 0.003617, - 0.001794, - 0.000842, - 0.002858, - 0.0008869999999999999, - 0.00168, - 0.0007440000000000001, - 0.0013570000000000001, - 0.000976, - 0.001442, - 0.0010550000000000002, - 0.001031, - 0.001099, - 0.000683, - 0.000144, - 0.00010400000000000001, - 5.2000000000000004e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Micropepsales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004598, - 0.002665, - 0.002542, - 0.003619, - 0.002882, - 0.0035840000000000004, - 0.0019030000000000002, - 0.003924, - 0.0017850000000000001, - 0.0018629999999999999, - 0.002043, - 0.006448000000000001, - 0.0019850000000000002, - 0.002223, - 0.005337, - 0.001809, - 0.000793, - 0.001607, - 0.001439, - 0.0036, - 0.003151, - 0.003322, - 0.003093, - 0.001859, - 0.002817, - 0.002141, - 0.0037689999999999998, - 0.0050030000000000005, - 0.004392, - 0.002221, - 0.002792, - 0.000688, - 0.001285, - 0.0009390000000000001, - 0.0014869999999999998, - 0.00033, - 9.300000000000001e-05, - 0.00032, - 3.1e-05, - 4.3e-05 - ] - }, - { - "name": "Monoblepharidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005034, - 0.004367, - 0.0033810000000000003, - 0.003467, - 0.002774, - 0.004158, - 0.0029620000000000002, - 0.002275, - 0.003317, - 0.0026780000000000003, - 0.002489, - 0.002798, - 0.003249, - 0.003268, - 0.002278, - 0.0031829999999999996, - 0.0019320000000000001, - 0.001741, - 0.002761, - 0.003372, - 0.002482, - 0.0013449999999999998, - 0.002202, - 0.0026969999999999997, - 0.002982, - 0.002246, - 0.0038689999999999996, - 0.0015539999999999998, - 0.0036479999999999998, - 0.001542, - 0.004102000000000001, - 0.001882, - 0.00078, - 0.001044, - 0.000543, - 0.00044400000000000006, - 6.2e-05, - 0.000433, - 4.1e-05, - 6.1e-05 - ] - }, - { - "name": "Trichosporonales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005549, - 0.004053, - 0.004968, - 0.003843, - 0.0043549999999999995, - 0.0038, - 0.003257, - 0.00235, - 0.00365, - 0.002991, - 0.002728, - 0.0018859999999999999, - 0.003068, - 0.00343, - 0.0019420000000000001, - 0.0030629999999999998, - 0.002787, - 0.002291, - 0.0028699999999999997, - 0.002855, - 0.0034159999999999998, - 0.002007, - 0.003041, - 0.0034409999999999996, - 0.001559, - 0.002648, - 0.001731, - 0.001175, - 0.001715, - 0.0012259999999999999, - 0.001771, - 0.001832, - 0.000849, - 0.001217, - 0.000776, - 0.000637, - 0.000124, - 0.000301, - 5.2000000000000004e-05, - 9.6e-05 - ] - }, - { - "name": "Gloeobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004083, - 0.004367, - 0.004541, - 0.004789, - 0.003163, - 0.004372999999999999, - 0.003433, - 0.004542, - 0.002344, - 0.004147, - 0.003379, - 0.001703, - 0.0039109999999999995, - 0.003385, - 0.0016699999999999998, - 0.002285, - 0.002799, - 0.001466, - 0.002046, - 0.004220000000000001, - 0.0035840000000000004, - 0.002731, - 0.003145, - 0.002219, - 0.000833, - 0.003116, - 0.000715, - 0.0014529999999999999, - 0.00054, - 0.000933, - 0.000642, - 0.00179, - 0.00179, - 0.000858, - 0.001927, - 0.0006490000000000001, - 4.1e-05, - 8.499999999999999e-05, - 2.1e-05, - 9.6e-05 - ] - }, - { - "name": "Desulfarculales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004717, - 0.004277, - 0.005454, - 0.002694, - 0.003676, - 0.002652, - 0.0040409999999999995, - 0.002996, - 0.002571, - 0.004845, - 0.0016899999999999999, - 0.000852, - 0.00385, - 0.003415, - 0.001117, - 0.003268, - 0.007642, - 0.001754, - 0.002879, - 0.003279, - 0.003123, - 0.001977, - 0.0019399999999999999, - 0.004822, - 0.0007160000000000001, - 0.002017, - 0.00048600000000000005, - 0.0015220000000000001, - 0.000496, - 0.000771, - 0.000605, - 0.0026609999999999997, - 0.001308, - 0.0011359999999999999, - 0.0009570000000000001, - 0.000603, - 6.2e-05, - 0.000113, - 3.6e-05, - 0.00010400000000000001 - ] - }, - { - "name": "Thermoproteales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004638000000000001, - 0.00571, - 0.0051, - 0.0032329999999999998, - 0.003619, - 0.002939, - 0.003237, - 0.00236, - 0.0032770000000000004, - 0.003851, - 0.002888, - 0.002068, - 0.002948, - 0.003091, - 0.002137, - 0.0027429999999999998, - 0.003512, - 0.001778, - 0.002845, - 0.0036200000000000004, - 0.003221, - 0.0018440000000000002, - 0.003041, - 0.002449, - 0.001588, - 0.002858, - 0.00128, - 0.0017239999999999998, - 0.000883, - 0.000964, - 0.0013369999999999999, - 0.001873, - 0.001101, - 0.001285, - 0.000892, - 0.000523, - 7.2e-05, - 0.000169, - 3.1e-05, - 0.000113 - ] - }, - { - "name": "Mytilinidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.008482, - 0.004971, - 0.004113, - 0.0019320000000000001, - 0.003403, - 0.004229999999999999, - 0.003257, - 0.00309, - 0.002065, - 0.0043170000000000005, - 0.001678, - 0.0011560000000000001, - 0.00379, - 0.003179, - 0.001161, - 0.002225, - 0.002141, - 0.001912, - 0.001877, - 0.003486, - 0.006915999999999999, - 0.0032600000000000003, - 0.0026739999999999997, - 0.001948, - 0.0006389999999999999, - 0.004913, - 0.0006580000000000001, - 0.0006, - 0.0007, - 0.000463, - 0.0005690000000000001, - 0.0014089999999999999, - 0.001423, - 0.001068, - 0.000685, - 0.000421, - 5.2000000000000004e-05, - 0.000113, - 4.6e-05, - 4.3e-05 - ] - }, - { - "name": "Ferrovales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.006698999999999999, - 0.005173, - 0.004072, - 0.002725, - 0.003196, - 0.003154, - 0.003924, - 0.0035399999999999997, - 0.002744, - 0.004065999999999999, - 0.0017469999999999999, - 0.001582, - 0.00367, - 0.002811, - 0.0007480000000000001, - 0.002526, - 0.002385, - 0.0020469999999999998, - 0.002736, - 0.004293, - 0.004364, - 0.003077, - 0.00367, - 0.001877, - 0.00061, - 0.002935, - 0.000522, - 0.000872, - 0.0007440000000000001, - 0.000424, - 0.00066, - 0.001301, - 0.001078, - 0.001402, - 0.001099, - 0.000637, - 9.300000000000001e-05, - 8.499999999999999e-05, - 4.1e-05, - 0.000122 - ] - }, - { - "name": "Calditrichales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005113, - 0.0038520000000000004, - 0.005248, - 0.002532, - 0.003743, - 0.003011, - 0.0037270000000000003, - 0.002416, - 0.004396, - 0.003708, - 0.001918, - 0.001217, - 0.002888, - 0.002811, - 0.000727, - 0.002821, - 0.005586, - 0.002236, - 0.003249, - 0.002503, - 0.0035700000000000003, - 0.0017829999999999999, - 0.005347, - 0.00242, - 0.0004940000000000001, - 0.002839, - 0.000544, - 0.00042300000000000004, - 0.000365, - 0.00044, - 0.000443, - 0.0023539999999999998, - 0.000665, - 0.001575, - 0.000737, - 0.000637, - 3.1e-05, - 6.6e-05, - 2.1e-05, - 8.7e-05 - ] - }, - { - "name": "Pleurocapsales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004439, - 0.0043219999999999995, - 0.005075, - 0.0032329999999999998, - 0.00419, - 0.002581, - 0.0043159999999999995, - 0.003128, - 0.002358, - 0.003994, - 0.002135, - 0.0018859999999999999, - 0.002166, - 0.0031940000000000002, - 0.002039, - 0.00249, - 0.00345, - 0.001894, - 0.002652, - 0.003496, - 0.0033880000000000004, - 0.002343, - 0.0026739999999999997, - 0.002414, - 0.001016, - 0.002065, - 0.000951, - 0.001396, - 0.0009050000000000001, - 0.001064, - 0.0008759999999999999, - 0.0020559999999999997, - 0.00101, - 0.001007, - 0.000647, - 0.0005690000000000001, - 2.1e-05, - 0.000113, - 4.1e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Malasseziales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0028539999999999998, - 0.002127, - 0.00255, - 0.002216, - 0.002029, - 0.002724, - 0.0018239999999999999, - 0.0019010000000000001, - 0.0020109999999999998, - 0.00197, - 0.001438, - 0.002555, - 0.0019850000000000002, - 0.002046, - 0.0022670000000000004, - 0.001959, - 0.001609, - 0.001124, - 0.002374, - 0.0021, - 0.0018679999999999999, - 0.0009480000000000001, - 0.001153, - 0.001381, - 0.004511, - 0.001835, - 0.003483, - 0.0016420000000000002, - 0.012673, - 0.00175, - 0.010806999999999999, - 0.001169, - 0.000597, - 0.000704, - 0.000491, - 0.00022799999999999999, - 6.2e-05, - 0.000433, - 3.1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Kiritimatiellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002418, - 0.004367, - 0.0075840000000000005, - 0.0044729999999999995, - 0.003693, - 0.0034409999999999996, - 0.005002, - 0.002444, - 0.0018780000000000001, - 0.004335, - 0.0022719999999999997, - 0.000365, - 0.0033689999999999996, - 0.003268, - 0.00035800000000000003, - 0.001766, - 0.0031379999999999997, - 0.000715, - 0.001338, - 0.0063100000000000005, - 0.00799, - 0.001172, - 0.0015199999999999999, - 0.001192, - 0.00011599999999999999, - 0.00195, - 0.000236, - 0.000335, - 0.000146, - 0.00022400000000000002, - 0.00018999999999999998, - 0.001707, - 0.0013310000000000002, - 0.0008150000000000001, - 0.000672, - 0.00044400000000000006, - 1e-05, - 1.9e-05, - 1.4999999999999999e-05, - 6.9e-05 - ] - }, - { - "name": "Sulfuricellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.005946, - 0.003247, - 0.004393, - 0.002176, - 0.0036270000000000004, - 0.003943, - 0.003001, - 0.002566, - 0.002651, - 0.003385, - 0.001598, - 0.000487, - 0.0033689999999999996, - 0.002605, - 0.0008460000000000001, - 0.002508, - 0.0027530000000000002, - 0.0021449999999999998, - 0.0032159999999999997, - 0.003496, - 0.0035700000000000003, - 0.0020989999999999997, - 0.0029879999999999998, - 0.002042, - 0.00047400000000000003, - 0.002552, - 0.000315, - 0.001118, - 0.000452, - 0.000517, - 0.000533, - 0.001989, - 0.000849, - 0.0017170000000000002, - 0.0009960000000000001, - 0.0005690000000000001, - 8.2e-05, - 9.4e-05, - 3.1e-05, - 8.7e-05 - ] - }, - { - "name": "Gloeophyllales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004756, - 0.00309, - 0.0036520000000000003, - 0.002959, - 0.002426, - 0.002796, - 0.0024129999999999998, - 0.0025280000000000003, - 0.002624, - 0.003153, - 0.0018039999999999998, - 0.00146, - 0.002707, - 0.0031940000000000002, - 0.002321, - 0.0023870000000000002, - 0.002294, - 0.00179, - 0.001953, - 0.002079, - 0.002384, - 0.001314, - 0.002412, - 0.0023899999999999998, - 0.0016940000000000002, - 0.0023899999999999998, - 0.003032, - 0.0015660000000000001, - 0.00151, - 0.001072, - 0.0017079999999999999, - 0.001185, - 0.000597, - 0.001118, - 0.000634, - 0.00041, - 8.2e-05, - 0.000198, - 4.1e-05, - 3.5e-05 - ] - }, - { - "name": "Balneolales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004281, - 0.0036950000000000004, - 0.003759, - 0.002318, - 0.003006, - 0.002222, - 0.003139, - 0.002294, - 0.002344, - 0.0036899999999999997, - 0.001952, - 0.002007, - 0.0027670000000000004, - 0.002856, - 0.001334, - 0.002442, - 0.003988, - 0.0016190000000000002, - 0.0022140000000000003, - 0.002845, - 0.002607, - 0.0017219999999999998, - 0.001887, - 0.002148, - 0.001336, - 0.002027, - 0.001023, - 0.001225, - 0.0008900000000000001, - 0.000779, - 0.0011480000000000001, - 0.001964, - 0.000597, - 0.0009449999999999999, - 0.000672, - 0.000546, - 2.1e-05, - 0.000151, - 1.4999999999999999e-05, - 3.5e-05 - ] - }, - { - "name": "Phycisphaerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004241, - 0.002754, - 0.0024920000000000003, - 0.0023989999999999997, - 0.002045, - 0.002366, - 0.0014119999999999998, - 0.001835, - 0.002664, - 0.002284, - 0.001655, - 0.003346, - 0.002106, - 0.001693, - 0.003059, - 0.002418, - 0.004475, - 0.001295, - 0.0018100000000000002, - 0.0022140000000000003, - 0.0017989999999999998, - 0.001773, - 0.002307, - 0.002202, - 0.0017519999999999999, - 0.001482, - 0.001674, - 0.002179, - 0.001423, - 0.001234, - 0.00131, - 0.00252, - 0.0005740000000000001, - 0.0008029999999999999, - 0.00066, - 0.000398, - 3.1e-05, - 0.000188, - 1.4999999999999999e-05, - 4.3e-05 - ] - }, - { - "name": "Peridiniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002616, - 0.00271, - 0.002451, - 0.004189, - 0.0033539999999999998, - 0.00086, - 0.0010789999999999999, - 0.001667, - 0.0057280000000000005, - 0.0018, - 0.001256, - 0.0011560000000000001, - 0.000662, - 0.001972, - 0.000662, - 0.009651999999999999, - 0.0013650000000000001, - 0.000825, - 0.002037, - 0.001469, - 0.00145, - 0.002058, - 0.001206, - 0.0029920000000000003, - 0.004085, - 0.001797, - 0.0022170000000000002, - 0.00034700000000000003, - 0.000781, - 0.000617, - 0.0016539999999999999, - 0.0008119999999999999, - 0.000918, - 0.00126, - 0.000272, - 0.00013700000000000002, - 3.1e-05, - 0.000198, - 5.2000000000000004e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Pelagibacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004201, - 0.00374, - 0.00278, - 0.0025210000000000002, - 0.002368, - 0.003154, - 0.0022949999999999997, - 0.002566, - 0.002597, - 0.0027670000000000004, - 0.001849, - 0.001338, - 0.001865, - 0.0019140000000000001, - 0.001052, - 0.002255, - 0.0022429999999999998, - 0.001454, - 0.001768, - 0.002607, - 0.002454, - 0.001987, - 0.00173, - 0.002066, - 0.0011619999999999998, - 0.001902, - 0.0012519999999999999, - 0.001004, - 0.001182, - 0.0009789999999999998, - 0.001301, - 0.001484, - 0.000964, - 0.0009630000000000001, - 0.000621, - 0.000478, - 0.000185, - 0.00032, - 0.000371, - 0.000156 - ] - }, - { - "name": "Fibrobacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.003607, - 0.002844, - 0.003825, - 0.002338, - 0.003196, - 0.002652, - 0.001726, - 0.002079, - 0.002611, - 0.002427, - 0.0018149999999999998, - 0.001217, - 0.0019850000000000002, - 0.002105, - 0.0011710000000000002, - 0.002285, - 0.003008, - 0.001986, - 0.002046, - 0.001872, - 0.0017850000000000001, - 0.0016710000000000002, - 0.002621, - 0.001576, - 0.00121, - 0.002151, - 0.000708, - 0.00072, - 0.001189, - 0.000655, - 0.001328, - 0.001467, - 0.001308, - 0.002878, - 0.0008410000000000001, - 0.000319, - 4.1e-05, - 0.00016, - 2.6000000000000002e-05, - 0.000122 - ] - }, - { - "name": "Acidaminococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0038450000000000003, - 0.003045, - 0.003077, - 0.002593, - 0.0036520000000000003, - 0.001434, - 0.002079, - 0.001648, - 0.002211, - 0.002212, - 0.0022600000000000003, - 0.001034, - 0.0028280000000000002, - 0.002591, - 0.001725, - 0.0021579999999999998, - 0.0034100000000000003, - 0.001375, - 0.00186, - 0.001955, - 0.002635, - 0.001477, - 0.002778, - 0.0017289999999999999, - 0.0012, - 0.0017109999999999998, - 0.0006940000000000001, - 0.001472, - 0.0008029999999999999, - 0.000725, - 0.0012289999999999998, - 0.0021219999999999998, - 0.000597, - 0.000908, - 0.000724, - 0.000364, - 0.000124, - 0.000254, - 2.6000000000000002e-05, - 6.9e-05 - ] - }, - { - "name": "Sneathiellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00543, - 0.002553, - 0.003134, - 0.002664, - 0.002708, - 0.003513, - 0.0021780000000000002, - 0.002463, - 0.0025440000000000003, - 0.002418, - 0.001838, - 0.000852, - 0.001564, - 0.002473, - 0.001182, - 0.002032, - 0.001456, - 0.001198, - 0.001675, - 0.0028239999999999997, - 0.002984, - 0.002343, - 0.002202, - 0.0018239999999999999, - 0.00061, - 0.0016820000000000001, - 0.0006940000000000001, - 0.0009539999999999999, - 0.00073, - 0.000763, - 0.000768, - 0.000895, - 0.001033, - 0.0008960000000000001, - 0.001254, - 0.000296, - 5.2000000000000004e-05, - 0.000122, - 2.6000000000000002e-05, - 9e-06 - ] - }, - { - "name": "Methanococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001348, - 0.004635, - 0.004944, - 0.001027, - 0.003387, - 0.001577, - 0.003198, - 0.0008710000000000001, - 0.001159, - 0.003511, - 0.0008449999999999999, - 0.003346, - 0.00379, - 0.004136, - 0.001811, - 0.001115, - 0.002464, - 0.001155, - 0.001187, - 0.001045, - 0.000586, - 0.00043799999999999997, - 0.000891, - 0.0023899999999999998, - 0.0037170000000000003, - 0.001549, - 0.000551, - 0.000872, - 0.000503, - 0.001157, - 0.0039030000000000002, - 0.001119, - 0.000688, - 0.000513, - 0.000362, - 0.00041, - 5.2000000000000004e-05, - 0.000273, - 0.000196, - 9.6e-05 - ] - }, - { - "name": "Deferribacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0031309999999999997, - 0.002598, - 0.003348, - 0.001667, - 0.002592, - 0.002222, - 0.002629, - 0.002079, - 0.0018510000000000002, - 0.0024, - 0.0011070000000000001, - 0.00073, - 0.002346, - 0.001943, - 0.001258, - 0.002152, - 0.004651, - 0.0015400000000000001, - 0.002205, - 0.002431, - 0.002105, - 0.0016809999999999998, - 0.0015199999999999999, - 0.002278, - 0.0006490000000000001, - 0.001348, - 0.000865, - 0.001004, - 0.0006490000000000001, - 0.000648, - 0.000714, - 0.001898, - 0.00062, - 0.0009199999999999999, - 0.0005690000000000001, - 0.000421, - 1e-05, - 0.000151, - 4.6e-05, - 6.1e-05 - ] - }, - { - "name": "Spizellomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002656, - 0.0018809999999999999, - 0.002254, - 0.001749, - 0.0017640000000000002, - 0.002509, - 0.001609, - 0.001423, - 0.002304, - 0.001549, - 0.0014269999999999999, - 0.002616, - 0.0009630000000000001, - 0.001516, - 0.001616, - 0.002188, - 0.001462, - 0.001082, - 0.0015660000000000001, - 0.001841, - 0.001422, - 0.000734, - 0.001206, - 0.0023079999999999997, - 0.00244, - 0.001482, - 0.003469, - 0.001282, - 0.003254, - 0.0010869999999999999, - 0.003461, - 0.001318, - 0.000711, - 0.0005809999999999999, - 0.000259, - 0.000273, - 0.000103, - 0.000433, - 3.6e-05, - 1.7e-05 - ] - }, - { - "name": "Thermoleophilales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002775, - 0.002486, - 0.002928, - 0.003203, - 0.002468, - 0.001219, - 0.001766, - 0.001966, - 0.000892, - 0.002311, - 0.001827, - 0.001946, - 0.002286, - 0.002046, - 0.0026899999999999997, - 0.00132, - 0.001292, - 0.000733, - 0.001077, - 0.002038, - 0.002538, - 0.0013449999999999998, - 0.001258, - 0.001009, - 0.001684, - 0.0011279999999999999, - 0.001266, - 0.003026, - 0.001394, - 0.001866, - 0.001202, - 0.0006799999999999999, - 0.000711, - 0.00042, - 0.001241, - 0.000455, - 2.1e-05, - 0.000188, - 1e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Thermomicrobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.003052, - 0.003919, - 0.004268999999999999, - 0.002023, - 0.002964, - 0.002294, - 0.0029230000000000003, - 0.001667, - 0.001106, - 0.0030989999999999998, - 0.001256, - 0.001338, - 0.002707, - 0.002649, - 0.001475, - 0.00117, - 0.002079, - 0.001228, - 0.001801, - 0.0016239999999999998, - 0.001645, - 0.0013650000000000001, - 0.001835, - 0.001222, - 0.000542, - 0.001778, - 0.000729, - 0.00108, - 0.000496, - 0.000848, - 0.000542, - 0.001268, - 0.000872, - 0.000556, - 0.00053, - 0.000364, - 9.300000000000001e-05, - 0.000151, - 5.2000000000000004e-05, - 7.8e-05 - ] - }, - { - "name": "Microascales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.003409, - 0.003157, - 0.002525, - 0.002135, - 0.002625, - 0.001864, - 0.0020989999999999997, - 0.0018260000000000001, - 0.0019309999999999998, - 0.00197, - 0.0016899999999999999, - 0.001034, - 0.001745, - 0.0017219999999999998, - 0.0010960000000000002, - 0.001766, - 0.00149, - 0.001191, - 0.001616, - 0.0022960000000000003, - 0.002301, - 0.0015279999999999998, - 0.001625, - 0.001405, - 0.000668, - 0.001797, - 0.000865, - 0.000897, - 0.000679, - 0.000655, - 0.001039, - 0.0008539999999999999, - 0.0007570000000000001, - 0.000661, - 0.000504, - 0.00028399999999999996, - 5.2000000000000004e-05, - 0.000169, - 2.1e-05, - 4.3e-05 - ] - }, - { - "name": "Geastrales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002775, - 0.002374, - 0.00195, - 0.002572, - 0.0018800000000000002, - 0.0017920000000000002, - 0.0020399999999999997, - 0.0018170000000000003, - 0.0018510000000000002, - 0.0017640000000000002, - 0.002226, - 0.001277, - 0.001384, - 0.002105, - 0.001454, - 0.001405, - 0.001173, - 0.001784, - 0.001389, - 0.0018620000000000002, - 0.00145, - 0.000927, - 0.001625, - 0.0016760000000000002, - 0.0012490000000000001, - 0.00195, - 0.001731, - 0.000891, - 0.001102, - 0.00108, - 0.001021, - 0.0010199999999999999, - 0.000688, - 0.000877, - 0.000582, - 0.00038700000000000003, - 0.000103, - 0.00033, - 8.2e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Methylacidiphilales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002893, - 0.001366, - 0.002205, - 0.003691, - 0.001987, - 0.003083, - 0.001609, - 0.0026780000000000003, - 0.001572, - 0.001585, - 0.001906, - 0.000547, - 0.001564, - 0.001236, - 0.0008789999999999999, - 0.001338, - 0.002391, - 0.000959, - 0.001482, - 0.0018620000000000002, - 0.0021190000000000002, - 0.002343, - 0.001625, - 0.001263, - 0.000455, - 0.0018449999999999999, - 0.000572, - 0.000758, - 0.000336, - 0.00035499999999999996, - 0.0005059999999999999, - 0.001376, - 0.000436, - 0.000624, - 0.001035, - 0.00028399999999999996, - 5.2000000000000004e-05, - 6.6e-05, - 1e-05, - 1.7e-05 - ] - }, - { - "name": "Leucosporidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.003092, - 0.002038, - 0.002344, - 0.002349, - 0.001673, - 0.002007, - 0.0015890000000000001, - 0.0016760000000000002, - 0.001732, - 0.001702, - 0.001416, - 0.001703, - 0.001263, - 0.001516, - 0.0010630000000000001, - 0.001332, - 0.00119, - 0.000642, - 0.0012369999999999998, - 0.001727, - 0.002203, - 0.001426, - 0.001468, - 0.001009, - 0.0008810000000000001, - 0.001415, - 0.0020670000000000003, - 0.000834, - 0.0013210000000000001, - 0.00047000000000000004, - 0.001391, - 0.000754, - 0.00062, - 0.000797, - 0.00042699999999999997, - 0.000296, - 4.1e-05, - 0.000151, - 2.6000000000000002e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Limnochordales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002259, - 0.0026420000000000003, - 0.002764, - 0.00185, - 0.002434, - 0.0017920000000000002, - 0.002903, - 0.001283, - 0.001518, - 0.002275, - 0.0012900000000000001, - 0.001034, - 0.001745, - 0.0019579999999999997, - 0.0009220000000000001, - 0.0014529999999999999, - 0.0020510000000000003, - 0.001088, - 0.0014730000000000001, - 0.001583, - 0.002231, - 0.001151, - 0.001101, - 0.001228, - 0.0005610000000000001, - 0.0011949999999999999, - 0.000408, - 0.000947, - 0.00041600000000000003, - 0.000663, - 0.00041600000000000003, - 0.001517, - 0.000688, - 0.0007160000000000001, - 0.000789, - 0.000398, - 4.1e-05, - 6.6e-05, - 1e-05, - 3.5e-05 - ] - }, - { - "name": "Kiloniellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002497, - 0.002127, - 0.002081, - 0.0024100000000000002, - 0.001847, - 0.002509, - 0.002079, - 0.0022010000000000003, - 0.001718, - 0.0018, - 0.0018039999999999998, - 0.000608, - 0.001564, - 0.001884, - 0.000868, - 0.0012900000000000001, - 0.00098, - 0.000874, - 0.0011359999999999999, - 0.001996, - 0.002538, - 0.0017629999999999998, - 0.001782, - 0.0011099999999999999, - 0.00041600000000000003, - 0.001883, - 0.000551, - 0.000606, - 0.0005690000000000001, - 0.00037, - 0.000524, - 0.0006219999999999999, - 0.000849, - 0.000624, - 0.000944, - 0.000273, - 0.000144, - 8.499999999999999e-05, - 2.1e-05, - 3.5e-05 - ] - }, - { - "name": "Nitriliruptorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002735, - 0.002239, - 0.002624, - 0.00246, - 0.002194, - 0.002079, - 0.001726, - 0.001302, - 0.0014789999999999998, - 0.002042, - 0.001301, - 0.0009119999999999999, - 0.002286, - 0.00212, - 0.0013779999999999999, - 0.001326, - 0.001626, - 0.0008550000000000001, - 0.001423, - 0.0012929999999999999, - 0.0019379999999999998, - 0.000999, - 0.0013109999999999999, - 0.001127, - 0.00062, - 0.00108, - 0.0005650000000000001, - 0.001067, - 0.000562, - 0.000794, - 0.00066, - 0.001078, - 0.0005740000000000001, - 0.0005740000000000001, - 0.00075, - 0.00041, - 2.1e-05, - 5.6000000000000006e-05, - 5e-06, - 4.3e-05 - ] - }, - { - "name": "Desulfurococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002418, - 0.002374, - 0.003052, - 0.001983, - 0.0024010000000000004, - 0.0017920000000000002, - 0.002433, - 0.001423, - 0.0013449999999999998, - 0.002015, - 0.0014730000000000001, - 0.000852, - 0.001865, - 0.00209, - 0.0008789999999999999, - 0.0012779999999999998, - 0.0021920000000000004, - 0.0009289999999999999, - 0.001204, - 0.001789, - 0.001422, - 0.000713, - 0.00173, - 0.001234, - 0.0006, - 0.0012900000000000001, - 0.000508, - 0.000518, - 0.00045999999999999996, - 0.000455, - 0.000515, - 0.00116, - 0.000413, - 0.00043799999999999997, - 0.000285, - 0.00041, - 1e-05, - 7.5e-05, - 1.4999999999999999e-05, - 6.1e-05 - ] - }, - { - "name": "Ceraceosorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002378, - 0.001679, - 0.0027890000000000002, - 0.001484, - 0.001565, - 0.001936, - 0.001648, - 0.001292, - 0.001598, - 0.001469, - 0.0010960000000000002, - 0.000547, - 0.0016239999999999998, - 0.001354, - 0.0012369999999999998, - 0.001363, - 0.0011330000000000001, - 0.000947, - 0.001347, - 0.001334, - 0.001994, - 0.000734, - 0.001835, - 0.001287, - 0.001355, - 0.001482, - 0.001852, - 0.000726, - 0.001218, - 0.000532, - 0.0015, - 0.0008789999999999999, - 0.000551, - 0.000469, - 0.000336, - 0.000364, - 2.1e-05, - 0.000198, - 2.6000000000000002e-05, - 3.5e-05 - ] - }, - { - "name": "Kordiimonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002616, - 0.002598, - 0.0023120000000000003, - 0.001891, - 0.00207, - 0.002294, - 0.001923, - 0.001564, - 0.001359, - 0.0020239999999999998, - 0.001347, - 0.00073, - 0.001504, - 0.001575, - 0.000944, - 0.001158, - 0.000889, - 0.000868, - 0.0011949999999999999, - 0.001738, - 0.002105, - 0.001182, - 0.001258, - 0.00095, - 0.0007070000000000001, - 0.001338, - 0.000586, - 0.000739, - 0.000518, - 0.00044699999999999997, - 0.000687, - 0.000522, - 0.000734, - 0.00047599999999999997, - 0.000556, - 0.000307, - 1e-05, - 0.000122, - 2.1e-05, - 6.1e-05 - ] - }, - { - "name": "Tritrichomonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002061, - 0.00159, - 0.001398, - 0.001291, - 0.001076, - 0.000789, - 0.001216, - 0.001142, - 0.002065, - 0.001048, - 0.00121, - 0.001338, - 0.000541, - 0.000839, - 0.0013779999999999999, - 0.002363, - 0.001263, - 0.001301, - 0.001355, - 0.0013859999999999999, - 0.001199, - 0.000601, - 0.000944, - 0.002355, - 0.001336, - 0.0010609999999999999, - 0.002238, - 0.000701, - 0.00186, - 0.000648, - 0.0022140000000000003, - 0.00126, - 0.00039, - 0.0005, - 0.000362, - 0.000171, - 4.1e-05, - 0.000151, - 6.2e-05, - 3.5e-05 - ] - }, - { - "name": "Microbotryales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002576, - 0.001679, - 0.002163, - 0.001444, - 0.0016309999999999999, - 0.001577, - 0.0015890000000000001, - 0.0013859999999999999, - 0.0017850000000000001, - 0.0014060000000000001, - 0.0011300000000000001, - 0.0010949999999999998, - 0.001504, - 0.001354, - 0.0009, - 0.001513, - 0.0009689999999999999, - 0.000782, - 0.001212, - 0.001562, - 0.00145, - 0.000601, - 0.000944, - 0.001151, - 0.001075, - 0.001424, - 0.00201, - 0.00046699999999999997, - 0.000883, - 0.000424, - 0.0022140000000000003, - 0.0008539999999999999, - 0.000367, - 0.000463, - 0.000375, - 0.000262, - 5.2000000000000004e-05, - 0.000188, - 1.4999999999999999e-05, - 3.5e-05 - ] - }, - { - "name": "Thermoplasmatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0022199999999999998, - 0.00159, - 0.0021219999999999998, - 0.0015660000000000001, - 0.0017059999999999998, - 0.001864, - 0.001923, - 0.0013109999999999999, - 0.001385, - 0.0019260000000000002, - 0.001027, - 0.000852, - 0.001865, - 0.001531, - 0.000933, - 0.00135, - 0.003082, - 0.001075, - 0.001389, - 0.001583, - 0.0013800000000000002, - 0.0008150000000000001, - 0.000682, - 0.001352, - 0.0006580000000000001, - 0.0012619999999999999, - 0.000644, - 0.000606, - 0.000489, - 0.000478, - 0.000696, - 0.001243, - 0.000229, - 0.0006360000000000001, - 0.00031, - 0.000205, - 2.1e-05, - 0.00014099999999999998, - 2.1e-05, - 3.5e-05 - ] - }, - { - "name": "Georgefischeriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.004717, - 0.001366, - 0.003554, - 0.001444, - 0.0021609999999999997, - 0.000932, - 0.001236, - 0.001161, - 0.001532, - 0.001782, - 0.0009480000000000001, - 0.000608, - 0.001143, - 0.001884, - 0.001009, - 0.001158, - 0.000708, - 0.0007030000000000001, - 0.0011359999999999999, - 0.001655, - 0.001213, - 0.000927, - 0.001101, - 0.000933, - 0.000949, - 0.0011279999999999999, - 0.0015810000000000002, - 0.0007830000000000001, - 0.0007440000000000001, - 0.00064, - 0.0009310000000000001, - 0.000771, - 0.0005740000000000001, - 0.000352, - 0.00022, - 0.000307, - 3.1e-05, - 6.6e-05, - 1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Nitrospinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002299, - 0.001948, - 0.001982, - 0.001596, - 0.0014990000000000001, - 0.002079, - 0.0015300000000000001, - 0.001517, - 0.001279, - 0.001997, - 0.001256, - 0.00073, - 0.0009019999999999999, - 0.0011330000000000001, - 0.0005639999999999999, - 0.001441, - 0.0019320000000000001, - 0.000807, - 0.001094, - 0.0019140000000000001, - 0.001715, - 0.001212, - 0.001258, - 0.00108, - 0.00038700000000000003, - 0.001443, - 0.00035, - 0.000796, - 0.000263, - 0.000401, - 0.000244, - 0.00121, - 0.0008029999999999999, - 0.000599, - 0.000517, - 0.000262, - 1e-05, - 5.6000000000000006e-05, - 1.4999999999999999e-05, - 3.5e-05 - ] - }, - { - "name": "Chrysiogenales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.003171, - 0.0008960000000000001, - 0.002065, - 0.0008849999999999999, - 0.001615, - 0.002868, - 0.001, - 0.00118, - 0.001998, - 0.001039, - 0.000719, - 0.00073, - 0.001444, - 0.0010890000000000001, - 0.000618, - 0.001369, - 0.0016710000000000002, - 0.001179, - 0.002163, - 0.0012720000000000001, - 0.0016170000000000002, - 0.000754, - 0.003303, - 0.0008560000000000001, - 0.00041600000000000003, - 0.000985, - 0.000336, - 0.000518, - 0.000292, - 0.00024700000000000004, - 0.000443, - 0.0009029999999999999, - 0.000459, - 0.00063, - 0.000478, - 0.00022799999999999999, - 2.1e-05, - 3.8e-05, - 1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Cercomonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0019030000000000002, - 0.000739, - 0.001078, - 0.000651, - 0.000596, - 0.001577, - 0.00023500000000000002, - 0.0010019999999999999, - 0.002105, - 0.000412, - 0.000525, - 0.004075, - 5.9999999999999995e-05, - 0.000339, - 0.000976, - 0.002532, - 0.000544, - 0.000984, - 0.000833, - 0.001593, - 0.001199, - 0.001212, - 0.000891, - 0.002113, - 0.0022559999999999998, - 0.000698, - 0.002117, - 0.00067, - 0.001124, - 0.000679, - 0.002973, - 0.0008039999999999999, - 0.000138, - 0.0008029999999999999, - 0.000388, - 3.4e-05, - 5.2000000000000004e-05, - 0.00016, - 1e-05, - null - ] - }, - { - "name": "Kickxellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001585, - 0.001299, - 0.001472, - 0.00123, - 0.001118, - 0.001721, - 0.001157, - 0.001068, - 0.001585, - 0.001003, - 0.0008900000000000001, - 0.001399, - 0.000722, - 0.0010890000000000001, - 0.001161, - 0.001411, - 0.000867, - 0.000788, - 0.001431, - 0.0009720000000000001, - 0.001046, - 0.000611, - 0.001048, - 0.001358, - 0.0018100000000000002, - 0.000755, - 0.00246, - 0.000916, - 0.001634, - 0.000563, - 0.001852, - 0.0006799999999999999, - 0.000528, - 0.0005059999999999999, - 0.000233, - 9.1e-05, - 5.2000000000000004e-05, - 0.000254, - null, - 2.6000000000000002e-05 - ] - }, - { - "name": "Parvularculales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002299, - 0.002284, - 0.0020559999999999997, - 0.001739, - 0.002269, - 0.001434, - 0.001373, - 0.001208, - 0.000986, - 0.001872, - 0.0008789999999999999, - 0.0011560000000000001, - 0.001324, - 0.002061, - 0.0008349999999999999, - 0.001182, - 0.001008, - 0.000941, - 0.0009339999999999999, - 0.0012929999999999999, - 0.0011710000000000002, - 0.001049, - 0.001363, - 0.001027, - 0.000591, - 0.000889, - 0.000637, - 0.0005679999999999999, - 0.000496, - 0.00037799999999999997, - 0.000795, - 0.000763, - 0.000298, - 0.000414, - 0.000336, - 0.000148, - null, - 8.499999999999999e-05, - 2.6000000000000002e-05, - 3.5e-05 - ] - }, - { - "name": "Cardiobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00214, - 0.00206, - 0.00232, - 0.001657, - 0.002012, - 0.002294, - 0.0020210000000000002, - 0.001545, - 0.0009460000000000001, - 0.002329, - 0.00145, - 0.000304, - 0.001023, - 0.001428, - 0.0007379999999999999, - 0.0009710000000000001, - 0.001139, - 0.00066, - 0.0007070000000000001, - 0.001924, - 0.0017989999999999998, - 0.0008349999999999999, - 0.0009960000000000001, - 0.000974, - 0.00032900000000000003, - 0.001443, - 0.000272, - 0.00038500000000000003, - 0.000263, - 0.000293, - 0.000307, - 0.0008210000000000001, - 0.000367, - 0.00035800000000000003, - 0.000556, - 0.000319, - 3.1e-05, - 4.7e-05, - 1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Entomoplasmatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0014269999999999999, - 0.0013880000000000001, - 0.001777, - 0.0008849999999999999, - 0.001217, - 0.001577, - 0.001334, - 0.00103, - 0.000919, - 0.001531, - 0.000594, - 0.001338, - 0.001504, - 0.001016, - 0.0015400000000000001, - 0.00088, - 0.001354, - 0.000837, - 0.0010019999999999999, - 0.000941, - 0.001353, - 0.000601, - 0.0005769999999999999, - 0.0016879999999999998, - 0.001501, - 0.0008320000000000001, - 0.0012439999999999999, - 0.00091, - 0.001656, - 0.00048600000000000005, - 0.001184, - 0.000688, - 0.000298, - 0.0005059999999999999, - 0.00022, - 0.000205, - 0.000103, - 0.000857, - 0.000124, - 6.9e-05 - ] - }, - { - "name": "Salinisphaerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00218, - 0.0016350000000000002, - 0.0022129999999999997, - 0.001505, - 0.0019210000000000002, - 0.001864, - 0.001295, - 0.001236, - 0.001745, - 0.0015140000000000002, - 0.0009699999999999999, - 0.000608, - 0.001444, - 0.0011480000000000001, - 0.000629, - 0.001284, - 0.001258, - 0.000923, - 0.00149, - 0.001458, - 0.001297, - 0.0009880000000000002, - 0.001048, - 0.001116, - 0.000319, - 0.0009939999999999999, - 0.000558, - 0.000499, - 0.000292, - 0.00048600000000000005, - 0.000425, - 0.000779, - 0.0005740000000000001, - 0.000648, - 0.000621, - 0.00013700000000000002, - 1e-05, - 2.8000000000000003e-05, - 1e-05, - 3.5e-05 - ] - }, - { - "name": "Desulfurellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0020210000000000002, - 0.002239, - 0.001925, - 0.000813, - 0.0017469999999999999, - 0.001075, - 0.0017850000000000001, - 0.0011330000000000001, - 0.001185, - 0.001424, - 0.0008900000000000001, - 0.000791, - 0.001444, - 0.001546, - 0.00064, - 0.001212, - 0.002368, - 0.000965, - 0.0010609999999999999, - 0.0013859999999999999, - 0.001827, - 0.000723, - 0.000839, - 0.001251, - 0.00035800000000000003, - 0.000927, - 0.000308, - 0.000379, - 0.000277, - 0.000285, - 0.000434, - 0.001152, - 0.0005740000000000001, - 0.0007599999999999999, - 0.000375, - 0.00025, - null, - 7.5e-05, - 1e-05, - 1.7e-05 - ] - }, - { - "name": "Archaeoglobales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00107, - 0.0017239999999999998, - 0.0018510000000000002, - 0.000986, - 0.001433, - 0.001434, - 0.0011380000000000001, - 0.000805, - 0.000906, - 0.001209, - 0.000833, - 0.000608, - 0.001023, - 0.0010890000000000001, - 0.0007480000000000001, - 0.000995, - 0.0016829999999999998, - 0.005927, - 0.00085, - 0.0008789999999999999, - 0.001157, - 0.000509, - 0.000891, - 0.0009029999999999999, - 0.000484, - 0.001051, - 0.000429, - 0.00042300000000000004, - 0.000525, - 0.000478, - 0.00037, - 0.0009609999999999999, - 0.000436, - 0.00045700000000000005, - 0.000233, - 0.000148, - 2.1e-05, - 9.4e-05, - 2.1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Cystofilobasidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001387, - 0.001791, - 0.0018920000000000002, - 0.001464, - 0.0009109999999999999, - 0.0005740000000000001, - 0.001471, - 0.001217, - 0.001052, - 0.001173, - 0.0011070000000000001, - 0.000973, - 0.000722, - 0.001295, - 0.002376, - 0.0009220000000000001, - 0.001093, - 0.0005740000000000001, - 0.000926, - 0.001065, - 0.001353, - 0.000611, - 0.000944, - 0.0008439999999999999, - 0.000958, - 0.0008699999999999999, - 0.0014449999999999999, - 0.000695, - 0.0008029999999999999, - 0.000586, - 0.000958, - 0.000663, - 0.000321, - 0.000469, - 0.000233, - 0.000171, - 2.1e-05, - 7.5e-05, - 7.7e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Magnetococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002299, - 0.00159, - 0.001777, - 0.001291, - 0.001433, - 0.001434, - 0.001099, - 0.001255, - 0.001026, - 0.0012720000000000001, - 0.001027, - 0.000669, - 0.001263, - 0.00103, - 0.000824, - 0.001019, - 0.0014960000000000002, - 0.000678, - 0.001145, - 0.0012519999999999999, - 0.00159, - 0.00109, - 0.0013109999999999999, - 0.000944, - 0.0003, - 0.0011279999999999999, - 0.000322, - 0.0005809999999999999, - 0.000379, - 0.00041600000000000003, - 0.000479, - 0.0008539999999999999, - 0.000344, - 0.000556, - 0.000556, - 0.000239, - 1e-05, - 1.9e-05, - 1e-05, - 6.9e-05 - ] - }, - { - "name": "Trichomonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000713, - 0.001075, - 0.001004, - 0.001159, - 0.0009609999999999999, - 0.000932, - 0.0009609999999999999, - 0.0007769999999999999, - 0.0016120000000000002, - 0.001057, - 0.000936, - 0.0016420000000000002, - 0.000722, - 0.000883, - 0.001323, - 0.001405, - 0.001082, - 0.000654, - 0.000842, - 0.000962, - 0.001143, - 0.000611, - 0.000734, - 0.001328, - 0.001956, - 0.000688, - 0.002196, - 0.0009289999999999999, - 0.0011970000000000001, - 0.000771, - 0.001482, - 0.0008619999999999999, - 0.000459, - 0.000389, - 0.000233, - 8e-05, - 4.1e-05, - 0.000226, - 5e-06, - 2.6000000000000002e-05 - ] - }, - { - "name": "Physariida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000396, - 0.000336, - 0.000337, - 0.000437, - 0.000306, - 0.000502, - 0.000294, - 0.000375, - 0.000826, - 0.000278, - 0.000377, - 0.003406, - 5.9999999999999995e-05, - 0.000442, - 0.001356, - 0.001007, - 0.0009119999999999999, - 0.00055, - 0.0007070000000000001, - 0.00061, - 0.000516, - 0.000377, - 0.000262, - 0.0017289999999999999, - 0.0019850000000000002, - 0.000516, - 0.006587000000000001, - 0.000834, - 0.00359, - 0.00091, - 0.002846, - 0.000572, - 0.000207, - 0.00033999999999999997, - 0.000259, - 2.3e-05, - 2.1e-05, - 0.000217, - 1e-05, - 1.7e-05 - ] - }, - { - "name": "Colpodida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 2.2e-05, - null, - 2e-05, - 8e-06, - 0.00028700000000000004, - null, - 6.6e-05, - 0.000426, - null, - 2.3e-05, - 0.000973, - null, - 1.4999999999999999e-05, - 0.001811, - 0.000283, - 0.000244, - 0.000733, - 0.001389, - 0.000434, - 2.8000000000000003e-05, - 4.1e-05, - null, - 0.00015900000000000002, - 0.013475999999999998, - 4.8e-05, - 0.004012, - 0.001478, - 0.001598, - 0.000941, - 0.0036780000000000003, - 0.00022400000000000002, - 4.6e-05, - 0.00035800000000000003, - 3.9e-05, - null, - 4.1e-05, - 0.001855, - null, - null - ] - }, - { - "name": "Pneumocystidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001506, - 0.000739, - 0.0010279999999999998, - 0.000813, - 0.000828, - 0.000789, - 0.00053, - 0.00059, - 0.0013449999999999998, - 0.000708, - 0.000605, - 0.002007, - 0.000602, - 0.000603, - 0.0010960000000000002, - 0.0010609999999999999, - 0.0007480000000000001, - 0.000837, - 0.0010689999999999999, - 0.000714, - 0.00045999999999999996, - 0.00041799999999999997, - 0.000734, - 0.001239, - 0.001791, - 0.00043, - 0.002281, - 0.000752, - 0.002408, - 0.00074, - 0.002376, - 0.0008039999999999999, - 4.6e-05, - 0.000377, - 0.000297, - 0.000125, - 1e-05, - 0.000188, - 1e-05, - 9e-06 - ] - }, - { - "name": "Erysiphales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002378, - 0.001344, - 0.001176, - 0.001159, - 0.001068, - 0.001721, - 0.000883, - 0.000918, - 0.001039, - 0.000958, - 0.000936, - 0.000791, - 0.000662, - 0.0009130000000000001, - 0.000857, - 0.000959, - 0.0006799999999999999, - 0.000532, - 0.00101, - 0.0013859999999999999, - 0.001032, - 0.000907, - 0.001363, - 0.000773, - 0.0009199999999999999, - 0.0009939999999999999, - 0.000965, - 0.000417, - 0.000708, - 0.000609, - 0.001428, - 0.0005549999999999999, - 0.000298, - 0.000482, - 0.000297, - 0.00011399999999999999, - 1e-05, - 0.000226, - 1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Acholeplasmatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001467, - 0.000985, - 0.0009460000000000001, - 0.001068, - 0.0008529999999999999, - 0.001004, - 0.001118, - 0.000758, - 0.001159, - 0.00086, - 0.000776, - 0.0010949999999999998, - 0.001324, - 0.001016, - 0.000868, - 0.001013, - 0.001048, - 0.000593, - 0.0008, - 0.000993, - 0.001046, - 0.000734, - 0.000839, - 0.000968, - 0.000745, - 0.000985, - 0.00088, - 0.0008269999999999999, - 0.00081, - 0.000625, - 0.000831, - 0.0008039999999999999, - 0.000528, - 0.000296, - 0.000323, - 0.000523, - 0.000412, - 0.000678, - 0.000175, - 0.000521 - ] - }, - { - "name": "Coniochaetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002061, - 0.001344, - 0.001621, - 0.001525, - 0.001358, - 0.0012900000000000001, - 0.0010400000000000001, - 0.001011, - 0.000986, - 0.001397, - 0.000925, - 0.000791, - 0.001023, - 0.00106, - 0.000651, - 0.001001, - 0.000889, - 0.000813, - 0.000993, - 0.0012, - 0.001199, - 0.000805, - 0.001153, - 0.000679, - 0.000484, - 0.0009460000000000001, - 0.000429, - 0.00043, - 0.00047400000000000003, - 0.00044, - 0.000669, - 0.00042300000000000004, - 0.000344, - 0.000797, - 0.000349, - 0.000171, - 3.1e-05, - 2.8000000000000003e-05, - 1.4999999999999999e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Methanocellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001704, - 0.001209, - 0.0013570000000000001, - 0.0012, - 0.001035, - 0.002151, - 0.000883, - 0.00103, - 0.000653, - 0.001191, - 0.0008560000000000001, - 0.000669, - 0.000782, - 0.000927, - 0.001269, - 0.000874, - 0.001513, - 0.000538, - 0.000657, - 0.001159, - 0.000976, - 0.000571, - 0.0013109999999999999, - 0.00075, - 0.000484, - 0.001233, - 0.000522, - 0.0006320000000000001, - 0.000263, - 0.001288, - 0.000768, - 0.000754, - 0.000298, - 0.000272, - 0.000362, - 0.000205, - 2.1e-05, - 1.9e-05, - 5e-06, - 9e-06 - ] - }, - { - "name": "Immundisolibacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.002497, - 0.001545, - 0.00139, - 0.00119, - 0.00135, - 0.0012900000000000001, - 0.001275, - 0.00118, - 0.0013449999999999998, - 0.001164, - 0.0010960000000000002, - 6.1e-05, - 0.000782, - 0.000868, - 0.000521, - 0.000947, - 0.0009460000000000001, - 0.000684, - 0.001019, - 0.001324, - 0.00145, - 0.0011, - 0.0005769999999999999, - 0.000938, - 0.00023199999999999997, - 0.001023, - 0.000293, - 0.000392, - 0.000285, - 0.000332, - 0.000181, - 0.000663, - 0.0007570000000000001, - 0.000488, - 0.000763, - 0.000102, - 3.1e-05, - 5.6000000000000006e-05, - 1.4999999999999999e-05, - 1.7e-05 - ] - }, - { - "name": "Thaumatomonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001031, - 0.0009630000000000001, - 0.000987, - 0.00058, - 0.000828, - 0.000717, - 0.000294, - 0.000646, - 0.002238, - 0.0005549999999999999, - 0.000411, - 0.001034, - 0.000241, - 0.000324, - 0.000998, - 0.001489, - 0.000295, - 0.00038500000000000003, - 0.0006900000000000001, - 0.001572, - 0.00099, - 0.001029, - 0.000786, - 0.000679, - 0.0017230000000000001, - 0.000726, - 0.001802, - 0.000644, - 0.0009119999999999999, - 0.00040899999999999997, - 0.002376, - 0.000439, - 0.00039, - 0.00043200000000000004, - 0.000207, - 5.6999999999999996e-05, - null, - 0.000198, - 1e-05, - 1.7e-05 - ] - }, - { - "name": "Acidothermales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0016649999999999998, - 0.0013210000000000001, - 0.001637, - 0.00185, - 0.001134, - 0.001219, - 0.0011769999999999999, - 0.0008609999999999999, - 0.000759, - 0.000967, - 0.000925, - 0.000426, - 0.0012029999999999999, - 0.001163, - 0.000965, - 0.000591, - 0.000646, - 0.000495, - 0.000918, - 0.0009310000000000001, - 0.0009199999999999999, - 0.0008460000000000001, - 0.001101, - 0.000454, - 0.000339, - 0.000698, - 0.00035800000000000003, - 0.00091, - 0.000343, - 0.0007559999999999999, - 0.000389, - 0.00040599999999999995, - 0.000482, - 0.000309, - 0.000608, - 0.00013700000000000002, - null, - 7.5e-05, - 5e-06, - null - ] - }, - { - "name": "Puniceicoccales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001625, - 0.001276, - 0.001275, - 0.000986, - 0.001052, - 0.000717, - 0.001, - 0.000993, - 0.000932, - 0.0010119999999999999, - 0.0008560000000000001, - 0.000547, - 0.0012029999999999999, - 0.001119, - 0.000412, - 0.001127, - 0.0018239999999999999, - 0.000599, - 0.0007830000000000001, - 0.00151, - 0.0013800000000000002, - 0.000723, - 0.000524, - 0.000986, - 0.00029, - 0.0007740000000000001, - 0.000293, - 0.000392, - 0.000182, - 0.00027, - 0.00031600000000000004, - 0.000953, - 0.000229, - 0.000371, - 0.000388, - 0.000125, - 1e-05, - 3.8e-05, - 5e-06, - 5.2000000000000004e-05 - ] - }, - { - "name": "Petrotogales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001308, - 0.0008960000000000001, - 0.001341, - 0.000722, - 0.001168, - 0.001219, - 0.001157, - 0.0007769999999999999, - 0.001265, - 0.001137, - 0.000731, - 0.001034, - 0.001023, - 0.000839, - 0.000597, - 0.001308, - 0.001977, - 0.00066, - 0.000589, - 0.000734, - 0.001102, - 0.00041799999999999997, - 0.000734, - 0.001027, - 0.000339, - 0.0005740000000000001, - 0.000393, - 0.000505, - 0.000241, - 0.000254, - 0.000298, - 0.0010609999999999999, - 0.000229, - 0.0008089999999999999, - 0.000233, - 0.000205, - 1e-05, - 2.8000000000000003e-05, - 5e-06, - 3.5e-05 - ] - }, - { - "name": "Protosteliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000713, - 0.000246, - 0.000206, - 0.000295, - 0.000215, - 0.0006450000000000001, - 0.000294, - 0.000384, - 0.000333, - 0.000251, - 0.000377, - 0.0017640000000000002, - null, - 0.000162, - 0.000466, - 0.000597, - 0.000306, - 0.00018899999999999999, - 0.000286, - 0.000538, - 0.0009199999999999999, - 0.000336, - 0.000105, - 0.001493, - 0.002091, - 0.000449, - 0.003511, - 0.0006190000000000001, - 0.003407, - 0.000663, - 0.005936, - 0.00029, - 0.00011499999999999999, - 0.000148, - 0.000207, - 1.1e-05, - 3.1e-05, - 0.000198, - 1e-05, - null - ] - }, - { - "name": "Venturiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001348, - 0.001209, - 0.001456, - 0.001312, - 0.00101, - 0.000789, - 0.0008039999999999999, - 0.001086, - 0.000932, - 0.0008150000000000001, - 0.0009019999999999999, - 0.000487, - 0.000421, - 0.001295, - 0.000944, - 0.00082, - 0.000759, - 0.00058, - 0.0009599999999999999, - 0.001221, - 0.000878, - 0.000805, - 0.0009960000000000001, - 0.000773, - 0.000503, - 0.00064, - 0.0005009999999999999, - 0.00043, - 0.00041600000000000003, - 0.000339, - 0.0006320000000000001, - 0.0005639999999999999, - 0.000321, - 0.00045099999999999996, - 0.000233, - 0.000102, - 1e-05, - 0.000132, - 1.4999999999999999e-05, - 1.7e-05 - ] - }, - { - "name": "Kosmotogales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001268, - 0.001052, - 0.001217, - 0.0008849999999999999, - 0.000869, - 0.001075, - 0.001, - 0.001086, - 0.000799, - 0.001003, - 0.0007650000000000001, - 0.000791, - 0.000662, - 0.000839, - 0.0007379999999999999, - 0.001025, - 0.001462, - 0.000446, - 0.0008, - 0.001117, - 0.001185, - 0.00055, - 0.000786, - 0.001003, - 0.000339, - 0.000593, - 0.000315, - 0.00043, - 0.000277, - 0.000308, - 0.000361, - 0.0009119999999999999, - 6.9e-05, - 0.000327, - 0.000259, - 0.000125, - 3.1e-05, - 6.6e-05, - 3.1e-05, - 6.1e-05 - ] - }, - { - "name": "Vampyrellida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 0.00022400000000000002, - 0.000395, - 0.00020299999999999997, - 0.000132, - null, - 0.000333, - 0.000234, - 0.000373, - 0.000143, - 0.000148, - 0.0032240000000000003, - 5.9999999999999995e-05, - 0.000162, - 0.000152, - 0.000386, - 0.00024900000000000004, - 0.000587, - 0.000665, - 0.000352, - 0.000349, - 0.000245, - null, - 0.000767, - 0.002014, - 9.6e-05, - 0.0067659999999999994, - 0.000272, - 0.003626, - 0.000478, - 0.002259, - 0.00023199999999999997, - 2.3e-05, - 0.00019099999999999998, - 0.00011599999999999999, - null, - 2.1e-05, - 0.000198, - 5e-06, - null - ] - }, - { - "name": "Brachyspirales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001268, - 0.0009630000000000001, - 0.001324, - 0.000712, - 0.0007700000000000001, - 0.000789, - 0.001059, - 0.000758, - 0.001225, - 0.000725, - 0.000491, - 0.000426, - 0.000602, - 0.000589, - 0.0006730000000000001, - 0.001429, - 0.001394, - 0.0005740000000000001, - 0.000926, - 0.000796, - 0.000683, - 0.000683, - 0.00041900000000000005, - 0.00085, - 0.000368, - 0.000545, - 0.00025, - 0.000379, - 0.000365, - 0.000285, - 0.00037, - 0.0008210000000000001, - 0.000482, - 0.000371, - 0.000181, - 0.000125, - null, - 0.00010400000000000001, - 1e-05, - null - ] - }, - { - "name": "Verrucariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001546, - 0.001142, - 0.0013160000000000001, - 0.001057, - 0.001018, - 0.0006450000000000001, - 0.000863, - 0.000852, - 0.000906, - 0.000725, - 0.000742, - 0.000365, - 0.000662, - 0.0009130000000000001, - 0.0005099999999999999, - 0.000766, - 0.000895, - 0.00042199999999999996, - 0.000614, - 0.000941, - 0.001269, - 0.000713, - 0.000524, - 0.000496, - 0.00038700000000000003, - 0.0007070000000000001, - 0.000479, - 0.00025299999999999997, - 0.000401, - 0.00020800000000000001, - 0.000452, - 0.000414, - 0.000413, - 0.000327, - 0.000323, - 0.000171, - null, - 6.6e-05, - 3.1e-05, - 1.7e-05 - ] - }, - { - "name": "Chitinispirillales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000713, - 0.0008060000000000001, - 0.000798, - 0.00062, - 0.000604, - 0.001147, - 0.000726, - 0.000824, - 0.000892, - 0.000519, - 0.000537, - 0.00073, - 0.000602, - 0.000603, - 0.00042300000000000004, - 0.001001, - 0.003909, - 0.000391, - 0.000589, - 0.000641, - 0.000739, - 0.000713, - 0.000315, - 0.000938, - 0.000252, - 0.00065, - 0.000272, - 0.000354, - 0.000197, - 0.000254, - 0.000488, - 0.001094, - 0.000207, - 0.000278, - 0.000272, - 6.8e-05, - 1e-05, - 2.8000000000000003e-05, - 1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Neolectales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0008320000000000001, - 0.0006490000000000001, - 0.0005679999999999999, - 0.000763, - 0.000629, - 0.000789, - 0.000275, - 0.000552, - 0.000679, - 0.000439, - 0.000582, - 0.0017640000000000002, - 0.00018, - 0.000383, - 0.00047699999999999994, - 0.000766, - 0.000436, - 0.000379, - 0.00043799999999999997, - 0.00061, - 0.000851, - 0.000275, - 0.000367, - 0.001263, - 0.0008710000000000001, - 0.000373, - 0.00221, - 0.000379, - 0.001591, - 0.000609, - 0.0014550000000000001, - 0.00046399999999999995, - 0.000161, - 0.000482, - 0.000155, - 8e-05, - null, - 8.499999999999999e-05, - 5e-06, - 1.7e-05 - ] - }, - { - "name": "Gloeoemargaritales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001823, - 0.0013210000000000001, - 0.0008640000000000001, - 0.0009050000000000001, - 0.000671, - 0.0006450000000000001, - 0.0009220000000000001, - 0.001077, - 0.000466, - 0.0007700000000000001, - 0.000571, - 0.000304, - 0.000782, - 0.000883, - 0.000401, - 0.00037999999999999997, - 0.0006, - 0.000342, - 0.000471, - 0.000983, - 0.001046, - 0.0005200000000000001, - 0.000786, - 0.00036, - 0.00020299999999999997, - 0.000688, - 0.000129, - 0.0007769999999999999, - 0.001058, - 0.00010800000000000001, - 0.000226, - 0.000522, - 0.000367, - 0.000229, - 0.000323, - 0.00028399999999999996, - 0.000134, - 0.000198, - 7.7e-05, - 6.1e-05 - ] - }, - { - "name": "Spirulinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001387, - 0.001008, - 0.001349, - 0.000834, - 0.001052, - 0.001075, - 0.001216, - 0.000824, - 0.0006389999999999999, - 0.001111, - 0.000525, - 0.000547, - 0.000361, - 0.000677, - 0.000553, - 0.000892, - 0.000759, - 0.000532, - 0.0006309999999999999, - 0.0008789999999999999, - 0.000767, - 0.0006519999999999999, - 0.000524, - 0.000573, - 0.000261, - 0.000736, - 0.000193, - 0.000297, - 0.000212, - 0.000185, - 0.000271, - 0.00063, - 0.000229, - 0.000278, - 0.000349, - 0.000182, - 1e-05, - 2.8000000000000003e-05, - 1e-05, - 9e-06 - ] - }, - { - "name": "Xylonomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001387, - 0.0009630000000000001, - 0.0009710000000000001, - 0.00122, - 0.000787, - 0.00086, - 0.0007059999999999999, - 0.0008150000000000001, - 0.000906, - 0.000708, - 0.000833, - 0.000608, - 0.000662, - 0.0007509999999999999, - 0.000466, - 0.000687, - 0.000572, - 0.000452, - 0.000791, - 0.000807, - 0.000753, - 0.00053, - 0.000786, - 0.000567, - 0.00035800000000000003, - 0.000621, - 0.00032900000000000003, - 0.000335, - 0.00037200000000000004, - 0.000262, - 0.000479, - 0.00039, - 0.000275, - 0.000587, - 0.000272, - 0.000171, - 1e-05, - 2.8000000000000003e-05, - 1.4999999999999999e-05, - 1.7e-05 - ] - }, - { - "name": "Dictyoglomales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0005549999999999999, - 0.0017469999999999999, - 0.001645, - 0.0009460000000000001, - 0.001466, - 0.000717, - 0.0014320000000000001, - 0.000655, - 0.0007059999999999999, - 0.001236, - 0.000696, - 0.000122, - 0.000842, - 0.000824, - 0.000174, - 0.000802, - 0.001003, - 0.00038500000000000003, - 0.000547, - 0.000859, - 0.000767, - 0.000509, - 0.000786, - 0.000525, - 0.000155, - 0.0005070000000000001, - 0.00010700000000000001, - 0.000164, - 0.000124, - 0.000154, - 0.000181, - 0.00058, - 0.000321, - 0.00022200000000000003, - 0.000246, - 0.000125, - 2.1e-05, - 1.9e-05, - 1.4999999999999999e-05, - 5.2000000000000004e-05 - ] - }, - { - "name": "Candidatus Altiarchaeales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0014269999999999999, - 0.001254, - 0.001045, - 0.0006, - 0.0008449999999999999, - 0.0005740000000000001, - 0.000745, - 0.000609, - 0.000813, - 0.000869, - 0.000365, - 0.00024300000000000002, - 0.000662, - 0.000603, - 0.000336, - 0.000699, - 0.001847, - 0.00046399999999999995, - 0.000682, - 0.000869, - 0.000544, - 0.00053, - 0.000944, - 0.0007379999999999999, - 0.000194, - 0.000621, - 0.000207, - 0.00025299999999999997, - 0.000175, - 0.000147, - 0.000226, - 0.000663, - 0.000138, - 0.000321, - 0.000129, - 8e-05, - 1e-05, - 2.8000000000000003e-05, - 5e-06, - 9e-06 - ] - }, - { - "name": "Desulfurobacteriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0008320000000000001, - 0.001209, - 0.001078, - 0.000773, - 0.001076, - 0.0006450000000000001, - 0.0007650000000000001, - 0.0007769999999999999, - 0.000533, - 0.001021, - 0.000582, - 0.000547, - 0.000541, - 0.000898, - 0.00028199999999999997, - 0.000796, - 0.001082, - 0.00044, - 0.0007160000000000001, - 0.001024, - 0.000795, - 0.0006219999999999999, - 0.000472, - 0.0006490000000000001, - 0.000155, - 0.000468, - 0.000129, - 0.000278, - 0.000175, - 0.00022400000000000002, - 0.000262, - 0.0007379999999999999, - 0.000229, - 0.000241, - 0.000285, - 6.8e-05, - null, - 6.6e-05, - null, - 9e-06 - ] - }, - { - "name": "Methanomassiliicoccales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001149, - 0.001209, - 0.001201, - 0.00059, - 0.000878, - 0.00035800000000000003, - 0.000785, - 0.000412, - 0.0006929999999999999, - 0.0009939999999999999, - 0.000468, - 0.000304, - 0.001263, - 0.0007650000000000001, - 0.0006730000000000001, - 0.0006450000000000001, - 0.001314, - 0.00042199999999999996, - 0.0005809999999999999, - 0.0006929999999999999, - 0.00041799999999999997, - 0.00032599999999999996, - 0.000682, - 0.000643, - 0.00029, - 0.000459, - 0.000365, - 0.000379, - 0.000146, - 0.000278, - 0.000271, - 0.0006129999999999999, - 0.000207, - 0.00025299999999999997, - 0.000194, - 0.000171, - 1e-05, - 4.7e-05, - 1e-05, - 1.7e-05 - ] - }, - { - "name": "Mariprofundales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001149, - 0.000717, - 0.0009050000000000001, - 0.001037, - 0.0008359999999999999, - 0.0006450000000000001, - 0.000863, - 0.000852, - 0.0006929999999999999, - 0.000976, - 0.00042199999999999996, - 0.000487, - 0.000541, - 0.0009570000000000001, - 0.000293, - 0.000729, - 0.000736, - 0.0005009999999999999, - 0.0006309999999999999, - 0.000724, - 0.001115, - 0.000509, - 0.000682, - 0.000466, - 0.000261, - 0.000717, - 0.000207, - 0.00025299999999999997, - 0.000131, - 0.000154, - 0.00010800000000000001, - 0.0005059999999999999, - 0.000367, - 0.00025299999999999997, - 0.000233, - 0.000102, - 5.2000000000000004e-05, - 3.8e-05, - 1e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Acidilobales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000991, - 0.000851, - 0.0010199999999999999, - 0.000681, - 0.000919, - 0.001075, - 0.0007059999999999999, - 0.000496, - 0.000466, - 0.000824, - 0.000377, - 0.000547, - 0.000782, - 0.0011480000000000001, - 0.00047699999999999994, - 0.000537, - 0.000629, - 0.00165, - 0.000463, - 0.0005070000000000001, - 0.000683, - 0.000275, - 0.00021, - 0.00043099999999999996, - 0.000223, - 0.000488, - 0.00025699999999999996, - 0.00031600000000000004, - 0.00018999999999999998, - 0.000278, - 0.000181, - 0.00039, - 0.000436, - 0.000185, - 0.000233, - 0.000193, - 1e-05, - 6.6e-05, - 5e-06, - 1.7e-05 - ] - }, - { - "name": "Lentisphaerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0008320000000000001, - 0.000918, - 0.0007650000000000001, - 0.00061, - 0.000828, - 0.000215, - 0.000647, - 0.000449, - 0.000759, - 0.000618, - 0.000502, - 0.00073, - 0.000301, - 0.00042699999999999997, - 0.001161, - 0.000772, - 0.0010199999999999999, - 0.000336, - 0.00047999999999999996, - 0.0006309999999999999, - 0.000697, - 0.000479, - 0.000157, - 0.0006259999999999999, - 0.000242, - 0.000296, - 0.000122, - 0.001219, - 0.000379, - 0.000177, - 0.000244, - 0.00058, - 0.000229, - 0.000241, - 0.000194, - 0.000102, - null, - 4.7e-05, - null, - 1.7e-05 - ] - }, - { - "name": "Togniniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001308, - 0.000851, - 0.000732, - 0.0008849999999999999, - 0.000654, - 0.000932, - 0.000549, - 0.000571, - 0.00047999999999999996, - 0.000824, - 0.00045700000000000005, - 0.000608, - 0.000722, - 0.000839, - 0.00044500000000000003, - 0.00041, - 0.000368, - 0.000281, - 0.0004969999999999999, - 0.0006929999999999999, - 0.000669, - 0.0005809999999999999, - 0.000524, - 0.000348, - 0.000484, - 0.000526, - 0.000343, - 0.00025299999999999997, - 0.000263, - 0.0002, - 0.0005690000000000001, - 0.00021600000000000002, - 0.000161, - 0.00021600000000000002, - 0.00031, - 0.000171, - 4.1e-05, - 5.6000000000000006e-05, - 5e-06, - null - ] - }, - { - "name": "Phaeomoniellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001308, - 0.000784, - 0.00088, - 0.000651, - 0.000505, - 0.000932, - 0.00045099999999999996, - 0.000459, - 0.0006129999999999999, - 0.000681, - 0.000571, - 0.000304, - 0.000241, - 0.000603, - 0.000315, - 0.000591, - 0.000521, - 0.00038500000000000003, - 0.000513, - 0.00119, - 0.000753, - 0.0005200000000000001, - 0.00021, - 0.000484, - 0.0005809999999999999, - 0.000717, - 0.000508, - 0.000171, - 0.000233, - 0.00016999999999999999, - 0.000551, - 0.00024900000000000004, - 0.000321, - 0.00022200000000000003, - 0.000207, - 6.8e-05, - null, - 0.00016, - 1e-05, - 1.7e-05 - ] - }, - { - "name": "Euplotida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 6.7e-05, - 9e-05, - 9.2e-05, - 5e-05, - 7.2e-05, - 5.9e-05, - 0.000215, - 0.000959, - 3.6e-05, - 6.8e-05, - 0.000973, - null, - 4.4e-05, - 0.000792, - 0.001037, - 0.00040199999999999996, - 0.001155, - 0.00085, - 0.000352, - 4.2e-05, - 0.000245, - 5.2000000000000004e-05, - 0.000708, - 0.0024980000000000002, - 6.7e-05, - 0.00103, - 0.0006320000000000001, - 0.001576, - 0.000663, - 0.0009130000000000001, - 0.000572, - 2.3e-05, - 0.000408, - 5.2000000000000004e-05, - 1.1e-05, - 1e-05, - 0.000264, - null, - 9e-06 - ] - }, - { - "name": "Euglenales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000198, - 6.7e-05, - 0.000296, - 0.000102, - 0.000215, - 0.000215, - 0.00023500000000000002, - 0.00031800000000000003, - 0.0016120000000000002, - 0.000197, - 8e-05, - 0.002251, - 5.9999999999999995e-05, - 8.8e-05, - 0.000315, - 0.000518, - 0.000363, - 0.000324, - 0.000337, - 0.000455, - 0.000153, - 0.00011200000000000001, - 0.000105, - 0.000443, - 0.000426, - 0.000229, - 0.001016, - 0.000808, - 0.002043, - 0.000625, - 0.0015, - 0.0004969999999999999, - 2.3e-05, - 0.000241, - 6.500000000000001e-05, - 1.1e-05, - 1e-05, - 0.000188, - null, - null - ] - }, - { - "name": "Urostylida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 2.5e-05, - 1e-05, - 5e-05, - null, - 2e-05, - 3.7e-05, - 0.00023999999999999998, - 9e-06, - null, - 0.001825, - null, - null, - 0.000195, - 0.003081, - 0.000125, - 0.00157, - 0.000328, - 0.00011399999999999999, - 2.8000000000000003e-05, - 4.1e-05, - 5.2000000000000004e-05, - 0.00232, - 0.0017230000000000001, - null, - 0.000164, - 0.00018899999999999999, - 0.000365, - 2.3e-05, - 0.0006320000000000001, - 0.001144, - null, - 0.0004940000000000001, - 1.3000000000000001e-05, - 2.3e-05, - null, - 0.000122, - 1e-05, - null - ] - }, - { - "name": "Gymnodiniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000317, - 0.000269, - 0.00022999999999999998, - 0.000173, - 0.000166, - 0.000502, - 0.00013700000000000002, - 0.000197, - 0.000413, - 0.000233, - 0.00013700000000000002, - 0.000791, - 0.000241, - 0.000132, - 0.000629, - 0.0004940000000000001, - 0.00018700000000000002, - 0.00023799999999999998, - 0.00032, - 0.000331, - 0.000153, - 0.000143, - 0.000157, - 0.000484, - 0.0018780000000000001, - 6.7e-05, - 0.001459, - 0.0006, - 0.001218, - 0.0005009999999999999, - 0.001401, - 0.00023999999999999998, - 0.00011499999999999999, - 0.00014199999999999998, - 5.2000000000000004e-05, - 2.3e-05, - null, - 0.000198, - 1e-05, - null - ] - }, - { - "name": "Cenarchaeales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.001387, - 0.000627, - 0.00044400000000000006, - 0.000458, - 0.000348, - 0.001075, - 0.00025499999999999996, - 0.000843, - 0.000546, - 0.000475, - 0.0005480000000000001, - 0.000304, - 0.000241, - 0.000221, - 0.000239, - 0.000543, - 0.000164, - 0.000177, - 0.000269, - 0.001303, - 0.00041799999999999997, - 0.000245, - 0.0009960000000000001, - 0.000395, - 0.00011599999999999999, - 0.0008789999999999999, - 0.00018600000000000002, - 0.00011999999999999999, - 0.000109, - 0.00011599999999999999, - 0.00020800000000000001, - 0.000149, - 0.000184, - 0.000161, - 0.00011599999999999999, - 6.8e-05, - null, - 9e-06, - null, - 9e-06 - ] - }, - { - "name": "Mesoaciditogales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000436, - 0.0008060000000000001, - 0.000995, - 0.000407, - 0.000869, - 0.00043, - 0.001157, - 0.000356, - 0.00032, - 0.000967, - 0.00016, - 6.1e-05, - 0.000722, - 0.000839, - 4.3e-05, - 0.00041600000000000003, - 0.000572, - 0.000306, - 0.000471, - 0.00031, - 0.000307, - 0.000306, - 0.000262, - 0.000401, - 0.00011599999999999999, - 0.0004969999999999999, - 5.6999999999999996e-05, - 0.00010700000000000001, - 9.499999999999999e-05, - 8.499999999999999e-05, - 3.6e-05, - 0.0005059999999999999, - 4.6e-05, - 0.00013000000000000002, - 6.500000000000001e-05, - 0.000148, - 1e-05, - 1.9e-05, - null, - null - ] - }, - { - "name": "Nautiliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000872, - 0.00044800000000000005, - 0.000625, - 0.000539, - 0.00044699999999999997, - 0.0005740000000000001, - 0.000373, - 0.000375, - 0.000493, - 0.00043, - 0.00044500000000000003, - 0.000547, - 0.000361, - 0.000412, - 0.00028199999999999997, - 0.000525, - 0.0005610000000000001, - 0.000299, - 0.00031099999999999997, - 0.000393, - 0.000349, - 0.000295, - 0.000262, - 0.00031299999999999996, - 0.000106, - 0.000421, - 0.00022200000000000003, - 0.000133, - 8.8e-05, - 0.000131, - 0.000117, - 0.00033999999999999997, - 0.000184, - 0.000154, - 0.000103, - 2.3e-05, - null, - null, - null, - 3.5e-05 - ] - }, - { - "name": "Euglyphida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000674, - 0.00022400000000000002, - 0.00025499999999999996, - 0.00022400000000000002, - 0.000265, - 7.2e-05, - 5.9e-05, - 0.00044, - 0.000519, - 0.00022400000000000002, - 0.000263, - 0.000669, - 0.00011999999999999999, - 0.00035299999999999996, - 0.000184, - 0.000989, - 0.000261, - 0.00047699999999999994, - 0.000404, - 0.00044500000000000003, - 0.000335, - 0.00038700000000000003, - 0.000157, - 0.00062, - 0.000349, - 0.000325, - 0.000536, - 0.000152, - 0.000336, - 0.000285, - 0.000334, - 0.00027400000000000005, - 0.000229, - 0.00028399999999999996, - 0.00011599999999999999, - 2.3e-05, - 1e-05, - 3.8e-05, - 5e-06, - 1.7e-05 - ] - }, - { - "name": "Ceramiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 0.00011200000000000001, - 0.000181, - 6.1e-05, - 0.000149, - 0.000143, - 0.00025499999999999996, - 0.00018700000000000002, - 0.000346, - 0.000197, - 0.000103, - 0.0016420000000000002, - null, - 0.000162, - 0.0009109999999999999, - 0.00023500000000000002, - 0.000136, - 0.000183, - 0.00016, - 0.000248, - 0.000167, - 0.000132, - 0.000157, - 0.000301, - 0.000852, - 0.000134, - 0.000944, - 0.000543, - 0.001248, - 0.000532, - 0.000732, - 0.00014099999999999998, - null, - 0.000105, - 2.6000000000000002e-05, - 2.3e-05, - null, - 0.000198, - 5e-06, - null - ] - }, - { - "name": "Sorogenida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 2.8000000000000003e-05, - 9.300000000000001e-05, - null, - 2.3e-05, - 0.000852, - null, - null, - 0.00128, - 0.000205, - 0.000136, - 0.00022, - 0.000522, - 0.000166, - 1.4000000000000001e-05, - 4.1e-05, - null, - 0.00015900000000000002, - 0.002827, - null, - 0.002002, - 0.000625, - 0.000277, - 0.000594, - 0.0009220000000000001, - 0.000199, - 4.6e-05, - 6.2e-05, - null, - null, - null, - 0.000245, - null, - null - ] - }, - { - "name": "Cryptomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 0.00011200000000000001, - 0.00014, - 0.00020299999999999997, - 0.00011599999999999999, - 0.000215, - 0.000177, - 0.000122, - 0.00036, - 0.00017900000000000001, - 8e-05, - 0.000973, - null, - 0.000221, - 0.000174, - 0.000543, - 0.00023199999999999997, - 0.00023799999999999998, - 0.000354, - 0.000155, - 0.00011200000000000001, - 9.2e-05, - 5.2000000000000004e-05, - 0.000331, - 0.0009199999999999999, - 0.000105, - 0.001359, - 0.000164, - 0.0014449999999999999, - 0.000278, - 0.001057, - 0.000323, - null, - 0.000198, - 1.3000000000000001e-05, - 1.1e-05, - null, - 8.499999999999999e-05, - null, - null - ] - }, - { - "name": "Synurales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 6.7e-05, - 4.1e-05, - 6.1e-05, - 7.5e-05, - 0.000215, - 5.9e-05, - 5.6000000000000006e-05, - 0.00016, - 2.7000000000000002e-05, - 3.4e-05, - 0.001582, - null, - 2.8999999999999997e-05, - 9.8e-05, - 0.000452, - 0.000181, - 0.00020800000000000001, - 0.000202, - 0.000155, - null, - 3.1e-05, - 0.000105, - 0.000484, - 0.001104, - 2.8999999999999997e-05, - 0.000386, - 3.8e-05, - 0.000897, - 6.2e-05, - 0.0030629999999999998, - 0.00024900000000000004, - 9.2e-05, - 0.000185, - 1.3000000000000001e-05, - null, - null, - 4.7e-05, - null, - null - ] - }, - { - "name": "Endomicrobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.0008320000000000001, - 0.00035800000000000003, - 0.00037799999999999997, - 0.000173, - 0.00025699999999999996, - 0.000502, - 0.00035299999999999996, - 0.000459, - 0.0005059999999999999, - 0.00040300000000000004, - 0.00022799999999999999, - 0.00024300000000000002, - 0.000361, - 0.00025, - 0.00024900000000000004, - 0.000446, - 0.000753, - 0.000171, - 0.000269, - 0.000393, - 0.000153, - 0.000336, - 0.000472, - 0.000342, - 0.000136, - 0.00020099999999999998, - 6.4e-05, - 0.000183, - 0.000109, - 0.000139, - 0.000145, - 0.00039, - 2.3e-05, - 0.00014199999999999998, - 0.000103, - 1.1e-05, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Caldisericales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00047599999999999997, - 0.00056, - 0.00034500000000000004, - 0.000275, - 0.000397, - 0.000143, - 0.000314, - 0.00029, - 0.000213, - 0.000439, - 0.00011399999999999999, - 0.000365, - 0.000421, - 0.000221, - 0.00013000000000000002, - 0.00031299999999999996, - 0.000668, - 0.00025699999999999996, - 0.000328, - 0.000341, - 0.000321, - 0.000183, - 0.000682, - 0.00036, - 8.7e-05, - 0.00021, - 8.6e-05, - 0.00011399999999999999, - 7.3e-05, - 8.499999999999999e-05, - 7.2e-05, - 0.000373, - 0.00011499999999999999, - 0.000117, - 6.500000000000001e-05, - 4.6e-05, - 1e-05, - 2.8000000000000003e-05, - 5e-06, - 1.7e-05 - ] - }, - { - "name": "Sticholonchida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000317, - 0.000134, - 0.000148, - 0.000132, - 5.7999999999999994e-05, - null, - 3.9e-05, - 9.4e-05, - 0.00016, - 9e-05, - 0.00011399999999999999, - 0.000608, - 5.9999999999999995e-05, - 2.8999999999999997e-05, - 0.000629, - 0.00032599999999999996, - 0.00016999999999999999, - 0.000373, - 0.00016, - 0.0003, - 0.000321, - 0.000285, - 0.000105, - 0.000301, - 0.0005610000000000001, - 0.000105, - 0.000851, - 0.00048600000000000005, - 0.00044500000000000003, - 0.000517, - 0.000452, - 0.000315, - 0.000138, - 0.000136, - 7.8e-05, - 1.1e-05, - 1e-05, - 0.00016, - null, - null - ] - }, - { - "name": "Chromulinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 4.5e-05, - 6.6e-05, - null, - 2.5e-05, - 7.2e-05, - null, - 0.00011200000000000001, - 0.00036, - 5.4000000000000005e-05, - 2.3e-05, - 0.000669, - 5.9999999999999995e-05, - 4.4e-05, - 4.3e-05, - 0.000826, - 0.000261, - 0.000183, - 0.000396, - 0.000207, - 2.8000000000000003e-05, - 8.2e-05, - null, - 0.000484, - 0.000987, - 2.8999999999999997e-05, - 0.000286, - 3.8e-05, - 0.00046699999999999997, - 6.2e-05, - 0.0028280000000000002, - 9.1e-05, - null, - 0.000167, - 3.9e-05, - null, - null, - 4.7e-05, - 5e-06, - null - ] - }, - { - "name": "Chattonellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 0.000202, - 0.00011499999999999999, - 0.00016299999999999998, - 0.000149, - 0.00043, - 2e-05, - 9.4e-05, - 0.000226, - 0.00016999999999999999, - 0.00011399999999999999, - 0.001034, - 0.000301, - 0.000118, - 0.00034700000000000003, - 0.000217, - 0.000204, - 0.000251, - 0.000278, - 0.000103, - 7e-05, - 0.000153, - null, - 0.000307, - 0.000678, - 0.000153, - 0.00024300000000000002, - 0.000145, - 0.000642, - 0.000154, - 0.001265, - 9.9e-05, - 0.00011499999999999999, - 0.000167, - 1.3000000000000001e-05, - 1.1e-05, - 2.1e-05, - 0.000198, - 2.6000000000000002e-05, - 9e-06 - ] - }, - { - "name": "Arcellinida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00047599999999999997, - 4.5e-05, - 0.000123, - 0.00021400000000000002, - 0.00023999999999999998, - 7.2e-05, - 3.9e-05, - 0.00029, - 0.0006929999999999999, - 0.00011599999999999999, - 0.000171, - 0.00024300000000000002, - null, - 0.00025, - 7.6e-05, - 0.000983, - 0.000153, - 0.000251, - 0.00032, - 0.000321, - 0.000404, - 0.000102, - 5.2000000000000004e-05, - 0.001051, - 0.000155, - 0.00028700000000000004, - 8.6e-05, - 7.6e-05, - 0.000204, - 0.00011599999999999999, - 0.00028, - 0.000199, - 0.000275, - 0.00043200000000000004, - 6.500000000000001e-05, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Himatismenida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00023799999999999998, - 0.00022400000000000002, - 6.6e-05, - 0.000153, - 9.1e-05, - 7.2e-05, - null, - 0.000169, - 0.001558, - 8.1e-05, - 8e-05, - null, - 5.9999999999999995e-05, - 2.8999999999999997e-05, - 4.3e-05, - 0.00117, - 0.00015900000000000002, - 0.00023199999999999997, - 0.000354, - 0.00029, - 0.000265, - 0.000194, - 5.2000000000000004e-05, - 0.000726, - 0.000106, - 0.000153, - 0.000229, - 4.4e-05, - 0.000212, - 0.000123, - 0.000154, - 0.000572, - 2.3e-05, - 0.000309, - 6.500000000000001e-05, - 1.1e-05, - null, - 9e-06, - 5e-06, - null - ] - }, - { - "name": "Bicosoecida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 3.3e-05, - 2e-05, - 1.7e-05, - null, - null, - 9e-06, - 0.00010700000000000001, - 3.6e-05, - 1.1e-05, - 0.000182, - null, - null, - 0.00013000000000000002, - 0.000754, - 0.000935, - 0.000122, - 8.4e-05, - 4.1e-05, - 1.4000000000000001e-05, - null, - null, - 0.000602, - 0.000194, - 1e-05, - 5e-05, - 0.000139, - 0.000139, - 3.1e-05, - 0.000117, - 0.0034649999999999998, - null, - 9.300000000000001e-05, - 1.3000000000000001e-05, - null, - null, - 5.6000000000000006e-05, - 5e-06, - null - ] - }, - { - "name": "Armophorida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 4.5e-05, - null, - 3.1e-05, - 3.3e-05, - 7.2e-05, - null, - 3.7e-05, - 6.7e-05, - null, - 4.6e-05, - 0.000182, - null, - null, - 0.001117, - 0.000102, - 0.00016999999999999999, - 6.1e-05, - 5.1e-05, - 9.300000000000001e-05, - 4.2e-05, - 7.099999999999999e-05, - null, - 0.000136, - 0.00041600000000000003, - 3.8e-05, - 0.001838, - 0.000291, - 0.000525, - 0.000185, - 0.0008039999999999999, - 9.9e-05, - null, - 4.3e-05, - null, - 1.1e-05, - 1e-05, - 7.5e-05, - null, - null - ] - }, - { - "name": "Ulvales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 0.000134, - 8.2e-05, - 4.1e-05, - 4.1e-05, - null, - 5.9e-05, - 0.00011200000000000001, - 9.300000000000001e-05, - 3.6e-05, - 0.00013700000000000002, - 0.000608, - 0.00011999999999999999, - 4.4e-05, - 0.000152, - 0.000145, - 0.00010800000000000001, - 0.000128, - 9.300000000000001e-05, - 0.000145, - 0.000195, - 6.1e-05, - null, - 8.3e-05, - 0.000319, - 9.6e-05, - 0.001616, - 0.00015800000000000002, - 0.000781, - 0.000131, - 0.000361, - 0.000149, - 9.2e-05, - 8.6e-05, - null, - null, - null, - 4.7e-05, - null, - null - ] - }, - { - "name": "Candidatus Actinomarinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000436, - 0.000314, - 0.000206, - 0.000305, - 0.000215, - 7.2e-05, - 0.000373, - 0.00015, - 0.00010700000000000001, - 0.000296, - 0.000183, - 6.1e-05, - 5.9999999999999995e-05, - 0.00019099999999999998, - 0.000206, - 0.000223, - 0.000215, - 9.8e-05, - 0.000126, - 0.000155, - 0.000335, - 0.000173, - 0.000157, - 0.000195, - 0.000126, - 0.000143, - 0.00015, - 0.00025299999999999997, - 0.000161, - 0.000131, - 0.000117, - 8.3e-05, - 6.9e-05, - 4.9e-05, - 0.00014199999999999998, - 3.4e-05, - 5.2000000000000004e-05, - 4.7e-05, - 7.2e-05, - 2.6000000000000002e-05 - ] - }, - { - "name": "Haloplasmatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000198, - 0.00044800000000000005, - 0.00034500000000000004, - 0.00014199999999999998, - 0.00014099999999999998, - 0.000143, - 0.00023500000000000002, - 8.4e-05, - 0.000226, - 0.000197, - 0.000148, - 0.000365, - 0.00011999999999999999, - 0.000236, - 0.000152, - 0.000133, - 0.000317, - 0.000153, - 0.000177, - 0.00031, - 0.000279, - 9.2e-05, - 5.2000000000000004e-05, - 0.000165, - 0.00023199999999999997, - 0.000134, - 0.000129, - 0.000133, - 0.000124, - 6.2e-05, - 0.00018999999999999998, - 0.000166, - 6.9e-05, - 8.6e-05, - 0.00014199999999999998, - 1.1e-05, - null, - 4.7e-05, - 5e-06, - 1.7e-05 - ] - }, - { - "name": "Chitinivibrionales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00023799999999999998, - 0.000269, - 0.000304, - 0.00020299999999999997, - 0.00023199999999999997, - 0.000143, - 0.000196, - 0.000169, - 0.00032, - 0.00016999999999999999, - 5.6999999999999996e-05, - 0.000182, - 0.00018, - 8.8e-05, - 0.000206, - 0.00023500000000000002, - 0.000442, - 0.000165, - 0.00021899999999999998, - 0.000331, - 0.000195, - 0.000204, - 0.000157, - 0.000307, - 0.000126, - 0.00021, - 7.900000000000001e-05, - 6.9e-05, - 5.1e-05, - 6.9e-05, - 5.4000000000000005e-05, - 0.00027400000000000005, - 6.9e-05, - 6.8e-05, - 6.500000000000001e-05, - null, - null, - 2.8000000000000003e-05, - 5e-06, - null - ] - }, - { - "name": "Elusimicrobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 0.00017900000000000001, - 0.000304, - 0.00011200000000000001, - 0.00022400000000000002, - 0.000143, - 0.000196, - 0.000197, - 0.00023999999999999998, - 0.000269, - 0.000148, - 0.000182, - 0.000241, - 0.000339, - 4.3e-05, - 0.00024700000000000004, - 0.000425, - 0.000153, - 0.000194, - 0.00018600000000000002, - 0.000363, - 0.000143, - 0.00021, - 0.000171, - 0.000106, - 0.000143, - 7.2e-05, - 5.1e-05, - 2.8999999999999997e-05, - 3.1e-05, - 0.000136, - 0.000207, - 0.00011499999999999999, - 9.300000000000001e-05, - 3.9e-05, - 3.4e-05, - 1e-05, - 3.8e-05, - null, - null - ] - }, - { - "name": "Bryopsidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000198, - 0.000291, - 0.00018899999999999999, - 9.2e-05, - 0.000174, - 0.00035800000000000003, - 0.000196, - 0.000122, - 0.00018600000000000002, - 0.00035800000000000003, - 0.00013700000000000002, - 6.1e-05, - 0.000361, - 0.000236, - 5.4000000000000005e-05, - 0.00025299999999999997, - 0.000176, - 0.000122, - 5.1e-05, - 0.000124, - 0.000349, - 0.000102, - 0.000157, - 0.000171, - 7.7e-05, - 0.00043, - 0.00010700000000000001, - 8.8e-05, - 8e-05, - 3.9e-05, - 0.000117, - 0.00014099999999999998, - 0.000138, - 4.9e-05, - 2.6000000000000002e-05, - 1.1e-05, - 6.2e-05, - 2.8000000000000003e-05, - 9.8e-05, - 1.7e-05 - ] - }, - { - "name": "Pyramimonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 4.5e-05, - 8e-06, - 7.099999999999999e-05, - 5e-05, - null, - 2e-05, - 6.6e-05, - 9.300000000000001e-05, - 0.00010700000000000001, - 4.6e-05, - 0.000608, - 5.9999999999999995e-05, - 1.4999999999999999e-05, - 0.00016299999999999998, - 0.000157, - 6.8e-05, - 9.2e-05, - 8.4e-05, - 0.00011399999999999999, - 0.000153, - 4.1e-05, - 0.000105, - 0.00014199999999999998, - 0.000426, - 4.8e-05, - 0.0015019999999999999, - 6.3e-05, - 0.000606, - 8.499999999999999e-05, - 0.000343, - 8.3e-05, - 2.3e-05, - 4.3e-05, - 3.9e-05, - null, - 1e-05, - 2.8000000000000003e-05, - null, - null - ] - }, - { - "name": "Natranaerobiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000317, - 0.000202, - 0.00024700000000000004, - 0.000254, - 0.000315, - 0.00035800000000000003, - 0.000196, - 0.000206, - 0.000173, - 0.00022400000000000002, - 0.000171, - 6.1e-05, - 0.00018, - 7.4e-05, - 7.6e-05, - 0.000193, - 0.00024900000000000004, - 0.00015900000000000002, - 0.000202, - 0.000166, - 0.000195, - 6.1e-05, - 5.2000000000000004e-05, - 0.000171, - 7.7e-05, - 0.00021, - 3.6e-05, - 0.00011399999999999999, - 8.8e-05, - 4.6e-05, - 5.4000000000000005e-05, - 0.000207, - 6.9e-05, - 5.6000000000000006e-05, - 5.2000000000000004e-05, - 4.6e-05, - 1e-05, - 9e-06, - null, - 9e-06 - ] - }, - { - "name": "Liceales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00011899999999999999, - 6.7e-05, - 7.4e-05, - 0.00014199999999999998, - 5.7999999999999994e-05, - 7.2e-05, - 3.9e-05, - 0.00011200000000000001, - 0.000306, - 4.5e-05, - 4.6e-05, - 0.000487, - null, - 7.4e-05, - 6.500000000000001e-05, - 0.000223, - 0.000176, - 9.2e-05, - 0.000152, - 0.000166, - 0.000223, - 0.000132, - 0.000105, - 0.000301, - 0.000281, - 2.8999999999999997e-05, - 0.000579, - 6.3e-05, - 0.00035, - 0.000123, - 0.000325, - 7.5e-05, - 0.000184, - 7.4e-05, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Methanopyrales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000277, - 0.000246, - 0.000132, - 0.000183, - 0.000306, - 0.00028700000000000004, - 9.8e-05, - 0.00015900000000000002, - 0.000147, - 0.000233, - 9.1e-05, - null, - 5.9999999999999995e-05, - 0.000103, - 9.8e-05, - 0.000133, - 0.000198, - 8.6e-05, - 0.000177, - 0.000207, - 0.000349, - 0.000102, - 0.000367, - 0.000148, - 5.7999999999999994e-05, - 0.000182, - 5e-05, - 6.9e-05, - 4.4e-05, - 6.9e-05, - 6.3e-05, - 0.00011599999999999999, - 4.6e-05, - 6.2e-05, - 1.3000000000000001e-05, - 4.6e-05, - null, - null, - 5e-06, - null - ] - }, - { - "name": "Gracilariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 0.00011200000000000001, - 0.000181, - 6.1e-05, - 4.1e-05, - 7.2e-05, - 7.8e-05, - 0.000131, - 8e-05, - 8.1e-05, - 0.00011399999999999999, - 0.000791, - 0.00011999999999999999, - 0.000103, - 0.00014099999999999998, - 0.00021099999999999998, - 7.900000000000001e-05, - 0.00011599999999999999, - 7.6e-05, - 0.000134, - 0.000195, - 2e-05, - 0.000105, - 0.000106, - 0.000213, - 0.000134, - 0.000172, - 0.000145, - 0.00038700000000000003, - 0.000154, - 0.00016299999999999998, - 4.1e-05, - 9.2e-05, - 9.300000000000001e-05, - 2.6000000000000002e-05, - null, - null, - 5.6000000000000006e-05, - null, - null - ] - }, - { - "name": "Protostomatida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - null, - 8e-06, - null, - null, - null, - null, - 1.9e-05, - 0.0004, - null, - null, - 0.000547, - null, - null, - 2.2e-05, - 0.000265, - 1.1e-05, - 0.000153, - 0.000109, - 3.1e-05, - null, - 6.1e-05, - null, - 0.00037799999999999997, - 0.001549, - 1.9e-05, - 7.2e-05, - 0.000139, - 0.000168, - 3.9e-05, - 0.000307, - 0.00033999999999999997, - 2.3e-05, - 4.3e-05, - null, - null, - null, - 7.5e-05, - null, - null - ] - }, - { - "name": "Oxyrrhinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 1.6e-05, - 3.1e-05, - 8e-06, - null, - null, - 5.6000000000000006e-05, - 0.00016, - 3.6e-05, - 6.8e-05, - 0.000182, - null, - 2.8999999999999997e-05, - 0.00010800000000000001, - 0.000229, - 0.000113, - 0.00011599999999999999, - 0.000135, - 5.2000000000000004e-05, - 8.4e-05, - null, - null, - 0.000295, - 0.00047400000000000003, - 7.6e-05, - 0.000965, - 6.9e-05, - 0.000496, - 4.6e-05, - 0.00066, - 9.1e-05, - 4.6e-05, - 5.6000000000000006e-05, - 1.3000000000000001e-05, - null, - null, - 6.6e-05, - 1e-05, - null - ] - }, - { - "name": "Pythiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000198, - 9e-05, - 9e-05, - 4.1e-05, - 0.000207, - null, - 0.000196, - 0.00018700000000000002, - 0.0002, - 0.00011599999999999999, - 0.000103, - 6.1e-05, - null, - null, - 6.500000000000001e-05, - 0.000356, - 0.00015900000000000002, - 0.00011599999999999999, - 0.000227, - 0.000352, - 0.000335, - 0.000102, - null, - 0.000153, - 0.000165, - 0.00020099999999999998, - 0.0001, - 3.2e-05, - 0.000226, - 2.3e-05, - 0.00018999999999999998, - 6.6e-05, - 9.2e-05, - 0.000352, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Microthamniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000198, - 4.5e-05, - 7.4e-05, - 9.2e-05, - 0.00010800000000000001, - 7.2e-05, - null, - 6.6e-05, - 8e-05, - 8.1e-05, - 6.8e-05, - 0.000487, - 0.00018, - 8.8e-05, - 0.000174, - 8.4e-05, - 2.8000000000000003e-05, - 3.1e-05, - 7.6e-05, - 5.2000000000000004e-05, - 5.6000000000000006e-05, - 3.1e-05, - null, - 0.000136, - 0.000668, - 6.7e-05, - 0.000365, - 7.6e-05, - 0.000248, - 0.0001, - 0.000813, - 3.3e-05, - 2.3e-05, - 2.5e-05, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Glissomonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 1.6e-05, - null, - 8e-06, - null, - null, - 1.9e-05, - 6.7e-05, - 1.8e-05, - null, - 0.001217, - null, - null, - 0.000206, - 6e-06, - 2.3e-05, - 1.8e-05, - 2.5e-05, - null, - 2.8000000000000003e-05, - null, - null, - 1.2e-05, - 0.0009199999999999999, - 1e-05, - 0.000365, - 8.2e-05, - 0.000489, - 8.499999999999999e-05, - 0.000831, - 4.1e-05, - null, - 6e-06, - null, - null, - 1e-05, - 0.000113, - null, - null - ] - }, - { - "name": "Rotaliida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 0.000157, - 6.6e-05, - 4.1e-05, - 8.3e-05, - null, - 2e-05, - 3.7e-05, - 0.000746, - 9.9e-05, - null, - 6.1e-05, - null, - 2.8999999999999997e-05, - 2.2e-05, - 0.00085, - 0.000334, - 0.000342, - 0.000168, - 5.2000000000000004e-05, - null, - 7.099999999999999e-05, - 5.2000000000000004e-05, - 0.00020099999999999998, - 2.8999999999999997e-05, - 8.6e-05, - 3.6e-05, - 2.5e-05, - 8.8e-05, - 2.3e-05, - 3.6e-05, - 0.000207, - null, - 0.00021, - null, - 1.1e-05, - null, - null, - 1e-05, - 9e-06 - ] - }, - { - "name": "Cyrtophorida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - 1e-05, - null, - null, - null, - 9e-06, - 5.3e-05, - null, - null, - 0.000122, - null, - null, - 0.001638, - 5.4000000000000005e-05, - 1.1e-05, - 3.7e-05, - 7.6e-05, - 1e-05, - null, - null, - null, - 5.9e-05, - 0.00037799999999999997, - null, - 0.000672, - 0.000139, - 0.000547, - 0.000131, - 0.000117, - 4.1e-05, - null, - 1.9e-05, - null, - null, - null, - 4.7e-05, - null, - null - ] - }, - { - "name": "Nassulida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - null, - null, - null, - null, - null, - 4.7e-05, - 0.0006389999999999999, - 9e-06, - null, - null, - null, - null, - 1.1e-05, - 0.000193, - 0.000266, - 0.000452, - 0.001322, - 6.2e-05, - null, - 1e-05, - null, - 0.000148, - 0.00011599999999999999, - null, - 0.0001, - 1.3000000000000001e-05, - 7.000000000000001e-06, - 9.300000000000001e-05, - 9e-06, - 0.00029, - null, - 9.9e-05, - null, - 1.1e-05, - null, - null, - null, - null - ] - }, - { - "name": "Nemastomatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000277, - 0.000314, - 0.000156, - 0.000102, - 0.000157, - 0.00028700000000000004, - 9.8e-05, - 0.00011200000000000001, - 8e-05, - 0.000161, - 8e-05, - null, - 5.9999999999999995e-05, - 0.000118, - 1.1e-05, - 4.2e-05, - 1.7e-05, - 3.1e-05, - 4.2e-05, - 0.000352, - 0.000167, - 0.000122, - 0.000262, - 0.0001, - 1e-05, - 0.00020099999999999998, - 8.6e-05, - 6e-06, - 1.4999999999999999e-05, - 8e-06, - 1.8e-05, - 3.3e-05, - null, - 2.5e-05, - 1.3000000000000001e-05, - 5.6999999999999996e-05, - 1e-05, - 9e-06, - null, - null - ] - }, - { - "name": "Haptorida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - null, - null, - null, - null, - null, - null, - 0.000226, - null, - null, - null, - null, - null, - 0.000651, - 6.6e-05, - 6e-06, - 3.1e-05, - 8e-06, - 3.1e-05, - 1.4000000000000001e-05, - null, - null, - 1.8e-05, - 0.000678, - null, - 0.000393, - 0.000328, - 0.000117, - 0.000231, - 0.000154, - 0.00024900000000000004, - null, - 0.000167, - null, - null, - null, - 5.6000000000000006e-05, - null, - null - ] - }, - { - "name": "Collodaria", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.000198, - 2.2e-05, - null, - 6.1e-05, - 2.5e-05, - 7.2e-05, - 3.9e-05, - 5.6000000000000006e-05, - 0.000413, - 5.4000000000000005e-05, - 2.3e-05, - 0.000182, - null, - 2.8999999999999997e-05, - 0.00010800000000000001, - 0.000307, - 0.00016999999999999999, - 6.1e-05, - 5.1e-05, - 3.1e-05, - 0.000251, - 7.099999999999999e-05, - 5.2000000000000004e-05, - 0.000254, - 0.000174, - 8.6e-05, - 0.00010700000000000001, - 7.6e-05, - 0.000109, - 3.9e-05, - 0.000199, - 4.1e-05, - null, - 2.5e-05, - 1.3000000000000001e-05, - null, - null, - 3.8e-05, - null, - null - ] - }, - { - "name": "Glaucocystales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 4.1e-05, - 7.099999999999999e-05, - 2.5e-05, - null, - 2e-05, - 3.7e-05, - 0.00010700000000000001, - 9e-06, - 2.3e-05, - 0.000426, - null, - null, - 9.8e-05, - 0.000199, - 0.00013000000000000002, - 0.000147, - 0.000101, - 8.3e-05, - 2.8000000000000003e-05, - 9.2e-05, - null, - 0.000153, - 0.00031, - 1.9e-05, - 0.00018600000000000002, - 5.1e-05, - 0.000533, - 4.6e-05, - 0.000271, - 5e-05, - null, - 6.8e-05, - null, - null, - 1e-05, - 2.8000000000000003e-05, - null, - null - ] - }, - { - "name": "Brevinematales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 9e-05, - 0.000148, - 0.000122, - 8.3e-05, - 0.00043, - 3.9e-05, - 8.4e-05, - 9.300000000000001e-05, - 7.2e-05, - 3.4e-05, - 6.1e-05, - 0.00018, - 8.8e-05, - 0.00013000000000000002, - 8.4e-05, - 0.000153, - 5.5e-05, - 5.1e-05, - 9.300000000000001e-05, - 0.000139, - 6.1e-05, - 0.000157, - 6.500000000000001e-05, - 5.7999999999999994e-05, - 5.6999999999999996e-05, - 3.6e-05, - 0.000183, - 8e-05, - 6.9e-05, - 9.9e-05, - 6.6e-05, - 4.6e-05, - 4.9e-05, - 2.6000000000000002e-05, - 2.3e-05, - 1e-05, - 3.8e-05, - null, - null - ] - }, - { - "name": "Corallinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 6.7e-05, - 3.3e-05, - 4.1e-05, - 3.3e-05, - 0.000143, - null, - 1.9e-05, - 6.7e-05, - 9e-06, - 5.6999999999999996e-05, - 0.000365, - null, - 1.4999999999999999e-05, - 1.1e-05, - 3.6e-05, - 6.8e-05, - 7.3e-05, - 8.4e-05, - null, - null, - 1e-05, - 5.2000000000000004e-05, - 6.500000000000001e-05, - 0.000155, - 4.8e-05, - 0.000973, - 5.1e-05, - 0.000277, - 4.6e-05, - 0.000271, - 3.3e-05, - null, - 1.9e-05, - null, - 1.1e-05, - null, - 1.9e-05, - null, - 9e-06 - ] - }, - { - "name": "Stemonitida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - 8e-06, - null, - null, - 9e-06, - 5.3e-05, - null, - 2.3e-05, - 0.000852, - null, - 4.4e-05, - 0.00036899999999999997, - 2.4e-05, - 7.4e-05, - 4.9e-05, - 0.000143, - null, - 8.4e-05, - 1e-05, - null, - 4.1e-05, - 0.00011599999999999999, - null, - 7.2e-05, - 0.000177, - 0.00047400000000000003, - 0.000262, - 0.000136, - 5.7999999999999994e-05, - null, - 1.9e-05, - null, - null, - null, - 3.8e-05, - null, - null - ] - }, - { - "name": "Dasycladales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 0.000134, - 5.7999999999999994e-05, - 7.099999999999999e-05, - 3.3e-05, - null, - null, - 9e-06, - 0.00011999999999999999, - 4.5e-05, - 4.6e-05, - 0.000182, - 5.9999999999999995e-05, - null, - null, - 0.000531, - 4e-05, - 0.00011, - 0.000101, - 0.00040300000000000004, - 0.000181, - 0.000122, - null, - 0.000118, - 1e-05, - 3.8e-05, - 4.3e-05, - 5.6999999999999996e-05, - 6.6e-05, - 1.4999999999999999e-05, - 6.3e-05, - 6.6e-05, - 2.3e-05, - 9.9e-05, - 1.3000000000000001e-05, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Parmales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 2.2e-05, - 8.2e-05, - 2e-05, - 2.5e-05, - null, - 2e-05, - 1.9e-05, - 6.7e-05, - 5.4000000000000005e-05, - null, - 6.1e-05, - null, - 1.4999999999999999e-05, - 8.7e-05, - 0.000139, - 0.00023799999999999998, - 9.2e-05, - 6.7e-05, - 6.2e-05, - 7e-05, - null, - null, - 8.3e-05, - 0.000252, - 1e-05, - 0.000122, - 7.6e-05, - 0.00018999999999999998, - 9.300000000000001e-05, - 0.000325, - 0.00040599999999999995, - null, - 7.4e-05, - 1.3000000000000001e-05, - 2.3e-05, - null, - 6.6e-05, - null, - null - ] - }, - { - "name": "Pavlovales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 4.5e-05, - 0.00010700000000000001, - 2e-05, - 8.3e-05, - null, - 0.000118, - 1.9e-05, - 0.000147, - 4.5e-05, - 1.1e-05, - 0.000182, - null, - 2.8999999999999997e-05, - 6.500000000000001e-05, - 0.00011499999999999999, - 0.000147, - 0.000122, - 0.000118, - 8.3e-05, - 7e-05, - 3.1e-05, - null, - 0.000106, - 0.000223, - 2.8999999999999997e-05, - 0.00018600000000000002, - 7.6e-05, - 0.000212, - 8e-06, - 0.000172, - 0.000149, - null, - 6.8e-05, - 1.3000000000000001e-05, - 2.3e-05, - 1e-05, - null, - null, - 9e-06 - ] - }, - { - "name": "Eunotiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 0.000291, - 5.7999999999999994e-05, - null, - 0.00029, - 0.000143, - 3.9e-05, - 5.6000000000000006e-05, - 0.000147, - 0.00011599999999999999, - 2.3e-05, - null, - 0.00011999999999999999, - 0.000147, - null, - 0.000145, - 5.6999999999999996e-05, - 3.7e-05, - 0.000101, - 0.000362, - 4.2e-05, - null, - 0.000105, - 7.099999999999999e-05, - null, - 5.6999999999999996e-05, - 7.000000000000001e-06, - null, - null, - null, - null, - 0.00011599999999999999, - 0.000138, - 4.9e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Entodiniomorphida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - null, - 8e-06, - 1e-05, - null, - null, - null, - null, - 0.000426, - null, - 1.1e-05, - 0.000182, - 5.9999999999999995e-05, - 1.4999999999999999e-05, - 0.000184, - 0.000458, - 5.6999999999999996e-05, - 4.9e-05, - null, - 4.1e-05, - 1.4000000000000001e-05, - 1e-05, - null, - 0.000183, - 0.00023199999999999997, - 1.9e-05, - 8.6e-05, - 6.9e-05, - 5.7999999999999994e-05, - 4.6e-05, - 0.00016299999999999998, - 0.000182, - null, - 3.7e-05, - null, - null, - null, - null, - 1e-05, - null - ] - }, - { - "name": "Prasinococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 0.00011200000000000001, - 3.3e-05, - 4.1e-05, - 9.9e-05, - 0.000143, - 2e-05, - 8.4e-05, - 8e-05, - 9e-05, - null, - 0.000365, - null, - 4.4e-05, - 0.000152, - 3.6e-05, - 3.4e-05, - 3.7e-05, - 9.300000000000001e-05, - 8.3e-05, - 2.8000000000000003e-05, - 4.1e-05, - null, - 4.1e-05, - 0.000106, - 4.8e-05, - 8.6e-05, - 3.8e-05, - 0.00037200000000000004, - 1.4999999999999999e-05, - 0.000126, - 3.3e-05, - null, - 3.7e-05, - null, - null, - null, - 3.8e-05, - null, - null - ] - }, - { - "name": "Heteronematales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 2.2e-05, - null, - 4.1e-05, - 3.3e-05, - 7.2e-05, - 2e-05, - 4.7e-05, - 0.000133, - 3.6e-05, - 3.4e-05, - 0.000487, - null, - 1.4999999999999999e-05, - 1.1e-05, - 7.2e-05, - 4e-05, - 3.7e-05, - 3.4e-05, - 6.2e-05, - 5.6000000000000006e-05, - 3.1e-05, - 0.000105, - 8.3e-05, - 7.7e-05, - 4.8e-05, - 0.0001, - 0.00011399999999999999, - 0.000336, - 0.000162, - 0.000126, - 4.1e-05, - null, - 6e-06, - 1.3000000000000001e-05, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Monomastigales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 1.6e-05, - 3.1e-05, - 5.7999999999999994e-05, - 7.2e-05, - 3.9e-05, - 9e-06, - 2.7000000000000002e-05, - 4.5e-05, - 3.4e-05, - 0.000304, - null, - 5.9e-05, - 0.000195, - 7.2e-05, - 9.1e-05, - 3.1e-05, - 3.4e-05, - 6.2e-05, - 4.2e-05, - 4.1e-05, - null, - 6e-06, - 5.7999999999999994e-05, - 1e-05, - 8.6e-05, - 0.000133, - 0.00025499999999999996, - 8.499999999999999e-05, - 0.00047000000000000004, - 5.7999999999999994e-05, - null, - null, - 1.3000000000000001e-05, - 1.1e-05, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Miliolida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 0.000134, - 5.7999999999999994e-05, - 2e-05, - 3.3e-05, - null, - null, - 5.6000000000000006e-05, - 0.00036, - null, - null, - null, - null, - 2.8999999999999997e-05, - null, - 0.0005059999999999999, - 0.000193, - 0.000244, - 9.300000000000001e-05, - 1e-05, - 1.4000000000000001e-05, - null, - 0.000105, - 0.00014199999999999998, - 1.9e-05, - 1e-05, - 7.000000000000001e-06, - null, - 2.2e-05, - null, - null, - 7.5e-05, - null, - 0.000167, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Stichotrichida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 3.7e-05, - 1.3000000000000001e-05, - null, - null, - 0.000487, - null, - null, - null, - 0.000434, - 1.1e-05, - 0.000147, - 1.7e-05, - null, - null, - null, - null, - 0.00045999999999999996, - 0.000155, - null, - 0.00011399999999999999, - null, - 8e-05, - 8e-06, - 5.4000000000000005e-05, - 0.00021600000000000002, - null, - 6.8e-05, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Nemaliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 2.2e-05, - 9e-05, - 0.000173, - 6.6e-05, - 7.2e-05, - 0.000157, - 0.000131, - 5.3e-05, - 0.000125, - 4.6e-05, - 6.1e-05, - null, - 2.8999999999999997e-05, - 2.2e-05, - 7.2e-05, - 0.000125, - 4.3e-05, - 4.2e-05, - 6.2e-05, - 8.4e-05, - 0.000153, - null, - 7.099999999999999e-05, - 1e-05, - 0.000124, - 6.4e-05, - 6e-06, - 1.4999999999999999e-05, - 1.4999999999999999e-05, - 1.8e-05, - 2.5e-05, - null, - 1.2e-05, - 6.500000000000001e-05, - 2.3e-05, - null, - 9e-06, - 5e-06, - null - ] - }, - { - "name": "Fragilariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 9e-05, - 4.9e-05, - 2e-05, - 8.3e-05, - null, - 2e-05, - 2.8000000000000003e-05, - 6.7e-05, - 6.3e-05, - 2.3e-05, - 0.000182, - 0.00018, - 2.8999999999999997e-05, - 1.1e-05, - 6.6e-05, - 5.1e-05, - 6.1e-05, - 0.000109, - 5.2000000000000004e-05, - 7e-05, - 1e-05, - null, - 8.9e-05, - 5.7999999999999994e-05, - 3.8e-05, - 0.00010700000000000001, - 4.4e-05, - 0.000131, - 2.3e-05, - 0.000145, - 7.5e-05, - null, - 1.9e-05, - null, - 1.1e-05, - null, - null, - null, - 9e-06 - ] - }, - { - "name": "Fucales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 6.7e-05, - 5.7999999999999994e-05, - 3.1e-05, - 4.1e-05, - null, - 3.9e-05, - 9e-06, - 9.300000000000001e-05, - 1.8e-05, - null, - 0.000182, - null, - 0.000132, - 4.3e-05, - 0.000157, - 7.900000000000001e-05, - 7.900000000000001e-05, - 5.1e-05, - 3.1e-05, - 4.2e-05, - 2e-05, - 5.2000000000000004e-05, - 0.00011200000000000001, - 0.000155, - 4.8e-05, - 5.6999999999999996e-05, - 6e-06, - 0.000226, - null, - 7.2e-05, - 0.00010800000000000001, - null, - 6.8e-05, - null, - null, - null, - 3.8e-05, - null, - 9e-06 - ] - }, - { - "name": "Thermoflexales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 0.000134, - 0.000181, - 0.000153, - 0.000132, - null, - 0.000157, - 5.6000000000000006e-05, - 1.3000000000000001e-05, - 6.3e-05, - 5.6999999999999996e-05, - null, - 0.000241, - 8.8e-05, - 5.4000000000000005e-05, - 7.2e-05, - 9.1e-05, - 3.7e-05, - 3.4e-05, - 3.1e-05, - 9.8e-05, - 3.1e-05, - 5.2000000000000004e-05, - 3.5e-05, - null, - 2.8999999999999997e-05, - 7.000000000000001e-06, - 1.9e-05, - null, - 1.4999999999999999e-05, - 6.3e-05, - 4.1e-05, - null, - null, - 3.9e-05, - 1.1e-05, - 1e-05, - null, - 5e-06, - null - ] - }, - { - "name": "Cladophorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 2.2e-05, - 8e-06, - 4.1e-05, - 5e-05, - 7.2e-05, - 3.9e-05, - 2.8000000000000003e-05, - 0.00010700000000000001, - 6.3e-05, - 1.1e-05, - null, - 5.9999999999999995e-05, - null, - 3.3e-05, - 8.4e-05, - 6.2e-05, - 6.7e-05, - 5.9e-05, - 1e-05, - 2.8000000000000003e-05, - 1e-05, - 5.2000000000000004e-05, - 4.7e-05, - 0.000155, - null, - 7.2e-05, - 1.9e-05, - 0.000299, - 6.2e-05, - 0.000199, - 5e-05, - 6.9e-05, - 1.2e-05, - 1.3000000000000001e-05, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Ulotrichales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 0.00011200000000000001, - 0.00010700000000000001, - 6.1e-05, - 6.6e-05, - null, - null, - 0.000103, - 9.300000000000001e-05, - 7.2e-05, - 5.6999999999999996e-05, - null, - null, - 8.8e-05, - 2.2e-05, - 4.8e-05, - 8.499999999999999e-05, - 4.9e-05, - 2.5e-05, - 5.2000000000000004e-05, - 4.2e-05, - 1e-05, - 5.2000000000000004e-05, - 0.000106, - 8.7e-05, - 3.8e-05, - 2.8999999999999997e-05, - 5.1e-05, - 5.7999999999999994e-05, - 1.4999999999999999e-05, - 7.2e-05, - 7.5e-05, - 4.6e-05, - 3.7e-05, - null, - 3.4e-05, - null, - null, - null, - null - ] - }, - { - "name": "Leptomyxida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - null, - 3.1e-05, - 9.9e-05, - null, - null, - 1.9e-05, - 0.00011999999999999999, - 9e-06, - 4.6e-05, - null, - null, - 4.4e-05, - null, - 0.000675, - 4.5e-05, - 8.6e-05, - 8e-06, - 0.000217, - 4.2e-05, - 7.099999999999999e-05, - null, - 0.00011200000000000001, - null, - 2.8999999999999997e-05, - 1.4000000000000001e-05, - 6e-06, - 3.6e-05, - 6.2e-05, - 3.6e-05, - 2.5e-05, - null, - 4.3e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Laminariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 4.5e-05, - 8.2e-05, - 6.1e-05, - 4.1e-05, - null, - 7.8e-05, - 4.7e-05, - 5.3e-05, - 1.8e-05, - 3.4e-05, - 6.1e-05, - 0.00011999999999999999, - null, - 3.3e-05, - 8.4e-05, - 2.8000000000000003e-05, - 3.1e-05, - 3.4e-05, - 6.2e-05, - 0.00011200000000000001, - 3.1e-05, - 5.2000000000000004e-05, - 4.7e-05, - 7.7e-05, - 0.000105, - 0.00010700000000000001, - 6.9e-05, - 3.6e-05, - 2.3e-05, - 8.1e-05, - 3.3e-05, - null, - 6.2e-05, - 6.500000000000001e-05, - 1.1e-05, - 1e-05, - 9e-06, - null, - null - ] - }, - { - "name": "Diplonemida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 4.5e-05, - 0.00011499999999999999, - 2e-05, - 1.7e-05, - 0.000143, - 2e-05, - 2.8000000000000003e-05, - 9.300000000000001e-05, - 4.5e-05, - null, - 6.1e-05, - null, - 5.9e-05, - 3.3e-05, - 0.000102, - 6.8e-05, - 3.7e-05, - 5.9e-05, - 4.1e-05, - 2.8000000000000003e-05, - 5.1e-05, - 5.2000000000000004e-05, - 8.9e-05, - 6.8e-05, - 4.8e-05, - 6.4e-05, - 2.5e-05, - 0.000124, - 3.9e-05, - 4.5e-05, - 9.1e-05, - null, - 3.7e-05, - null, - 1.1e-05, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Trichiida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 1.6e-05, - 1e-05, - 1.7e-05, - null, - 2e-05, - 1.9e-05, - 5.3e-05, - null, - 3.4e-05, - 0.000122, - 0.00018, - null, - 0.00024900000000000004, - 6.6e-05, - 2.8000000000000003e-05, - 3.7e-05, - 2.5e-05, - 2.1e-05, - 5.6000000000000006e-05, - 2e-05, - 5.2000000000000004e-05, - 3.5e-05, - 6.8e-05, - null, - 6.4e-05, - 3.8e-05, - 0.000168, - 0.00010800000000000001, - 0.00010800000000000001, - 6.6e-05, - 2.3e-05, - 2.5e-05, - null, - null, - null, - 2.8000000000000003e-05, - null, - null - ] - }, - { - "name": "Hildenbrandiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 6.7e-05, - 1.6e-05, - 2e-05, - 2.5e-05, - 0.000143, - 2e-05, - 9e-06, - 5.3e-05, - 5.4000000000000005e-05, - 3.4e-05, - 6.1e-05, - 5.9999999999999995e-05, - 5.9e-05, - 4.3e-05, - 7.2e-05, - 0.000102, - 3.7e-05, - 2.5e-05, - 1e-05, - 4.2e-05, - 3.1e-05, - null, - 9.4e-05, - 9.7e-05, - 4.8e-05, - 0.000136, - 3.2e-05, - 6.6e-05, - null, - 6.3e-05, - 0.00011599999999999999, - 2.3e-05, - 1.2e-05, - 1.3000000000000001e-05, - null, - null, - 9e-06, - null, - 1.7e-05 - ] - }, - { - "name": "Gonyaulacales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 4.5e-05, - 6.6e-05, - 3.1e-05, - 5.7999999999999994e-05, - null, - 5.9e-05, - 4.7e-05, - 0.00016, - 5.4000000000000005e-05, - 2.3e-05, - 6.1e-05, - 5.9999999999999995e-05, - 1.4999999999999999e-05, - 2.2e-05, - 0.000102, - 0.00013000000000000002, - 6.1e-05, - 5.1e-05, - 7.2e-05, - 1.4000000000000001e-05, - 1e-05, - 5.2000000000000004e-05, - 0.0001, - 1e-05, - 1.9e-05, - 3.6e-05, - 2.5e-05, - 7.3e-05, - 4.6e-05, - 5.4000000000000005e-05, - 2.5e-05, - 2.3e-05, - 6.2e-05, - null, - 1.1e-05, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Dictyotales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 9e-05, - 8e-06, - 3.1e-05, - 2.5e-05, - null, - null, - 9e-06, - 4e-05, - 9e-06, - 2.3e-05, - 0.000122, - null, - 7.4e-05, - 4.3e-05, - 0.000229, - 4e-05, - 3.7e-05, - 3.4e-05, - 6.2e-05, - 8.4e-05, - null, - 5.2000000000000004e-05, - 7.7e-05, - 8.7e-05, - 2.8999999999999997e-05, - 0.000157, - 6e-06, - 0.000139, - null, - 0.000126, - 3.3e-05, - null, - 1.2e-05, - null, - 1.1e-05, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Gloeochaetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - 8e-06, - null, - null, - 1.9e-05, - 8e-05, - null, - null, - 0.00024300000000000002, - null, - null, - 2.2e-05, - 7.2e-05, - 7.4e-05, - 3.1e-05, - 5.1e-05, - null, - null, - null, - null, - 0.000148, - 0.000261, - 1e-05, - 8.6e-05, - 1.9e-05, - 0.00027, - 3.1e-05, - 0.000145, - 5.7999999999999994e-05, - 2.3e-05, - 1.2e-05, - null, - null, - null, - 2.8000000000000003e-05, - null, - null - ] - }, - { - "name": "Fervidicoccales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 5.7999999999999994e-05, - 5.1e-05, - 9.9e-05, - 7.2e-05, - 3.9e-05, - 6.6e-05, - 1.3000000000000001e-05, - 5.4000000000000005e-05, - 1.1e-05, - 0.000122, - 0.00018, - 4.4e-05, - 3.3e-05, - 4.2e-05, - 7.900000000000001e-05, - null, - 5.1e-05, - 6.2e-05, - 7e-05, - 2e-05, - null, - 6.500000000000001e-05, - 1e-05, - 3.8e-05, - 4.3e-05, - 4.4e-05, - 0.000102, - 8e-06, - 2.7000000000000002e-05, - 4.1e-05, - 2.3e-05, - 6e-06, - 1.3000000000000001e-05, - null, - null, - 3.8e-05, - null, - null - ] - }, - { - "name": "Rhodymeniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 4.5e-05, - 8e-06, - null, - 2.5e-05, - null, - 3.9e-05, - null, - 8e-05, - 1.8e-05, - null, - 6.1e-05, - null, - 1.4999999999999999e-05, - 4.3e-05, - 3.6e-05, - 5.6999999999999996e-05, - 2.4e-05, - 3.4e-05, - 2.1e-05, - 8.4e-05, - 1e-05, - null, - 7.099999999999999e-05, - 0.000174, - 1e-05, - 9.300000000000001e-05, - 5.1e-05, - 0.000328, - 3.9e-05, - 0.00010800000000000001, - 5e-05, - null, - 2.5e-05, - null, - 1.1e-05, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Vaucheriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 1.6e-05, - 4.1e-05, - null, - null, - 3.9e-05, - 4.7e-05, - 0.000213, - 1.8e-05, - null, - 0.000182, - null, - null, - 4.3e-05, - 0.000301, - 2.8000000000000003e-05, - 3.1e-05, - 4.2e-05, - 3.1e-05, - null, - 3.1e-05, - null, - 0.00013000000000000002, - 1e-05, - 1.9e-05, - 3.6e-05, - 2.5e-05, - 3.6e-05, - 5.4000000000000005e-05, - 1.8e-05, - 9.1e-05, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Hapalidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 3.1e-05, - 1.7e-05, - null, - null, - 9e-06, - null, - 9e-06, - 4.6e-05, - 0.000182, - null, - null, - 5.4000000000000005e-05, - 1.8e-05, - null, - 6e-06, - 1.7e-05, - null, - null, - null, - null, - 1.8e-05, - 0.000145, - 1e-05, - 0.000644, - 3.2e-05, - 0.000124, - 8e-06, - 7.2e-05, - 8e-06, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Peltigerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 4.1e-05, - null, - null, - 9e-06, - 5.3e-05, - 9e-06, - 1.1e-05, - 0.000182, - 5.9999999999999995e-05, - null, - null, - 7.8e-05, - 3.4e-05, - 6e-06, - 5.9e-05, - 2.1e-05, - null, - null, - null, - 3.5e-05, - 5.7999999999999994e-05, - 1e-05, - 0.000443, - 4.4e-05, - 0.000109, - null, - 9e-05, - null, - 2.3e-05, - 3.7e-05, - 1.3000000000000001e-05, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Goniochloridales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 4.5e-05, - 1.6e-05, - null, - 7.5e-05, - null, - 2e-05, - 3.7e-05, - 2.7000000000000002e-05, - 2.7000000000000002e-05, - null, - null, - null, - 2.8999999999999997e-05, - null, - 5.9999999999999995e-05, - 3.4e-05, - 3.7e-05, - 5.1e-05, - 3.1e-05, - 2.8000000000000003e-05, - 2e-05, - null, - 0.0001, - 0.000106, - 3.8e-05, - 0.000122, - 5.6999999999999996e-05, - 0.000131, - 2.3e-05, - 0.000126, - 8e-06, - 4.6e-05, - 3.1e-05, - 1.3000000000000001e-05, - 1.1e-05, - null, - null, - null, - null - ] - }, - { - "name": "Synhymeniida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 7.5e-05, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - null, - 4.2e-05, - 6.8e-05, - 4.9e-05, - 0.000177, - 4.1e-05, - null, - null, - null, - 0.0001, - null, - null, - 0.000515, - null, - null, - 5.4000000000000005e-05, - 9e-05, - 7.5e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Eutreptiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 3.3e-05, - null, - 1.7e-05, - 7.2e-05, - 2e-05, - 9e-06, - 9.300000000000001e-05, - null, - null, - 0.00024300000000000002, - null, - 1.4999999999999999e-05, - 2.2e-05, - 5.9999999999999995e-05, - 3.4e-05, - 1.2e-05, - 3.4e-05, - null, - 2.8000000000000003e-05, - 6.1e-05, - 5.2000000000000004e-05, - 2.4e-05, - null, - 1e-05, - 3.6e-05, - 8.2e-05, - 0.000109, - 5.4000000000000005e-05, - 4.5e-05, - 8e-06, - 2.3e-05, - 1.2e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Plagiopylida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 9.300000000000001e-05, - null, - null, - null, - null, - null, - null, - 0.00044, - 1.1e-05, - 1.8e-05, - 1.7e-05, - null, - null, - 1e-05, - null, - 0.000295, - 1.9e-05, - null, - 0.000215, - null, - null, - null, - 9e-06, - 9.9e-05, - null, - null, - null, - 1.1e-05, - null, - null, - null, - null - ] - }, - { - "name": "Chlorodendrales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - null, - 1e-05, - 3.3e-05, - null, - 5.9e-05, - null, - 5.3e-05, - 1.8e-05, - 2.3e-05, - 6.1e-05, - 5.9999999999999995e-05, - 2.8999999999999997e-05, - 5.4000000000000005e-05, - 2.9999999999999997e-05, - 2.3e-05, - 3.1e-05, - 4.2e-05, - 3.1e-05, - null, - 5.1e-05, - null, - 7.7e-05, - 9.7e-05, - 1.9e-05, - 2.1e-05, - 4.4e-05, - 0.000124, - 8e-06, - 5.4000000000000005e-05, - 9.9e-05, - null, - 1.2e-05, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Chlamydodontida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - 6.1e-05, - null, - null, - 0.000174, - null, - null, - null, - 1.7e-05, - null, - null, - null, - null, - null, - 9.7e-05, - null, - 0.000544, - 8.8e-05, - 2.2e-05, - 0.000131, - 3.6e-05, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cymbellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 9e-05, - 2.5e-05, - 1e-05, - 4.1e-05, - null, - null, - 2.8000000000000003e-05, - 0.00011999999999999999, - 5.4000000000000005e-05, - 4.6e-05, - null, - null, - 2.8999999999999997e-05, - null, - 2.9999999999999997e-05, - 1.7e-05, - 4.9e-05, - 3.4e-05, - 8.3e-05, - null, - 2e-05, - 5.2000000000000004e-05, - 8.3e-05, - 4.8e-05, - 2.8999999999999997e-05, - 2.1e-05, - 6e-06, - 6.6e-05, - null, - 1.8e-05, - 5e-05, - null, - 1.9e-05, - null, - 1.1e-05, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Syndiniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - null, - 4.1e-05, - 1e-05, - null, - null, - 7.8e-05, - null, - 8e-05, - 9e-06, - 3.4e-05, - 0.000122, - null, - null, - 1.1e-05, - 4.2e-05, - 2.3e-05, - 2.4e-05, - 4.2e-05, - 8.3e-05, - 8.4e-05, - 1e-05, - null, - 2.9999999999999997e-05, - 2.8999999999999997e-05, - 1.9e-05, - 2.1e-05, - 1.3000000000000001e-05, - 2.8999999999999997e-05, - 1.4999999999999999e-05, - 9.9e-05, - 2.5e-05, - 2.3e-05, - 3.7e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Thoreales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 1.6e-05, - 5.1e-05, - 8e-06, - null, - 2e-05, - null, - 8e-05, - 1.8e-05, - null, - null, - null, - 2.8999999999999997e-05, - null, - 6.6e-05, - 0.00013000000000000002, - 1.8e-05, - 1.7e-05, - 3.1e-05, - 2.8000000000000003e-05, - 1e-05, - null, - 0.000136, - 7.7e-05, - 1.9e-05, - 2.1e-05, - 1.3000000000000001e-05, - 0.000139, - 1.4999999999999999e-05, - 9e-05, - 2.5e-05, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pyrocystales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 8e-06, - null, - 8e-06, - null, - null, - 9e-06, - null, - 9e-06, - 1.1e-05, - 0.000122, - null, - 1.4999999999999999e-05, - 1.1e-05, - 3.6e-05, - 6e-06, - 3.1e-05, - 2.5e-05, - 2.1e-05, - 4.2e-05, - 1e-05, - null, - 5.9e-05, - 3.9e-05, - 2.8999999999999997e-05, - 0.0001, - 1.3000000000000001e-05, - 6.6e-05, - 2.3e-05, - 7.2e-05, - 1.7e-05, - 0.000138, - 1.9e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Acrasida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 8e-06, - null, - 1.7e-05, - null, - null, - null, - 6.7e-05, - null, - null, - 6.1e-05, - null, - null, - 1.1e-05, - 4.8e-05, - 2.8000000000000003e-05, - 4.3e-05, - 5.9e-05, - null, - null, - 2e-05, - null, - 2.4e-05, - 0.000106, - 1e-05, - 0.000129, - 3.2e-05, - 7.3e-05, - 8e-06, - 9.9e-05, - 5.7999999999999994e-05, - null, - 3.7e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Nassellaria", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - 1.9e-05, - 2.7000000000000002e-05, - 9e-06, - null, - 0.000365, - null, - null, - 3.3e-05, - 4.2e-05, - 6e-06, - 6e-06, - 6.7e-05, - null, - null, - null, - null, - 4.7e-05, - 3.9e-05, - 1e-05, - 4.3e-05, - 3.8e-05, - 9.499999999999999e-05, - 8e-06, - 2.7000000000000002e-05, - 8e-06, - 2.3e-05, - 6e-06, - 2.6000000000000002e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Gelidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 2.5e-05, - 1e-05, - 4.1e-05, - null, - null, - 3.7e-05, - 5.3e-05, - null, - 1.1e-05, - null, - null, - 1.4999999999999999e-05, - 4.3e-05, - 0.000102, - 4.5e-05, - 1.8e-05, - 1.7e-05, - 1e-05, - 2.8000000000000003e-05, - 6.1e-05, - null, - 6.500000000000001e-05, - 3.9e-05, - 1.9e-05, - 6.4e-05, - 2.5e-05, - 4.4e-05, - 1.4999999999999999e-05, - 1.8e-05, - 8.3e-05, - null, - 1.9e-05, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Microthoracida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 6.7e-05, - null, - null, - null, - null, - null, - null, - 5.4000000000000005e-05, - 5.1e-05, - 4.9e-05, - 0.000185, - null, - null, - null, - null, - 4.1e-05, - 5.7999999999999994e-05, - 1e-05, - 0.00024300000000000002, - 1.3000000000000001e-05, - null, - null, - null, - 0.00014099999999999998, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Microstromatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00015900000000000002, - 2.2e-05, - null, - 3.1e-05, - 8e-06, - null, - null, - 2.8000000000000003e-05, - 1.3000000000000001e-05, - null, - 6.8e-05, - null, - null, - 2.8999999999999997e-05, - 4.3e-05, - 1.8e-05, - 1.1e-05, - 1.2e-05, - 2.5e-05, - 4.1e-05, - 0.00011200000000000001, - 6.1e-05, - null, - 7.099999999999999e-05, - 1.9e-05, - null, - 7.000000000000001e-06, - 1.9e-05, - 2.8999999999999997e-05, - 8e-06, - 1.8e-05, - 8e-06, - null, - 4.3e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Plocamiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 2.7000000000000002e-05, - null, - 2.3e-05, - null, - null, - 1.4999999999999999e-05, - null, - 5.4000000000000005e-05, - 2.3e-05, - 1.2e-05, - 8e-06, - 7.2e-05, - 4.2e-05, - 2e-05, - null, - 1.8e-05, - 3.9e-05, - 1.9e-05, - 8.6e-05, - 1.3000000000000001e-05, - 8.8e-05, - 2.3e-05, - 0.00020800000000000001, - 1.7e-05, - null, - null, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Prorodontida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - 1.1e-05, - 0.000217, - 0.00013000000000000002, - 6.7e-05, - 6.7e-05, - null, - null, - null, - null, - 0.000148, - 1e-05, - 1e-05, - 7.000000000000001e-06, - 6e-06, - 7.000000000000001e-06, - null, - null, - 9.1e-05, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Palmariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - 1e-05, - null, - 7.2e-05, - 2e-05, - 1.9e-05, - 1.3000000000000001e-05, - 9e-06, - 2.3e-05, - null, - 5.9999999999999995e-05, - null, - null, - 1.2e-05, - null, - 6e-06, - 3.4e-05, - 1e-05, - null, - 2e-05, - null, - 8.3e-05, - 8.7e-05, - 1.9e-05, - 0.00010700000000000001, - 6e-06, - 3.6e-05, - null, - 5.4000000000000005e-05, - 6.6e-05, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Prorocentrales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 4.5e-05, - 1.6e-05, - 4.1e-05, - null, - null, - 2e-05, - 2.8000000000000003e-05, - 2.7000000000000002e-05, - null, - 1.1e-05, - null, - null, - null, - 5.4000000000000005e-05, - 2.9999999999999997e-05, - 1.7e-05, - 3.7e-05, - 1.7e-05, - 4.1e-05, - 1.4000000000000001e-05, - 2e-05, - null, - 1.8e-05, - 1e-05, - 1e-05, - 5e-05, - 1.9e-05, - 5.1e-05, - 3.1e-05, - 8.1e-05, - 8e-06, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Batrachospermales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 8e-06, - null, - null, - null, - null, - null, - 2.7000000000000002e-05, - 1.8e-05, - null, - null, - null, - null, - 2.2e-05, - 5.4000000000000005e-05, - 4e-05, - 4.9e-05, - 4.2e-05, - 5.2000000000000004e-05, - 4.2e-05, - 1e-05, - null, - 7.099999999999999e-05, - 4.8e-05, - 1e-05, - 3.6e-05, - 6e-06, - 5.7999999999999994e-05, - null, - 4.5e-05, - 7.5e-05, - null, - 3.1e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Olpidiopsidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 0.000365, - null, - null, - null, - null, - 1.1e-05, - 6e-06, - null, - null, - null, - null, - null, - null, - 9.7e-05, - 1e-05, - 2.1e-05, - null, - 0.000168, - null, - 5.4000000000000005e-05, - 8e-06, - null, - 6e-06, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Sessilida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 0.000152, - 4.8e-05, - 1.1e-05, - 3.7e-05, - 4.2e-05, - null, - null, - null, - null, - 3.5e-05, - 7.7e-05, - 1.9e-05, - 7.900000000000001e-05, - 4.4e-05, - 3.6e-05, - 5.4000000000000005e-05, - 1.8e-05, - 8e-06, - null, - 1.9e-05, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Nanoarchaeales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - 2.2e-05, - 1.6e-05, - null, - 1.7e-05, - null, - 2e-05, - 9e-06, - 1.3000000000000001e-05, - 2.7000000000000002e-05, - 2.3e-05, - null, - null, - 2.8999999999999997e-05, - 2.2e-05, - 2.9999999999999997e-05, - 4.5e-05, - 2.4e-05, - 8e-06, - 2.1e-05, - 4.2e-05, - 1e-05, - null, - 2.9999999999999997e-05, - 1e-05, - 2.8999999999999997e-05, - 1.4000000000000001e-05, - 1.3000000000000001e-05, - 2.8999999999999997e-05, - 3.1e-05, - 1.8e-05, - 1.7e-05, - null, - 1.9e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Diversisporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 4.5e-05, - null, - 2e-05, - 8e-06, - null, - null, - 2.8000000000000003e-05, - 2.7000000000000002e-05, - 1.8e-05, - null, - 0.000122, - null, - 4.4e-05, - null, - 1.8e-05, - 1.1e-05, - 6e-06, - 4.2e-05, - null, - 5.6000000000000006e-05, - null, - null, - 1.8e-05, - 1e-05, - 2.8999999999999997e-05, - 1.4000000000000001e-05, - 1.9e-05, - 7.000000000000001e-06, - null, - 9e-05, - 1.7e-05, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Lagenidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 8e-06, - 1e-05, - 1.7e-05, - null, - null, - null, - 6.7e-05, - 9e-06, - 1.1e-05, - null, - null, - null, - 1.1e-05, - 0.000109, - 3.4e-05, - 6.7e-05, - 8e-06, - null, - null, - null, - 5.2000000000000004e-05, - 4.1e-05, - 2.8999999999999997e-05, - null, - 7.000000000000001e-06, - 6e-06, - 5.7999999999999994e-05, - null, - 2.7000000000000002e-05, - 1.7e-05, - null, - 6e-06, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Hibberdiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - 2.3e-05, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - 0.000242, - null, - null, - null, - 0.00021899999999999998, - null, - 8.1e-05, - null, - null, - 1.2e-05, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Halymeniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 1.6e-05, - 1e-05, - 1.7e-05, - null, - null, - 9e-06, - 5.3e-05, - 9e-06, - 1.1e-05, - null, - 5.9999999999999995e-05, - 1.4999999999999999e-05, - null, - 1.8e-05, - 2.3e-05, - 1.8e-05, - 2.5e-05, - 1e-05, - 1.4000000000000001e-05, - null, - null, - 2.4e-05, - 2.8999999999999997e-05, - null, - 2.8999999999999997e-05, - 6e-06, - 2.8999999999999997e-05, - 8e-06, - 9.9e-05, - 4.1e-05, - null, - null, - null, - null, - 1e-05, - 9e-06, - null, - null - ] - }, - { - "name": "Porphyridiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - 1e-05, - 2.5e-05, - null, - null, - 7.5e-05, - 1.3000000000000001e-05, - 5.4000000000000005e-05, - null, - null, - null, - 2.8999999999999997e-05, - 2.2e-05, - 7.8e-05, - 2.3e-05, - 1.8e-05, - 2.5e-05, - null, - 4.2e-05, - 2e-05, - null, - 6e-06, - 1.9e-05, - 3.8e-05, - null, - 6e-06, - 7.000000000000001e-06, - 4.6e-05, - 1.8e-05, - 2.5e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Lecanorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 6.7e-05, - null, - 3.1e-05, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - 6.1e-05, - null, - 1.4999999999999999e-05, - 2.2e-05, - 2.4e-05, - 1.1e-05, - 5.5e-05, - 1.7e-05, - 8.3e-05, - null, - 1e-05, - 5.2000000000000004e-05, - 1.2e-05, - 1e-05, - 1e-05, - 7.000000000000001e-06, - null, - 1.4999999999999999e-05, - null, - 1.8e-05, - 8e-06, - null, - 6e-06, - null, - 1.1e-05, - null, - null, - null, - null - ] - }, - { - "name": "Kriegeriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 3.3e-05, - null, - 8e-06, - 7.2e-05, - null, - 5.6000000000000006e-05, - 2.7000000000000002e-05, - 9e-06, - 1.1e-05, - null, - 5.9999999999999995e-05, - null, - null, - 1.2e-05, - 6e-06, - 3.7e-05, - 5.1e-05, - 1e-05, - 2.8000000000000003e-05, - null, - null, - 1.8e-05, - 5.7999999999999994e-05, - 1e-05, - 7.000000000000001e-06, - null, - 7.000000000000001e-06, - null, - 1.8e-05, - 1.7e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Bursariomorphida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 0.00010700000000000001, - null, - null, - null, - null, - null, - null, - 1.2e-05, - 2.3e-05, - 1.8e-05, - 9.300000000000001e-05, - null, - null, - null, - null, - 6e-06, - 4.8e-05, - 1e-05, - 0.000172, - null, - null, - null, - 1.8e-05, - 3.3e-05, - null, - 6e-06, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Bonnemaisoniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 2.8000000000000003e-05, - 1.3000000000000001e-05, - 3.6e-05, - null, - null, - null, - 1.4999999999999999e-05, - null, - 2.9999999999999997e-05, - 1.1e-05, - 2.4e-05, - 8e-06, - 4.1e-05, - 4.2e-05, - null, - 5.2000000000000004e-05, - 2.4e-05, - 7.7e-05, - 1.9e-05, - null, - 6e-06, - 1.4999999999999999e-05, - 1.4999999999999999e-05, - 4.5e-05, - null, - null, - 6e-06, - null, - 1.1e-05, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Echinosteliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 8e-06, - null, - 1.7e-05, - null, - 2e-05, - null, - null, - 9e-06, - 1.1e-05, - null, - null, - null, - 3.3e-05, - 1.8e-05, - null, - 1.2e-05, - 1.7e-05, - null, - null, - 5.1e-05, - null, - 2.9999999999999997e-05, - 3.9e-05, - null, - 5e-05, - 4.4e-05, - 3.6e-05, - 8e-06, - 2.7000000000000002e-05, - 8e-06, - null, - 6e-06, - 3.9e-05, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Dinophysiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 1.6e-05, - 1e-05, - 8e-06, - null, - null, - 9e-06, - null, - 3.6e-05, - null, - null, - null, - null, - 2.2e-05, - 5.9999999999999995e-05, - 1.1e-05, - 1.2e-05, - 8e-06, - 2.1e-05, - 1.4000000000000001e-05, - null, - null, - 3.5e-05, - 1e-05, - null, - 5e-05, - 1.3000000000000001e-05, - 6.6e-05, - 3.1e-05, - 1.8e-05, - null, - null, - 3.7e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Candidatus Peribacterales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 6.6e-05, - null, - 1.7e-05, - null, - null, - 2.8000000000000003e-05, - 1.3000000000000001e-05, - 9e-06, - null, - null, - null, - 2.8999999999999997e-05, - null, - 2.9999999999999997e-05, - 3.4e-05, - null, - 1.7e-05, - null, - 7e-05, - 2e-05, - null, - 1.8e-05, - 5.7999999999999994e-05, - 3.8e-05, - null, - 6e-06, - 2.2e-05, - 8e-06, - 9e-06, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Stylonematales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - null, - 1.6e-05, - 2e-05, - null, - null, - 3.9e-05, - 3.7e-05, - 1.3000000000000001e-05, - 9e-06, - 3.4e-05, - 6.1e-05, - null, - 1.4999999999999999e-05, - null, - 1.2e-05, - 6e-06, - null, - 1.7e-05, - 3.1e-05, - null, - 1e-05, - null, - 6e-06, - null, - 1e-05, - null, - null, - 7.000000000000001e-06, - null, - 9e-06, - 3.3e-05, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Spumellaria", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 4.1e-05, - 2e-05, - 8e-06, - null, - 2e-05, - 1.9e-05, - null, - null, - 2.3e-05, - null, - null, - 1.4999999999999999e-05, - 1.1e-05, - 2.9999999999999997e-05, - 1.7e-05, - 2.4e-05, - 2.5e-05, - 1e-05, - 7e-05, - 2e-05, - 5.2000000000000004e-05, - 1.2e-05, - 1e-05, - 1e-05, - null, - null, - null, - null, - null, - 8e-06, - null, - 1.9e-05, - null, - 1.1e-05, - null, - null, - null, - null - ] - }, - { - "name": "Lithodesmiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 4.5e-05, - null, - null, - 3.3e-05, - null, - null, - null, - 2.7000000000000002e-05, - 1.8e-05, - 1.1e-05, - null, - null, - null, - null, - 2.9999999999999997e-05, - 6e-06, - 1.2e-05, - 6.7e-05, - 2.1e-05, - 1.4000000000000001e-05, - null, - null, - 3.5e-05, - 1e-05, - null, - 7.000000000000001e-06, - null, - null, - null, - 2.7000000000000002e-05, - 3.3e-05, - null, - 1.9e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Loxodida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6.1e-05, - null, - null, - 3.3e-05, - 1.2e-05, - 1.7e-05, - 2.4e-05, - null, - null, - null, - null, - null, - 6e-06, - 0.000165, - null, - 3.6e-05, - 3.2e-05, - 1.4999999999999999e-05, - 8e-06, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - null, - 1.9e-05, - null, - null - ] - }, - { - "name": "Telonemida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - null, - 1.6e-05, - 1e-05, - 8e-06, - 7.2e-05, - null, - 9e-06, - null, - null, - null, - null, - 5.9999999999999995e-05, - null, - null, - 6e-06, - 1.1e-05, - 2.4e-05, - 8e-06, - null, - null, - null, - null, - 2.9999999999999997e-05, - 1e-05, - null, - 2.8999999999999997e-05, - null, - 7.000000000000001e-06, - 8e-06, - 2.7000000000000002e-05, - 8e-06, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Leptomitales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 2.7000000000000002e-05, - null, - 1.1e-05, - null, - null, - null, - 4.3e-05, - 2.9999999999999997e-05, - 6e-06, - 6e-06, - 8e-06, - 2.1e-05, - null, - null, - null, - 6e-06, - 6.8e-05, - null, - 7.000000000000001e-06, - 1.3000000000000001e-05, - 0.000153, - 1.4999999999999999e-05, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Phaeocystales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - 8e-06, - null, - null, - null, - null, - 9e-06, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - 1.1e-05, - 6e-06, - 1.1e-05, - 1.8e-05, - 2.5e-05, - null, - null, - null, - null, - 2.4e-05, - 3.9e-05, - 2.8999999999999997e-05, - 2.1e-05, - null, - 8.8e-05, - 1.4999999999999999e-05, - 4.5e-05, - 8e-06, - null, - 6e-06, - 1.3000000000000001e-05, - null, - 1e-05, - 9e-06, - null, - null - ] - }, - { - "name": "Pseudoamphisiellida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6.1e-05, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - 2.4e-05, - 8.7e-05, - null, - 2.8999999999999997e-05, - null, - 9.499999999999999e-05, - 1.4999999999999999e-05, - 9e-05, - 8e-06, - null, - null, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Ahnfeltiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - 2e-05, - null, - 2.7000000000000002e-05, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - null, - 2.8000000000000003e-05, - 1.2e-05, - 1.7e-05, - null, - null, - 1e-05, - 0.000157, - 2.9999999999999997e-05, - 1e-05, - null, - 7.000000000000001e-06, - null, - 1.4999999999999999e-05, - null, - null, - 2.5e-05, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Lituolida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 6.7e-05, - 8e-06, - null, - 8e-06, - null, - null, - null, - 5.3e-05, - null, - null, - null, - null, - null, - null, - 0.000133, - 1.7e-05, - 2.4e-05, - 5.1e-05, - null, - null, - null, - null, - 1.2e-05, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pinguiochrysidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - 3.7e-05, - 1.3000000000000001e-05, - 1.8e-05, - null, - null, - null, - null, - 1.1e-05, - 2.4e-05, - 1.1e-05, - 1.2e-05, - 8e-06, - 4.1e-05, - 1.4000000000000001e-05, - null, - null, - 1.2e-05, - null, - null, - null, - 1.3000000000000001e-05, - 7.3e-05, - null, - 2.7000000000000002e-05, - 8e-06, - null, - 1.9e-05, - null, - null, - 1e-05, - 9e-06, - null, - null - ] - }, - { - "name": "Umbelopsidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - 1.7e-05, - null, - null, - null, - 1.3000000000000001e-05, - 9e-06, - 1.1e-05, - null, - null, - null, - 2.2e-05, - 2.9999999999999997e-05, - 2.3e-05, - 6e-06, - 3.4e-05, - 1e-05, - 4.2e-05, - null, - null, - 2.4e-05, - null, - null, - 2.1e-05, - 1.9e-05, - 7.000000000000001e-06, - null, - 1.8e-05, - 4.1e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Noctilucales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - 2.8000000000000003e-05, - 2.7000000000000002e-05, - 9e-06, - null, - null, - null, - 1.4999999999999999e-05, - null, - 1.2e-05, - 1.1e-05, - null, - null, - 3.1e-05, - 4.2e-05, - null, - null, - 1.2e-05, - null, - null, - 1.4000000000000001e-05, - 6e-06, - 2.8999999999999997e-05, - 8e-06, - 7.2e-05, - 8e-06, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Sebdeniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.00011899999999999999, - null, - 3.3e-05, - 2e-05, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - 1.1e-05, - 6e-06, - 1.1e-05, - 6e-06, - 1.7e-05, - null, - 1.4000000000000001e-05, - null, - null, - 6e-06, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - 3.6e-05, - 8e-06, - null, - 2.5e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pedinomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 9e-05, - null, - 1e-05, - 8e-06, - null, - 2e-05, - 3.7e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - 1.4999999999999999e-05, - null, - 2.4e-05, - 6e-06, - null, - 8e-06, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - 7.000000000000001e-06, - 8e-06, - 2.7000000000000002e-05, - 2.5e-05, - null, - 2.5e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Chaetophorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - 3.7e-05, - null, - null, - 1.1e-05, - null, - null, - 1.4999999999999999e-05, - null, - 6e-06, - 1.7e-05, - 6e-06, - 8e-06, - null, - null, - 1e-05, - null, - 6e-06, - 1.9e-05, - null, - 2.8999999999999997e-05, - null, - null, - null, - 0.000117, - 2.5e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cristamonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - 9e-06, - 1.1e-05, - null, - null, - null, - 1.1e-05, - 6e-06, - null, - 1.8e-05, - null, - null, - null, - null, - null, - 1.8e-05, - 4.8e-05, - 1.9e-05, - 0.000129, - null, - null, - null, - null, - 8e-06, - null, - 6e-06, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Polychytriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 9e-06, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 0.00016299999999999998, - 6e-06, - 1.2e-05, - 3.4e-05, - 2.1e-05, - null, - 1e-05, - null, - 6e-06, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - 8e-06, - null, - 1.2e-05, - null, - null, - null, - null, - 5e-06, - null - ] - }, - { - "name": "Myzocytiopsidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - 2e-05, - null, - 5.3e-05, - null, - null, - null, - null, - null, - null, - 5.4000000000000005e-05, - 1.7e-05, - 2.4e-05, - 1.7e-05, - 3.1e-05, - 1.4000000000000001e-05, - null, - null, - 6e-06, - 1.9e-05, - 1e-05, - 7.000000000000001e-06, - null, - null, - null, - 1.8e-05, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Chaetopeltidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 1.6e-05, - 1e-05, - 1.7e-05, - 7.2e-05, - null, - null, - null, - 9e-06, - null, - null, - null, - 1.4999999999999999e-05, - 1.1e-05, - 1.2e-05, - 6e-06, - 6e-06, - 1.7e-05, - null, - 1.4000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - 8e-06, - null, - 8e-06, - 4.6e-05, - 1.2e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Tribonematales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - 9e-06, - null, - 9e-06, - null, - null, - null, - null, - null, - 1.2e-05, - 1.1e-05, - 2.4e-05, - 1.7e-05, - null, - null, - null, - null, - 6e-06, - 1.9e-05, - 1e-05, - 5e-05, - null, - 4.4e-05, - null, - 5.4000000000000005e-05, - 8e-06, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Slopalinida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - 2.2e-05, - 2.9999999999999997e-05, - 1.1e-05, - 2.4e-05, - 5.1e-05, - null, - null, - null, - null, - 3.5e-05, - 1.9e-05, - null, - null, - null, - 7.000000000000001e-06, - null, - 1.8e-05, - 5e-05, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Sphenomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 3.3e-05, - null, - 1.7e-05, - null, - null, - null, - 2.7000000000000002e-05, - 1.8e-05, - null, - null, - null, - null, - null, - 1.8e-05, - null, - 1.8e-05, - 8e-06, - 1e-05, - null, - null, - 0.000105, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - 8e-06, - null, - 6e-06, - null, - 1.1e-05, - null, - null, - null, - null - ] - }, - { - "name": "Cladochytriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - 6.1e-05, - null, - null, - null, - 4.2e-05, - 6e-06, - 6e-06, - 8e-06, - null, - null, - null, - null, - 6e-06, - 1.9e-05, - null, - 7.000000000000001e-06, - null, - 4.4e-05, - null, - 9e-06, - null, - null, - 6e-06, - 3.9e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Anisolpidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - 2.8999999999999997e-05, - null, - 5.6999999999999996e-05, - 3.2e-05, - 5.7999999999999994e-05, - 4.6e-05, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Erythrobasidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - 9e-06, - null, - 1.8e-05, - null, - null, - null, - null, - 1.1e-05, - 1.2e-05, - 1.7e-05, - null, - null, - 3.1e-05, - null, - null, - 5.2000000000000004e-05, - 1.2e-05, - null, - 1e-05, - null, - 2.5e-05, - 1.4999999999999999e-05, - 1.4999999999999999e-05, - 1.8e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cyrtolophosidida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - 4.2e-05, - 1.7e-05, - 1.8e-05, - 5.9e-05, - null, - null, - null, - null, - 1.8e-05, - 1e-05, - null, - 2.1e-05, - null, - null, - null, - null, - 4.1e-05, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pleuronematida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.9999999999999997e-05, - 0.000113, - 1.8e-05, - null, - null, - null, - null, - null, - 6e-06, - 1.9e-05, - null, - 4.3e-05, - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Prasiolales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 4.5e-05, - null, - null, - 8e-06, - null, - null, - null, - 1.3000000000000001e-05, - 9e-06, - null, - null, - null, - null, - null, - null, - 1.7e-05, - 6e-06, - 8e-06, - 1e-05, - null, - 1e-05, - null, - 2.9999999999999997e-05, - 2.8999999999999997e-05, - null, - 7.000000000000001e-06, - 6e-06, - 1.4999999999999999e-05, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Rigifilida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 1.6e-05, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - 2.2e-05, - 4.2e-05, - 1.7e-05, - null, - null, - 1e-05, - null, - null, - null, - 6e-06, - 2.8999999999999997e-05, - null, - 7.000000000000001e-06, - 6e-06, - 7.000000000000001e-06, - 8e-06, - 1.8e-05, - null, - null, - 1.9e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Oltmansiellopsidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - 8e-06, - null, - 2e-05, - null, - null, - null, - null, - null, - null, - 1.4999999999999999e-05, - null, - null, - 1.1e-05, - 6e-06, - 8e-06, - null, - 8.4e-05, - 4.1e-05, - null, - null, - null, - null, - 1.4000000000000001e-05, - null, - null, - null, - null, - 8e-06, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Palmophyllales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 1.6e-05, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - 9e-06, - null, - null, - null, - null, - null, - 1.8e-05, - 3.4e-05, - null, - 1.7e-05, - null, - null, - null, - null, - null, - 1e-05, - 2.8999999999999997e-05, - null, - null, - null, - null, - 2.7000000000000002e-05, - 3.3e-05, - null, - null, - 1.3000000000000001e-05, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Rhizosoleniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - 2e-05, - 1.9e-05, - null, - null, - 1.1e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - 8e-06, - null, - 4.2e-05, - 4.1e-05, - null, - null, - 1e-05, - null, - null, - null, - null, - 2.3e-05, - 1.8e-05, - 8e-06, - null, - null, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Choreotrichida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6.500000000000001e-05, - 1.2e-05, - null, - 1.8e-05, - null, - null, - null, - null, - null, - 6e-06, - 4.8e-05, - null, - 2.1e-05, - 1.3000000000000001e-05, - null, - 1.4999999999999999e-05, - 9e-06, - null, - null, - 6e-06, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Mischococcales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - 1.4999999999999999e-05, - null, - 1.8e-05, - 2.3e-05, - 2.4e-05, - 1.7e-05, - null, - null, - null, - null, - 1.8e-05, - null, - null, - 1.4000000000000001e-05, - null, - 3.6e-05, - 8e-06, - null, - 3.3e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Coccolithales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - 1.7e-05, - null, - null, - null, - 2.7000000000000002e-05, - null, - null, - null, - null, - 2.8999999999999997e-05, - null, - 6e-06, - null, - 1.8e-05, - 1.7e-05, - null, - null, - 1e-05, - null, - 1.2e-05, - 1e-05, - null, - 7.000000000000001e-06, - null, - 7.000000000000001e-06, - 1.4999999999999999e-05, - 9e-06, - 8e-06, - null, - null, - null, - 1.1e-05, - null, - null, - null, - null - ] - }, - { - "name": "Hypotrichomonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 4.2e-05, - null, - 6e-06, - null, - 8.3e-05, - null, - null, - null, - 3.5e-05, - 1e-05, - 1.9e-05, - null, - null, - null, - 8e-06, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Thelephorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - 1e-05, - 1.7e-05, - null, - null, - 3.7e-05, - 1.3000000000000001e-05, - null, - 1.1e-05, - null, - null, - null, - null, - 1.8e-05, - 2.3e-05, - 1.2e-05, - null, - null, - null, - null, - null, - 4.1e-05, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Ignatiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - 2.5e-05, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 1.8e-05, - 6e-06, - 6e-06, - 8e-06, - null, - 1.4000000000000001e-05, - 2e-05, - null, - 6e-06, - null, - null, - null, - 6e-06, - 7.000000000000001e-06, - null, - 2.7000000000000002e-05, - 1.7e-05, - null, - 6e-06, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Phaeocystida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - 1.2e-05, - null, - null, - null, - null, - null, - 1.2e-05, - 2.8999999999999997e-05, - null, - 2.8999999999999997e-05, - 6e-06, - 4.4e-05, - 8e-06, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Chaunacanthida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - 1.7e-05, - 1.2e-05, - 1.7e-05, - 1e-05, - null, - null, - null, - 2.9999999999999997e-05, - null, - null, - 7.000000000000001e-06, - 6e-06, - 1.4999999999999999e-05, - 8e-06, - 1.8e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Desmarestiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - 6.1e-05, - null, - null, - null, - 1.2e-05, - 6e-06, - 6e-06, - 2.5e-05, - null, - null, - null, - null, - 2.4e-05, - null, - null, - 1.4000000000000001e-05, - 6e-06, - null, - 8e-06, - null, - 8e-06, - null, - 6e-06, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Caliciales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 1.6e-05, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - 6.1e-05, - null, - null, - 3.3e-05, - null, - 6e-06, - null, - null, - null, - 1.4000000000000001e-05, - null, - null, - null, - 1e-05, - 1e-05, - null, - 1.3000000000000001e-05, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Candidatus Nitrosocaldales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 9e-06, - 1.3000000000000001e-05, - null, - 1.1e-05, - null, - null, - 1.4999999999999999e-05, - null, - 6e-06, - 6e-06, - 6e-06, - 1.7e-05, - null, - 2.8000000000000003e-05, - null, - null, - null, - null, - 4.8e-05, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Coronophorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.9999999999999997e-05, - null, - null, - 8e-06, - null, - null, - null, - null, - 1.8e-05, - 1.9e-05, - null, - 7.000000000000001e-06, - 6e-06, - 7.000000000000001e-06, - 3.9e-05, - 9e-06, - null, - null, - 6e-06, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Agaricostilbales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - 1.1e-05, - 6e-06, - null, - 1.2e-05, - 2.5e-05, - null, - null, - null, - null, - 6e-06, - 1.9e-05, - 1e-05, - null, - 6e-06, - 7.000000000000001e-06, - 8e-06, - 3.6e-05, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Exogenida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.2e-05, - 3.6e-05, - 6e-06, - 6e-06, - 8e-06, - null, - null, - null, - null, - null, - 2.8999999999999997e-05, - null, - null, - null, - 5.1e-05, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Trichonymphida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - 1.2e-05, - 6e-06, - 6e-06, - 8e-06, - 1e-05, - null, - null, - null, - 6e-06, - 2.8999999999999997e-05, - null, - 1.4000000000000001e-05, - null, - 7.000000000000001e-06, - 1.4999999999999999e-05, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Hemiaulales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - 4.5e-05, - 1.1e-05, - null, - null, - 1.4999999999999999e-05, - null, - 1.2e-05, - 6e-06, - 6e-06, - null, - 4.1e-05, - null, - null, - null, - 6e-06, - null, - 1e-05, - 7.000000000000001e-06, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Ralfsiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 7.900000000000001e-05, - null, - 8e-06, - null, - null, - null, - null, - 2.8000000000000003e-05, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - 1.4999999999999999e-05, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Dimargaritales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - 7.2e-05, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - 1.4000000000000001e-05, - null, - null, - null, - 1.8e-05, - null, - null, - 2.5e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Ochromonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 2.5e-05, - null, - 8e-06, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 1.8e-05, - 6e-06, - null, - 2.5e-05, - null, - null, - null, - null, - 2.4e-05, - null, - 1e-05, - null, - null, - null, - null, - null, - 1.7e-05, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Endogonales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - 1.1e-05, - 6e-06, - null, - null, - 8e-06, - null, - 5.6000000000000006e-05, - null, - null, - null, - null, - null, - 2.8999999999999997e-05, - null, - 7.000000000000001e-06, - null, - 1.8e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Chlorosarcinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 2.5e-05, - 3.1e-05, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - 6e-06, - 1.1e-05, - null, - null, - 1e-05, - null, - null, - null, - 6e-06, - null, - 1e-05, - 7.000000000000001e-06, - 6e-06, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Tintinnida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 3.3e-05, - 1.2e-05, - null, - 1.2e-05, - null, - null, - null, - 1e-05, - null, - 6e-06, - 1.9e-05, - null, - 7.000000000000001e-06, - 6e-06, - 1.4999999999999999e-05, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Moniliellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - 9e-06, - null, - null, - 1.1e-05, - null, - null, - null, - null, - 6e-06, - 1.1e-05, - 6e-06, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - 8e-06, - null, - null, - 5.2000000000000004e-05, - null, - null, - null, - null, - null - ] - }, - { - "name": "Melosirales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - 2.2e-05, - 8e-06, - null, - null, - null, - null, - null, - null, - 1.8e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 8e-06, - null, - null, - null, - null, - 6e-06, - null, - null, - 7.000000000000001e-06, - null, - 1.4999999999999999e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Archaeorhizomycetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - null, - 6e-06, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9.300000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Teloschistales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 2.7000000000000002e-05, - null, - 1.1e-05, - null, - 5.9999999999999995e-05, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 8e-06, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Filobasidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - 2e-05, - null, - null, - null, - null, - null, - 5.9999999999999995e-05, - null, - null, - null, - null, - 6e-06, - 2.5e-05, - null, - 1.4000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pleurostomatida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.2e-05, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - 1.4000000000000001e-05, - 6e-06, - 2.8999999999999997e-05, - 8e-06, - 9e-06, - null, - null, - null, - null, - null, - null, - 2.8000000000000003e-05, - null, - null - ] - }, - { - "name": "Florenciellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 6.6e-05, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 6e-06, - 8e-06, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - 6e-06, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Endogenida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6.1e-05, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - 1e-05, - 1e-05, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pleurochloridellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - 1.9e-05, - null, - 7.000000000000001e-06, - null, - 5.7999999999999994e-05, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Zoopagales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - null, - null, - 6e-06, - null, - 1e-05, - null, - null, - null, - 6e-06, - null, - 1e-05, - null, - null, - 1.4999999999999999e-05, - null, - 1.8e-05, - 8e-06, - null, - 1.9e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Coscinodiscales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - 6e-06, - 8e-06, - 1e-05, - 1.4000000000000001e-05, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Symphyacanthida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - 2.8000000000000003e-05, - null, - null, - null, - 1e-05, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Oedogoniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 1.2e-05, - 1.1e-05, - null, - null, - null, - null, - 2e-05, - null, - null, - 2.8999999999999997e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Toxariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 1.7e-05, - null, - null, - null, - null, - 9e-06, - 1.1e-05, - null, - null, - 1.4999999999999999e-05, - 1.1e-05, - 6e-06, - 6e-06, - null, - 8e-06, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Leptocylindrales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - 8e-06, - null, - null, - null, - null, - null, - 1e-05, - 2.8999999999999997e-05, - 7.000000000000001e-06, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Dysteriida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.2e-05, - null, - null, - null, - null, - 2.1e-05, - null, - null, - null, - null, - null, - null, - 1.4000000000000001e-05, - 6e-06, - null, - 1.4999999999999999e-05, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Sarcinochrysidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 1.9e-05, - 4e-05, - null, - null, - null, - null, - null, - 1.1e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Phaeothamniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4e-05, - null, - 8e-06, - null, - 8e-06, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cocconeidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.8999999999999997e-05, - null, - null, - 1.1e-05, - null, - 8e-06, - 3.1e-05, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Chaetocerotales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - 9e-06, - 2.3e-05, - null, - null, - null, - null, - null, - 6e-06, - 6e-06, - 8e-06, - null, - 1.4000000000000001e-05, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Mastogloiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - 9e-06, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - 1.1e-05, - 6e-06, - null, - 1e-05, - null, - null, - null, - 6e-06, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Surirellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 1.1e-05, - null, - null, - null, - null, - 1.2e-05, - null, - null, - 8e-06, - null, - null, - null, - null, - 2.4e-05, - null, - 1e-05, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Trapeliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - 1.4000000000000001e-05, - null, - null, - null, - 1.9e-05, - null, - null, - null, - 7.000000000000001e-06, - 8e-06, - 1.8e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Ascoseirales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - 6e-06, - null, - null, - null, - null, - null, - null, - 2.9999999999999997e-05, - null, - 1e-05, - 7.000000000000001e-06, - null, - null, - null, - null, - 8e-06, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Savoryellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.4e-05, - 1.7e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - 7.000000000000001e-06, - null, - 1.4999999999999999e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Vestibuliferida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - 1.8e-05, - 6e-06, - 6e-06, - null, - null, - null, - null, - null, - 1.8e-05, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Biddulphiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - 2e-05, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 8e-06, - null, - null, - 3.1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cutleriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 2.7000000000000002e-05, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - 1.8e-05, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Trentepohliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.2e-05, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - 9e-06, - 8e-06, - null, - null, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Sporochnales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - 1.1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - 2.8000000000000003e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Ostropales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - 1.4999999999999999e-05, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Compsopogonales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.7e-05, - null, - 8e-06, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - 6e-06, - 7.000000000000001e-06, - null, - null, - 8e-06, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Helicobasidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.8000000000000003e-05, - 1e-05, - null, - null, - 1e-05, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Heterogastridiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 6e-06, - null, - null, - null, - null, - null, - 2.4e-05, - null, - null, - null, - 6e-06, - null, - 8e-06, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Scytothamnales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 4e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Sphacelariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - null, - null, - null, - null, - null, - null, - 2.9999999999999997e-05, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rapaza", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - 1.4999999999999999e-05, - null, - 9e-06, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Phallales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - 1.7e-05, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Eupodiscales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhizophlyctidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - 1.4999999999999999e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Myriangiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 8e-06, - null, - null, - null, - null, - null, - 1e-05, - null, - 7.000000000000001e-06, - null, - 7.000000000000001e-06, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Thalassionemales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 2.5e-05, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cryomonadida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - 2.8000000000000003e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Mobilida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - 1.9e-05, - null, - 7.000000000000001e-06, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Archaeosporales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 2.5e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhytismatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - 2.2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.4000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Dolichomastigales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 1.6e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - 1.4000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Triceratiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - 9e-06, - null, - null, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Blastodiniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pedinellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 1.6e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Marsupiomonadales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 6e-06, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - 7.000000000000001e-06, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Scotinosphaerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - 1e-05, - null, - 7.000000000000001e-06, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Phaeophilales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - 2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Septobasidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - 2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pertusariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.1e-05, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Thalassiophysales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - 2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Glaucosphaerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Colaconematales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Chaetosphaeriales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - 2e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhodothalassiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhizochloridales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Arthoniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 8e-06, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Lophodiniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 8e-06, - null, - null, - null, - 1.2e-05, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhodachlyales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Gomphales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Arthracanthida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Lichinales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null - ] - }, - { - "name": "Evaginogenida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Hypocomatida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1.2e-05, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Erythropeltidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 8e-06, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cystobasidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhodellales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Balliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cyclophorales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - 8e-06, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Botrydiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - 1.3000000000000001e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Spirotrichonymphida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Exobasidiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Abrothallales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Holtermanniales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rufusiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhaponeidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Entylomatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 1e-05, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Cyclotrichida", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Tilopteridales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Protoraphidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Tabellariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Syringodermatales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - 9e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Rhopalodiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - 8e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Lecideales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 7.000000000000001e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Spiculogloeales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Paraglomerales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Urocystidales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Acrochaetiales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Valsariales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Pleurotheciales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Koralionastetales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Chrysomeridales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null - ] - }, - { - "name": "Trypetheliales", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - null, - 6e-06, - null, - null, - null, - null, - null, - null - ] - } - ], - "layout": { - "barmode": "stack", - "hovermode": "closest", - "margin": { - "b": 200 - }, - "showlegend": false, - "title": "Assignments per Sample (Level: Order)", - "xaxis": { - "tickangle": -60 - }, - "yaxis": { - "title": "Percent" - } - } - }, - "text/html": [ - "
" - ], - "text/vnd.plotly.v1+html": [ - "
" - ] - }, - "metadata": {}, - "output_type": "display_data" - } - ], - "source": [ - "sub = m[[tax_level] + [\"Percent_%s\" % sample_order[i][0] for i in range(len(sample_order))]]\n", - "percents = sub.copy()\n", - "percents = percents[(~percents[tax_level].str.contains(\"unclassified|cannot\"))]\n", - "# percents = percents.head(20)\n", - "cols = percents.columns.tolist()\n", - "cols = [i.partition(\"Percent_\")[-1] for i in cols if \"Percent_\" in i]\n", - "percents.columns = [tax_level] + cols\n", - "percents = percents.T\n", - "percents.columns = percents.loc[tax_level]\n", - "percents.drop([tax_level], inplace=True)\n", - "\n", - "data = [go.Bar(x=percents.index, y=percents[tax], name=tax) for tax in percents.columns.tolist()]\n", - "\n", - "layout = go.Layout(\n", - " barmode='stack',\n", - " title='Assignments per Sample (Level: Order)',\n", - " margin={'b':200},\n", - " xaxis={\"tickangle\":-60},\n", - " yaxis={\"title\":\"Percent\"},\n", - " hovermode=\"closest\",\n", - " showlegend=False\n", - ")\n", - "\n", - "fig = go.Figure(data=data, layout=layout)\n", - "iplot(fig)" - ] - }, - { - "cell_type": "code", - "execution_count": 53, - "metadata": {}, - "outputs": [ - { - "data": { - "application/vnd.plotly.v1+json": { - "data": [ - { - "name": "Lactobacillales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 250226, - 217735, - 2224612, - 1832091, - 2519273, - 49303, - 715484, - 2591916, - 1895974, - 3102849, - 657799, - 334054, - 113605, - 1329887, - 2325875, - 4043322, - 4570964, - 4206692, - 3868100, - 1789462, - 3011590, - 3134917, - 762032, - 4495954, - 2549444, - 1011496, - 3891197, - 5419043, - 4199608, - 3737631, - 1484097, - 1676231, - 642967, - 6863032, - 2902051, - 1434848, - 1923510, - 2740638, - 4947499, - 1651551 - ] - }, - { - "name": "Enterobacterales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 109425, - 114408, - 57848, - 34727, - 93402, - 155885, - 668164, - 43394, - 30591, - 371550, - 169965, - 7082, - 229756, - 152023, - 38968, - 71073, - 93311, - 87062, - 31942, - 33976, - 26737, - 33455, - 109043, - 1745152, - 256762, - 356721, - 110778, - 59663, - 283072, - 53321, - 32820, - 2567430, - 1092443, - 39799, - 268536, - 2775047, - 2437271, - 2625969, - 4200385, - 4308198 - ] - }, - { - "name": "Bacillales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 77537, - 77306, - 57872, - 35012, - 69625, - 102992, - 440365, - 36849, - 30381, - 229549, - 121874, - 34361, - 153207, - 97177, - 192953, - 62638, - 69271, - 50038, - 59593, - 2374981, - 26145, - 20977, - 66209, - 67311, - 126882, - 208366, - 190564, - 446855, - 341260, - 138446, - 167688, - 1767571, - 786078, - 56009, - 171677, - 1748051, - 1304662, - 1516751, - 2452150, - 2610838 - ] - }, - { - "name": "Burkholderiales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 53762, - 55117, - 295449, - 202804, - 212801, - 17129, - 75346, - 235039, - 143249, - 176352, - 84070, - 29933, - 15660, - 83178, - 273717, - 382681, - 667219, - 388670, - 310443, - 182394, - 129915, - 280628, - 26568, - 358917, - 294080, - 100779, - 268046, - 743767, - 305379, - 348703, - 3314900, - 167149, - 32391, - 576364, - 84680, - 40233, - 28557, - 116868, - 72545, - 30124 - ] - }, - { - "name": "Pseudomonadales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 11802, - 18070, - 175055, - 46868, - 362102, - 5994, - 91257, - 258064, - 52835, - 57847, - 30243, - 5485, - 160471, - 854342, - 61736, - 109573, - 123692, - 67849, - 91882, - 29903, - 181954, - 50522, - 5724, - 120386, - 44165, - 30128, - 107426, - 84568, - 47691, - 48905, - 41074, - 20467, - 9016, - 106632, - 1305280, - 10626, - 841585, - 16088, - 19285, - 8785 - ] - }, - { - "name": "Clostridiales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 19513, - 20347, - 77877, - 64615, - 172599, - 9196, - 84360, - 182384, - 60896, - 118026, - 40754, - 19448, - 13942, - 30601, - 92393, - 167876, - 185236, - 106624, - 136655, - 36776, - 27807, - 141365, - 10283, - 120610, - 132743, - 63664, - 170482, - 185837, - 102588, - 49958, - 41442, - 439606, - 213151, - 122865, - 59302, - 339227, - 216830, - 489322, - 1824502, - 291870 - ] - }, - { - "name": "Rhizobiales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 176052, - 62515, - 183349, - 839319, - 168139, - 17359, - 61371, - 140756, - 76279, - 149905, - 97041, - 16529, - 23567, - 395758, - 108846, - 173086, - 127541, - 114657, - 118915, - 114015, - 94940, - 106175, - 21297, - 169125, - 82065, - 89944, - 91487, - 170531, - 96797, - 93651, - 78346, - 61964, - 18565, - 91605, - 445092, - 23138, - 21483, - 23582, - 12998, - 10973 - ] - }, - { - "name": "Neisseriales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 3023, - 3443, - 19555, - 10830, - 19610, - 250279, - 4685, - 26262, - 14531, - 13147, - 5663, - 1644, - 870, - 5527, - 9725, - 29930, - 28402, - 11735, - 16651, - 8876, - 6122, - 21024, - 1395, - 17276, - 12261, - 3665132, - 20220, - 15767, - 18596, - 8955, - 8033, - 8867, - 2384, - 24662, - 4516, - 2163, - 1083, - 8025, - 2203, - 726 - ] - }, - { - "name": "Corynebacteriales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 22093, - 168279, - 165806, - 86630, - 121938, - 9764, - 42837, - 112453, - 129583, - 93802, - 368746, - 85004, - 12620, - 48818, - 109075, - 455725, - 267962, - 80518, - 80017, - 79743, - 57067, - 94063, - 11650, - 98945, - 131452, - 66845, - 192975, - 145275, - 82679, - 87663, - 53807, - 61246, - 24728, - 219693, - 41619, - 38023, - 35767, - 70311, - 201554, - 43360 - ] - }, - { - "name": "Sporadotrichida", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 4021, - 5652, - 17394, - 18194, - 16395, - 1500, - 4229, - 124944, - 60003, - 13296, - 12490, - 70652, - 1111, - 7718, - 382938, - 141731, - 69252, - 319958, - 98855, - 95869, - 8398, - 90925, - 1534, - 201373, - 623021, - 22247, - 414044, - 526043, - 398780, - 321513, - 473757, - 34231, - 4075, - 120663, - 2901, - 1575, - 1524, - 69224, - 2760, - 1254 - ] - }, - { - "name": "Eurotiales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 15592, - 35468, - 140736, - 114574, - 129315, - 10088, - 39077, - 106123, - 61455, - 95505, - 70437, - 13661, - 10106, - 54661, - 106742, - 153427, - 205737, - 123391, - 121435, - 85407, - 53314, - 90862, - 8378, - 147519, - 113083, - 86996, - 189758, - 81681, - 94560, - 104227, - 101805, - 38726, - 15400, - 103982, - 22998, - 4617, - 1011, - 11379, - 2756, - 1648 - ] - }, - { - "name": "Xanthomonadales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 10895, - 13243, - 33364, - 32168, - 36010, - 6304, - 19070, - 31350, - 20459, - 33541, - 18548, - 2668, - 5572, - 20149, - 24466, - 34687, - 32912, - 24234, - 27260, - 21328, - 19229, - 27646, - 8611, - 31401, - 28848, - 19759, - 30454, - 42139, - 29240, - 2209357, - 24302, - 99966, - 10335, - 26298, - 11003, - 21530, - 9354, - 13233, - 40912, - 30110 - ] - }, - { - "name": "Coriobacteriales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 679, - 418638, - 38796, - 2818, - 3863, - 253, - 1098, - 4209, - 3260, - 4014, - 1225039, - 230, - 286, - 1616, - 1549, - 10945, - 47289, - 1930, - 2796, - 1778, - 3722, - 5874, - 1133, - 4025, - 1771, - 2067, - 3630, - 4775, - 25308, - 2627, - 1335, - 2519, - 753, - 4495, - 1334, - 1009, - 909, - 865, - 3420, - 533 - ] - }, - { - "name": "Streptomycetales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 24134, - 106650, - 110161, - 70744, - 80626, - 10489, - 30308, - 48219, - 43849, - 70477, - 224568, - 4578, - 9245, - 46807, - 56893, - 68159, - 117252, - 50057, - 51672, - 47009, - 38207, - 31841, - 12723, - 53985, - 56584, - 47800, - 60159, - 53758, - 37221, - 47066, - 59819, - 32117, - 8548, - 34274, - 12089, - 9966, - 2957, - 13716, - 5900, - 3943 - ] - }, - { - "name": "Peronosporales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 7433, - 17163, - 86646, - 58303, - 82052, - 4207, - 32033, - 50348, - 29826, - 40564, - 40529, - 13345, - 5281, - 30858, - 167754, - 71997, - 93472, - 72388, - 49066, - 42092, - 31872, - 31166, - 3113, - 66098, - 166774, - 39284, - 236883, - 116431, - 79585, - 107936, - 153506, - 25111, - 7600, - 84472, - 9952, - 2491, - 1002, - 17735, - 1769, - 1264 - ] - }, - { - "name": "Micrococcales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 11749, - 19075, - 61536, - 43584, - 53997, - 4808, - 18259, - 29656, - 24647, - 46120, - 25521, - 5339, - 5199, - 28154, - 46163, - 45508, - 47139, - 188332, - 35585, - 25434, - 24060, - 23778, - 5469, - 35860, - 66419, - 26456, - 43069, - 67148, - 44754, - 52308, - 64976, - 20350, - 5639, - 21836, - 10171, - 6032, - 1386, - 14812, - 3057, - 1534 - ] - }, - { - "name": "Haemosporida", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 7222, - 14263, - 48053, - 25685, - 28283, - 2999, - 10757, - 25245, - 42260, - 26448, - 19164, - 7718, - 3544, - 16075, - 64887, - 86470, - 48585, - 33031, - 42014, - 21286, - 14683, - 17219, - 2742, - 53851, - 59633, - 24739, - 64027, - 65540, - 60572, - 61412, - 50706, - 19286, - 5896, - 34852, - 3546, - 1592, - 353, - 4335, - 658, - 679 - ] - }, - { - "name": "Eucoccidiorida", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 1067, - 2403, - 107124, - 3758, - 3752, - 409, - 1378, - 2565, - 8763, - 3532, - 4061, - 655, - 90925, - 2258, - 7023, - 16825, - 18069, - 3120, - 3540, - 4849, - 2051, - 1886, - 498, - 4444, - 3450, - 2445, - 15888, - 2473, - 3480, - 2055, - 5137, - 1731, - 489, - 11163, - 722, - 382, - 274068, - 746, - 658, - 120 - ] - }, - { - "name": "Acidobacteriales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 12137, - 17888, - 52267, - 45053, - 44897, - 6005, - 17402, - 42779, - 17865, - 43954, - 27499, - 1956, - 4811, - 23317, - 40696, - 51997, - 69164, - 38102, - 35401, - 41497, - 26991, - 22072, - 4960, - 65426, - 10446, - 29576, - 11143, - 51228, - 14996, - 29069, - 10823, - 28588, - 5625, - 27215, - 11115, - 4565, - 1411, - 1571, - 1759, - 846 - ] - }, - { - "name": "Saccharomycetales", - "type": "bar", - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 2322, - 112136, - 13396, - 10518, - 10825, - 1227, - 4242, - 9297, - 14660, - 10133, - 331178, - 2112, - 1053, - 7400, - 15893, - 30582, - 24002, - 22435, - 14704, - 8004, - 5029, - 5510, - 974, - 31063, - 13135, - 7661, - 56840, - 10724, - 31896, - 12071, - 11772, - 7335, - 1164, - 14195, - 1567, - 937, - 304, - 2280, - 1213, - 328 - ] - } - ], - "layout": { - "barmode": "stack", - "margin": { - "b": 200 - }, - "title": "Assignments per Sample (Top 20; Order)", - "xaxis": { - "tickangle": -60 - }, - "yaxis": { - "title": "Count" - } - } - }, - "text/html": [ - "
" - ], - "text/vnd.plotly.v1+html": [ - "
" - ] - }, - "metadata": {}, - "output_type": "display_data" - } - ], - "source": [ - "# t = sub.copy()\n", - "# t.set_index(\"Order\", inplace=True)\n", - "# cols = t.columns.tolist()\n", - "# cols = [i.strip(\"Percent_\") for i in cols]\n", - "# t.columns = cols\n", - "# fig = t.iplot(title=\"Top 100 Assignments by Percent\", xTitle=\"Taxonomy\", yTitle=\"Percent\", asFigure=True)\n", - "# fig.layout.margin.update({'b':200})\n", - "# fig.layout.xaxis.update({\"tickangle\":-60, \"title\":\"Taxonomy\"})\n", - "# print(fig)\n", - "# t.iplot?\n", - "# iplot(fig)\n", - "\n", - "data = [go.Bar(x=counts.index, y=counts[tax], name=tax) for tax in counts.columns.tolist()]\n", - "\n", - "layout = go.Layout(\n", - " barmode='stack',\n", - " title='Assignments per Sample (Top 20; Order)',\n", - " margin={'b':200},\n", - " xaxis={\"tickangle\":-60},\n", - " yaxis={\"title\":\"Count\"}\n", - ")\n", - "# print(data)\n", - "fig = go.Figure(data=data, layout=layout)\n", - "iplot(fig)" - ] - }, - { - "cell_type": "code", - "execution_count": 55, - "metadata": {}, - "outputs": [ - { - "data": { - "application/vnd.plotly.v1+json": { - "data": [ - { - "name": "Lactobacillales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 9.91815, - 4.875787, - 18.299616, - 18.626768, - 20.860512, - 3.534468, - 14.036060999999998, - 24.270857, - 25.254229000000002, - 27.789181, - 7.509417999999999, - 20.31987, - 6.8348059999999995, - 19.57515, - 25.229219, - 24.376435999999998, - 25.894707, - 25.703689999999998, - 32.56089, - 18.51, - 41.992729, - 31.941605, - 39.949127000000004, - 26.536640000000002, - 24.681038, - 9.668959, - 27.828783, - 34.228664, - 30.640402, - 28.820351000000002, - 13.409765, - 13.893896, - 14.753264000000001, - 42.385296000000004, - 37.529037, - 16.328442000000003, - 19.81365, - 25.80336, - 25.487453, - 14.342144000000001 - ] - }, - { - "name": "Enterobacterales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 4.337254, - 2.561963, - 0.475857, - 0.353068, - 0.773403, - 11.175193, - 13.107757999999999, - 0.406344, - 0.40747, - 3.32761, - 1.940316, - 0.43078500000000003, - 13.822785999999999, - 2.237689, - 0.42269300000000004, - 0.428486, - 0.5286109999999999, - 0.5319649999999999, - 0.268881, - 0.351444, - 0.372813, - 0.34087199999999995, - 5.716522, - 10.300478, - 2.4857, - 3.4099199999999996, - 0.792254, - 0.376853, - 2.065298, - 0.41115100000000004, - 0.29655, - 21.280839999999998, - 25.066761, - 0.245794, - 3.4726809999999997, - 31.579786, - 25.105785, - 24.72374, - 21.638634, - 37.41259 - ] - }, - { - "name": "Bacillales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 3.073316, - 1.7311299999999998, - 0.476054, - 0.35596500000000003, - 0.576521, - 7.383361999999999, - 8.638893, - 0.345056, - 0.404673, - 2.055846, - 1.391311, - 2.090114, - 9.217377, - 1.430388, - 2.0929990000000003, - 0.377633, - 0.392423, - 0.305742, - 0.501642, - 24.566545, - 0.364558, - 0.213734, - 3.470972, - 0.39729200000000003, - 1.228338, - 1.991785, - 1.362862, - 2.8225, - 2.489838, - 1.0675379999999999, - 1.515168, - 14.650991000000001, - 18.037031, - 0.345905, - 2.22011, - 19.892664, - 13.439032999999998, - 14.280351000000001, - 12.632455, - 22.672635999999997 - ] - }, - { - "name": "Burkholderiales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 2.130952, - 1.2342469999999999, - 2.430358, - 2.061897, - 1.762071, - 1.227956, - 1.478106, - 2.200919, - 1.908066, - 1.579412, - 0.959741, - 1.820768, - 0.9421510000000001, - 1.224331, - 2.969061, - 2.307113, - 3.7798239999999996, - 2.374848, - 2.6132470000000003, - 1.886664, - 1.8114970000000001, - 2.859313, - 1.3928129999999999, - 2.118449, - 2.8469729999999998, - 0.963353, - 1.9169919999999998, - 4.697906, - 2.22805, - 2.6888, - 29.952244, - 1.3854600000000001, - 0.7432310000000001, - 3.559558, - 1.095073, - 0.457848, - 0.294159, - 1.100323, - 0.373722, - 0.261598 - ] - }, - { - "name": "Pseudomonadales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.467793, - 0.404645, - 1.439999, - 0.476504, - 2.998338, - 0.42970200000000003, - 1.790241, - 2.416527, - 0.703758, - 0.518079, - 0.34525300000000003, - 0.333642, - 9.654401, - 12.575409, - 0.669662, - 0.6605949999999999, - 0.700721, - 0.41457, - 0.7734439999999999, - 0.309313, - 2.537113, - 0.514768, - 0.300078, - 0.710559, - 0.427559, - 0.28799600000000003, - 0.768282, - 0.534163, - 0.347954, - 0.3771, - 0.37113, - 0.169646, - 0.206878, - 0.658547, - 16.879753, - 0.120923, - 8.66898, - 0.15147, - 0.099348, - 0.076289 - ] - }, - { - "name": "Clostridiales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.773432, - 0.455635, - 0.6406149999999999, - 0.656937, - 1.429184, - 0.659249, - 1.654939, - 1.707855, - 0.81113, - 1.057043, - 0.465247, - 1.182985, - 0.838791, - 0.450429, - 1.002205, - 1.0120930000000001, - 1.0493700000000001, - 0.651493, - 1.150334, - 0.380407, - 0.387733, - 1.440365, - 0.539081, - 0.711881, - 1.2850780000000002, - 0.608568, - 1.219241, - 1.173815, - 0.748484, - 0.385219, - 0.37445500000000004, - 3.643794, - 4.890878, - 0.7588, - 0.766888, - 3.8603730000000005, - 2.233518, - 4.607012, - 9.399075, - 2.534612 - ] - }, - { - "name": "Rhizobiales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 6.978133000000001, - 1.399912, - 1.508225, - 8.53331, - 1.392253, - 1.244444, - 1.20395, - 1.3180479999999999, - 1.01603, - 1.342552, - 1.107818, - 1.005428, - 1.417859, - 5.825324, - 1.180674, - 1.043503, - 0.722525, - 0.700576, - 1.001003, - 1.179359, - 1.3238159999999999, - 1.081815, - 1.116484, - 0.998233, - 0.794467, - 0.8597809999999999, - 0.6542899999999999, - 1.077136, - 0.706232, - 0.72213, - 0.707906, - 0.513605, - 0.42598500000000006, - 0.565742, - 5.755886, - 0.263308, - 0.22129200000000002, - 0.222027, - 0.06696, - 0.09529 - ] - }, - { - "name": "Neisseriales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.119822, - 0.0771, - 0.160859, - 0.110108, - 0.162378, - 17.942175, - 0.091908, - 0.245919, - 0.193552, - 0.117745, - 0.064649, - 0.10000099999999999, - 0.05234199999999999, - 0.081354, - 0.10548900000000001, - 0.18044200000000002, - 0.16089900000000001, - 0.071703, - 0.140165, - 0.091812, - 0.085363, - 0.21421300000000001, - 0.073132, - 0.101969, - 0.118698, - 35.035247999999996, - 0.144608, - 0.09959, - 0.135677, - 0.069051, - 0.07258300000000001, - 0.073497, - 0.054702, - 0.15231, - 0.0584, - 0.024615, - 0.011156000000000001, - 0.075556, - 0.011349, - 0.006305 - ] - }, - { - "name": "Corynebacteriales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.8756950000000001, - 3.768308, - 1.363917, - 0.880762, - 1.009692, - 0.699968, - 0.8403579999999999, - 1.053017, - 1.7260360000000001, - 0.840093, - 4.209596, - 5.170632, - 0.759256, - 0.718572, - 1.183158, - 2.747481, - 1.518016, - 0.49198000000000003, - 0.673567, - 0.8248530000000001, - 0.795726, - 0.958406, - 0.610745, - 0.5840069999999999, - 1.2725799999999998, - 0.638976, - 1.380105, - 0.91761, - 0.6032270000000001, - 0.6759569999999999, - 0.48618100000000003, - 0.507654, - 0.567399, - 1.356799, - 0.538213, - 0.43269799999999997, - 0.36842800000000003, - 0.661985, - 1.038322, - 0.37654 - ] - }, - { - "name": "Sporadotrichida", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.159379, - 0.126566, - 0.143083, - 0.184977, - 0.135757, - 0.10753299999999999, - 0.082963, - 1.169983, - 0.799235, - 0.11907899999999999, - 0.142586, - 4.297626999999999, - 0.066841, - 0.113604, - 4.153802, - 0.8544700000000001, - 0.392316, - 1.9550040000000002, - 0.832142, - 0.9916590000000001, - 0.117099, - 0.926433, - 0.080419, - 1.188572, - 6.031435, - 0.21266100000000002, - 2.96113, - 3.3226809999999998, - 2.909505, - 2.479142, - 4.280697, - 0.283733, - 0.093503, - 0.745201, - 0.037515, - 0.017922999999999998, - 0.015698, - 0.65175, - 0.014218000000000001, - 0.01089 - ] - }, - { - "name": "Eurotiales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.618016, - 0.794243, - 1.157692, - 1.164868, - 1.070776, - 0.723196, - 0.766596, - 0.993742, - 0.818576, - 0.855345, - 0.804107, - 0.830973, - 0.608006, - 0.804578, - 1.157851, - 0.924983, - 1.165509, - 0.753943, - 1.0222149999999999, - 0.883441, - 0.743395, - 0.925791, - 0.439212, - 0.870707, - 1.094751, - 0.831601, - 1.357098, - 0.515927, - 0.6899109999999999, - 0.8036800000000001, - 0.9198729999999999, - 0.32099099999999997, - 0.353362, - 0.642181, - 0.297408, - 0.052541, - 0.010414, - 0.107134, - 0.014197999999999999, - 0.014311 - ] - }, - { - "name": "Xanthomonadales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.43184300000000003, - 0.296553, - 0.274452, - 0.32705, - 0.298176, - 0.451926, - 0.374107, - 0.293563, - 0.272512, - 0.300394, - 0.21174400000000002, - 0.16228900000000002, - 0.335228, - 0.296581, - 0.265387, - 0.209121, - 0.186448, - 0.148074, - 0.229469, - 0.220615, - 0.268124, - 0.28168499999999996, - 0.451427, - 0.185339, - 0.279276, - 0.188878, - 0.21779899999999996, - 0.266165, - 0.213335, - 17.036043, - 0.219584, - 0.8285950000000001, - 0.237143, - 0.162413, - 0.14229, - 0.245009, - 0.096353, - 0.12459, - 0.21076199999999998, - 0.261477 - ] - }, - { - "name": "Coriobacteriales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.026913, - 9.374651, - 0.319135, - 0.02865, - 0.031987, - 0.018137, - 0.02154, - 0.039413, - 0.043423, - 0.035949, - 13.985016, - 0.01399, - 0.017207, - 0.023787, - 0.016802, - 0.065985, - 0.267894, - 0.011793000000000001, - 0.023536, - 0.018391, - 0.051898, - 0.05985, - 0.059397000000000005, - 0.023757, - 0.017145, - 0.019759, - 0.025961, - 0.030161, - 0.184648, - 0.020256, - 0.012062999999999999, - 0.020878999999999998, - 0.017278, - 0.027761, - 0.017251, - 0.011482, - 0.009363, - 0.008144, - 0.017618, - 0.004629 - ] - }, - { - "name": "Streptomycetales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.956594, - 2.3882369999999997, - 0.9061819999999999, - 0.71925, - 0.667613, - 0.751943, - 0.594569, - 0.45152600000000004, - 0.584065, - 0.6311939999999999, - 2.563663, - 0.278471, - 0.5562060000000001, - 0.688971, - 0.617129, - 0.410918, - 0.664238, - 0.305858, - 0.434965, - 0.486256, - 0.532747, - 0.324427, - 0.6669970000000001, - 0.31863800000000003, - 0.547787, - 0.45692299999999997, - 0.430241, - 0.339555, - 0.271565, - 0.362919, - 0.540503, - 0.26621, - 0.196139, - 0.21167199999999997, - 0.156334, - 0.11341199999999999, - 0.030458999999999996, - 0.129137, - 0.030394, - 0.034241 - ] - }, - { - "name": "Peronosporales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.29462, - 0.384335, - 0.7127479999999999, - 0.592763, - 0.679421, - 0.30159400000000003, - 0.62841, - 0.471462, - 0.39728, - 0.363292, - 0.462678, - 0.811751, - 0.31772, - 0.454212, - 1.8196599999999998, - 0.43405699999999997, - 0.529523, - 0.442305, - 0.41302799999999995, - 0.435395, - 0.44441400000000003, - 0.31755, - 0.163197, - 0.390133, - 1.614531, - 0.37551799999999996, - 1.694123, - 0.735421, - 0.580653, - 0.8322790000000001, - 1.387025, - 0.208139, - 0.174387, - 0.5216890000000001, - 0.128698, - 0.028347000000000004, - 0.010320999999999999, - 0.166977, - 0.009113, - 0.010976999999999999 - ] - }, - { - "name": "Micrococcales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.465692, - 0.427151, - 0.5061939999999999, - 0.443116, - 0.447115, - 0.344679, - 0.358197, - 0.27770100000000003, - 0.328296, - 0.41305200000000003, - 0.29134699999999997, - 0.324761, - 0.312787, - 0.41441000000000006, - 0.500739, - 0.274359, - 0.267044, - 1.1507450000000001, - 0.299547, - 0.263087, - 0.335486, - 0.242274, - 0.286709, - 0.21165799999999999, - 0.642999, - 0.252895, - 0.30801799999999996, - 0.42413100000000004, - 0.32652600000000004, - 0.40334000000000003, - 0.5871, - 0.168676, - 0.12939, - 0.134857, - 0.13153, - 0.06864400000000001, - 0.014277000000000001, - 0.139456, - 0.015747999999999998, - 0.013321000000000001 - ] - }, - { - "name": "Haemosporida", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.28625700000000004, - 0.319394, - 0.395283, - 0.26113800000000004, - 0.234194, - 0.21499400000000002, - 0.21102600000000002, - 0.236396, - 0.5629, - 0.236869, - 0.21877600000000003, - 0.469471, - 0.21321700000000002, - 0.236614, - 0.703842, - 0.521312, - 0.27523600000000004, - 0.201826, - 0.353665, - 0.22018000000000001, - 0.204735, - 0.17544400000000002, - 0.14374800000000001, - 0.317847, - 0.577304, - 0.23648200000000003, - 0.457904, - 0.413975, - 0.441934, - 0.47353900000000004, - 0.458161, - 0.159857, - 0.135287, - 0.21524200000000002, - 0.045857, - 0.018116999999999998, - 0.003636, - 0.040813999999999996, - 0.00339, - 0.005896 - ] - }, - { - "name": "Eucoccidiorida", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.042292, - 0.053811000000000005, - 0.8812, - 0.038207, - 0.031068000000000002, - 0.029320999999999996, - 0.027032999999999998, - 0.024019, - 0.116722, - 0.031633, - 0.046360000000000005, - 0.039842, - 5.470311, - 0.033236, - 0.07618, - 0.101435, - 0.102362, - 0.019063999999999998, - 0.029799000000000003, - 0.050158, - 0.028599, - 0.019216, - 0.026106999999999998, - 0.02623, - 0.033399, - 0.023372, - 0.11362699999999999, - 0.015619999999999998, - 0.02539, - 0.015846000000000002, - 0.046416000000000006, - 0.014348, - 0.01122, - 0.068941, - 0.009337, - 0.004347, - 2.823113, - 0.007024, - 0.00339, - 0.001042 - ] - }, - { - "name": "Acidobacteriales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.481071, - 0.40057, - 0.429947, - 0.45805100000000004, - 0.371764, - 0.430491, - 0.341385, - 0.40058499999999997, - 0.23795999999999998, - 0.39365300000000003, - 0.31392800000000004, - 0.11897999999999999, - 0.289444, - 0.34321199999999996, - 0.44143699999999997, - 0.31348000000000004, - 0.391817, - 0.23281, - 0.29799899999999996, - 0.42923999999999995, - 0.376355, - 0.22489099999999998, - 0.260025, - 0.386166, - 0.101127, - 0.282719, - 0.079692, - 0.323575, - 0.109411, - 0.22414699999999999, - 0.09779299999999999, - 0.236959, - 0.12906900000000002, - 0.168077, - 0.143738, - 0.051949, - 0.014534, - 0.014791, - 0.009062, - 0.007347 - ] - }, - { - "name": "Saccharomycetales", - "type": "bar", - "visible": true, - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 0.092037, - 2.511086, - 0.110195, - 0.10693599999999999, - 0.089635, - 0.087962, - 0.083218, - 0.08705800000000001, - 0.19527, - 0.090751, - 3.7807199999999996, - 0.128469, - 0.06335199999999999, - 0.108924, - 0.172394, - 0.184373, - 0.135972, - 0.13708199999999998, - 0.123775, - 0.08279299999999999, - 0.070123, - 0.056140999999999996, - 0.051061, - 0.183344, - 0.127159, - 0.073232, - 0.406504, - 0.067737, - 0.23271399999999998, - 0.093078, - 0.106368, - 0.060798000000000005, - 0.026708999999999997, - 0.087667, - 0.020263999999999997, - 0.010662999999999999, - 0.0031309999999999997, - 0.021466, - 0.006249, - 0.002848 - ] - }, - { - "name": "Lactobacillales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 250226, - 217735, - 2224612, - 1832091, - 2519273, - 49303, - 715484, - 2591916, - 1895974, - 3102849, - 657799, - 334054, - 113605, - 1329887, - 2325875, - 4043322, - 4570964, - 4206692, - 3868100, - 1789462, - 3011590, - 3134917, - 762032, - 4495954, - 2549444, - 1011496, - 3891197, - 5419043, - 4199608, - 3737631, - 1484097, - 1676231, - 642967, - 6863032, - 2902051, - 1434848, - 1923510, - 2740638, - 4947499, - 1651551 - ] - }, - { - "name": "Enterobacterales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 109425, - 114408, - 57848, - 34727, - 93402, - 155885, - 668164, - 43394, - 30591, - 371550, - 169965, - 7082, - 229756, - 152023, - 38968, - 71073, - 93311, - 87062, - 31942, - 33976, - 26737, - 33455, - 109043, - 1745152, - 256762, - 356721, - 110778, - 59663, - 283072, - 53321, - 32820, - 2567430, - 1092443, - 39799, - 268536, - 2775047, - 2437271, - 2625969, - 4200385, - 4308198 - ] - }, - { - "name": "Bacillales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 77537, - 77306, - 57872, - 35012, - 69625, - 102992, - 440365, - 36849, - 30381, - 229549, - 121874, - 34361, - 153207, - 97177, - 192953, - 62638, - 69271, - 50038, - 59593, - 2374981, - 26145, - 20977, - 66209, - 67311, - 126882, - 208366, - 190564, - 446855, - 341260, - 138446, - 167688, - 1767571, - 786078, - 56009, - 171677, - 1748051, - 1304662, - 1516751, - 2452150, - 2610838 - ] - }, - { - "name": "Burkholderiales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 53762, - 55117, - 295449, - 202804, - 212801, - 17129, - 75346, - 235039, - 143249, - 176352, - 84070, - 29933, - 15660, - 83178, - 273717, - 382681, - 667219, - 388670, - 310443, - 182394, - 129915, - 280628, - 26568, - 358917, - 294080, - 100779, - 268046, - 743767, - 305379, - 348703, - 3314900, - 167149, - 32391, - 576364, - 84680, - 40233, - 28557, - 116868, - 72545, - 30124 - ] - }, - { - "name": "Pseudomonadales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 11802, - 18070, - 175055, - 46868, - 362102, - 5994, - 91257, - 258064, - 52835, - 57847, - 30243, - 5485, - 160471, - 854342, - 61736, - 109573, - 123692, - 67849, - 91882, - 29903, - 181954, - 50522, - 5724, - 120386, - 44165, - 30128, - 107426, - 84568, - 47691, - 48905, - 41074, - 20467, - 9016, - 106632, - 1305280, - 10626, - 841585, - 16088, - 19285, - 8785 - ] - }, - { - "name": "Clostridiales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 19513, - 20347, - 77877, - 64615, - 172599, - 9196, - 84360, - 182384, - 60896, - 118026, - 40754, - 19448, - 13942, - 30601, - 92393, - 167876, - 185236, - 106624, - 136655, - 36776, - 27807, - 141365, - 10283, - 120610, - 132743, - 63664, - 170482, - 185837, - 102588, - 49958, - 41442, - 439606, - 213151, - 122865, - 59302, - 339227, - 216830, - 489322, - 1824502, - 291870 - ] - }, - { - "name": "Rhizobiales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 176052, - 62515, - 183349, - 839319, - 168139, - 17359, - 61371, - 140756, - 76279, - 149905, - 97041, - 16529, - 23567, - 395758, - 108846, - 173086, - 127541, - 114657, - 118915, - 114015, - 94940, - 106175, - 21297, - 169125, - 82065, - 89944, - 91487, - 170531, - 96797, - 93651, - 78346, - 61964, - 18565, - 91605, - 445092, - 23138, - 21483, - 23582, - 12998, - 10973 - ] - }, - { - "name": "Neisseriales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 3023, - 3443, - 19555, - 10830, - 19610, - 250279, - 4685, - 26262, - 14531, - 13147, - 5663, - 1644, - 870, - 5527, - 9725, - 29930, - 28402, - 11735, - 16651, - 8876, - 6122, - 21024, - 1395, - 17276, - 12261, - 3665132, - 20220, - 15767, - 18596, - 8955, - 8033, - 8867, - 2384, - 24662, - 4516, - 2163, - 1083, - 8025, - 2203, - 726 - ] - }, - { - "name": "Corynebacteriales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 22093, - 168279, - 165806, - 86630, - 121938, - 9764, - 42837, - 112453, - 129583, - 93802, - 368746, - 85004, - 12620, - 48818, - 109075, - 455725, - 267962, - 80518, - 80017, - 79743, - 57067, - 94063, - 11650, - 98945, - 131452, - 66845, - 192975, - 145275, - 82679, - 87663, - 53807, - 61246, - 24728, - 219693, - 41619, - 38023, - 35767, - 70311, - 201554, - 43360 - ] - }, - { - "name": "Sporadotrichida", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 4021, - 5652, - 17394, - 18194, - 16395, - 1500, - 4229, - 124944, - 60003, - 13296, - 12490, - 70652, - 1111, - 7718, - 382938, - 141731, - 69252, - 319958, - 98855, - 95869, - 8398, - 90925, - 1534, - 201373, - 623021, - 22247, - 414044, - 526043, - 398780, - 321513, - 473757, - 34231, - 4075, - 120663, - 2901, - 1575, - 1524, - 69224, - 2760, - 1254 - ] - }, - { - "name": "Eurotiales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 15592, - 35468, - 140736, - 114574, - 129315, - 10088, - 39077, - 106123, - 61455, - 95505, - 70437, - 13661, - 10106, - 54661, - 106742, - 153427, - 205737, - 123391, - 121435, - 85407, - 53314, - 90862, - 8378, - 147519, - 113083, - 86996, - 189758, - 81681, - 94560, - 104227, - 101805, - 38726, - 15400, - 103982, - 22998, - 4617, - 1011, - 11379, - 2756, - 1648 - ] - }, - { - "name": "Xanthomonadales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 10895, - 13243, - 33364, - 32168, - 36010, - 6304, - 19070, - 31350, - 20459, - 33541, - 18548, - 2668, - 5572, - 20149, - 24466, - 34687, - 32912, - 24234, - 27260, - 21328, - 19229, - 27646, - 8611, - 31401, - 28848, - 19759, - 30454, - 42139, - 29240, - 2209357, - 24302, - 99966, - 10335, - 26298, - 11003, - 21530, - 9354, - 13233, - 40912, - 30110 - ] - }, - { - "name": "Coriobacteriales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 679, - 418638, - 38796, - 2818, - 3863, - 253, - 1098, - 4209, - 3260, - 4014, - 1225039, - 230, - 286, - 1616, - 1549, - 10945, - 47289, - 1930, - 2796, - 1778, - 3722, - 5874, - 1133, - 4025, - 1771, - 2067, - 3630, - 4775, - 25308, - 2627, - 1335, - 2519, - 753, - 4495, - 1334, - 1009, - 909, - 865, - 3420, - 533 - ] - }, - { - "name": "Streptomycetales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 24134, - 106650, - 110161, - 70744, - 80626, - 10489, - 30308, - 48219, - 43849, - 70477, - 224568, - 4578, - 9245, - 46807, - 56893, - 68159, - 117252, - 50057, - 51672, - 47009, - 38207, - 31841, - 12723, - 53985, - 56584, - 47800, - 60159, - 53758, - 37221, - 47066, - 59819, - 32117, - 8548, - 34274, - 12089, - 9966, - 2957, - 13716, - 5900, - 3943 - ] - }, - { - "name": "Peronosporales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 7433, - 17163, - 86646, - 58303, - 82052, - 4207, - 32033, - 50348, - 29826, - 40564, - 40529, - 13345, - 5281, - 30858, - 167754, - 71997, - 93472, - 72388, - 49066, - 42092, - 31872, - 31166, - 3113, - 66098, - 166774, - 39284, - 236883, - 116431, - 79585, - 107936, - 153506, - 25111, - 7600, - 84472, - 9952, - 2491, - 1002, - 17735, - 1769, - 1264 - ] - }, - { - "name": "Micrococcales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 11749, - 19075, - 61536, - 43584, - 53997, - 4808, - 18259, - 29656, - 24647, - 46120, - 25521, - 5339, - 5199, - 28154, - 46163, - 45508, - 47139, - 188332, - 35585, - 25434, - 24060, - 23778, - 5469, - 35860, - 66419, - 26456, - 43069, - 67148, - 44754, - 52308, - 64976, - 20350, - 5639, - 21836, - 10171, - 6032, - 1386, - 14812, - 3057, - 1534 - ] - }, - { - "name": "Haemosporida", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 7222, - 14263, - 48053, - 25685, - 28283, - 2999, - 10757, - 25245, - 42260, - 26448, - 19164, - 7718, - 3544, - 16075, - 64887, - 86470, - 48585, - 33031, - 42014, - 21286, - 14683, - 17219, - 2742, - 53851, - 59633, - 24739, - 64027, - 65540, - 60572, - 61412, - 50706, - 19286, - 5896, - 34852, - 3546, - 1592, - 353, - 4335, - 658, - 679 - ] - }, - { - "name": "Eucoccidiorida", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 1067, - 2403, - 107124, - 3758, - 3752, - 409, - 1378, - 2565, - 8763, - 3532, - 4061, - 655, - 90925, - 2258, - 7023, - 16825, - 18069, - 3120, - 3540, - 4849, - 2051, - 1886, - 498, - 4444, - 3450, - 2445, - 15888, - 2473, - 3480, - 2055, - 5137, - 1731, - 489, - 11163, - 722, - 382, - 274068, - 746, - 658, - 120 - ] - }, - { - "name": "Acidobacteriales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 12137, - 17888, - 52267, - 45053, - 44897, - 6005, - 17402, - 42779, - 17865, - 43954, - 27499, - 1956, - 4811, - 23317, - 40696, - 51997, - 69164, - 38102, - 35401, - 41497, - 26991, - 22072, - 4960, - 65426, - 10446, - 29576, - 11143, - 51228, - 14996, - 29069, - 10823, - 28588, - 5625, - 27215, - 11115, - 4565, - 1411, - 1571, - 1759, - 846 - ] - }, - { - "name": "Saccharomycetales", - "type": "bar", - "visible": false, - "x": [ - "Reads_WL8_S29_001", - "Reads_WL39_S28_001", - "Reads_WL84_S36_001", - "Reads_WL187_S5_001", - "Reads_WL121_S37_001", - "Reads_WL142_S30_001", - "Reads_WL57_S40_001", - "Reads_WL106_S10_001", - "Reads_WL134_S34_001", - "Reads_WL70_S39_001", - "Reads_WL147_S4_001", - "Reads_WL162_S15_001", - "Reads_WL182_S25_001", - "Reads_WL183_S26_001", - "Reads_WL1161and2_S12_001", - "Reads_WL1141_S35_001", - "Reads_WL33_S32_001", - "Reads_WL172_S22_001", - "Reads_WL55_S20_001", - "Reads_WL113_S9_001", - "Reads_WL64_S7_001", - "Reads_WL1382_S8_001", - "Reads_WL180_S31_001", - "Reads_WL68_S23_001", - "Reads_WL79_S13_001", - "Reads_WL3_S6_001", - "Reads_WL891_S18_001", - "Reads_WL1331and2_S21_001", - "Reads_WL115_S17_001", - "Reads_WL381and2_S11_001", - "Reads_WL110_S14_001", - "Reads_WL148_S24_001", - "Reads_WL40_S3_001", - "Reads_WL124_S19_001", - "Reads_WL2_S2_001", - "Reads_WL112_S38_001", - "Reads_WL51_S1_001", - "Reads_WL130_S16_001", - "Reads_WL93_S33_001", - "Reads_WL69_S27_001" - ], - "y": [ - 2322, - 112136, - 13396, - 10518, - 10825, - 1227, - 4242, - 9297, - 14660, - 10133, - 331178, - 2112, - 1053, - 7400, - 15893, - 30582, - 24002, - 22435, - 14704, - 8004, - 5029, - 5510, - 974, - 31063, - 13135, - 7661, - 56840, - 10724, - 31896, - 12071, - 11772, - 7335, - 1164, - 14195, - 1567, - 937, - 304, - 2280, - 1213, - 328 - ] - } - ], - "layout": { - "barmode": "stack", - "margin": { - "b": 200 - }, - "title": "Assignments per Sample (Top 20; Order)", - "updatemenus": [ - { - "active": 0, - "buttons": [ - { - "args": [ - { - "visible": [ - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false - ] - }, - { - "yaxis": { - "title": "Percent" - } - } - ], - "label": "Percent", - "method": "update" - }, - { - "args": [ - { - "visible": [ - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - false, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true, - true - ] - }, - { - "yaxis": { - "title": "Count" - } - } - ], - "label": "Count", - "method": "update" - } - ], - "direction": "left", - "pad": { - "r": 0, - "t": 0 - }, - "showactive": true, - "type": "buttons", - "x": 0, - "xanchor": "left", - "y": 1.2, - "yanchor": "top" - } - ], - "xaxis": { - "tickangle": -60 - }, - "yaxis": { - "title": "Percent" - } - } - }, - "text/html": [ - "
" - ], - "text/vnd.plotly.v1+html": [ - "
" - ] - }, - "metadata": {}, - "output_type": "display_data" - } - ], - "source": [ - "# data traces are taxonomies across samples\n", - "data = [go.Bar(x=percents.index, y=percents[tax], name=tax, visible=True) for tax in percents.columns.tolist()] + \\\n", - " [go.Bar(x=counts.index, y=counts[tax], name=tax, visible=False) for tax in counts.columns.tolist()]\n", - "\n", - "# the number of taxa\n", - "trace_length = len(percents.columns)\n", - "\n", - "# plot buttons\n", - "updatemenus = list([\n", - " dict(type=\"buttons\",\n", - " active=0,\n", - " buttons=list([ \n", - " dict(label = 'Percent',\n", - " method = 'update',\n", - " args = [{'visible': [True]*trace_length + [False]*trace_length},\n", - " {'yaxis': {\"title\": \"Percent\"}}\n", - " ]),\n", - " dict(label = 'Count',\n", - " method = 'update',\n", - " args = [{'visible': [False]*trace_length + [True]*trace_length},\n", - " {'yaxis': {\"title\": \"Count\"}}\n", - " ])\n", - " ]),\n", - " direction = 'left',\n", - " pad = {'r': 0, 't': 0},\n", - " showactive = True,\n", - " x = 0,\n", - " xanchor = 'left',\n", - " y = 1.2,\n", - " yanchor = 'top' \n", - " )\n", - "])\n", - "\n", - "# initial layout\n", - "layout = dict(title=\"Assignments per Sample (Top 20; Order)\",\n", - " updatemenus=updatemenus,\n", - " barmode=\"stack\",\n", - " margin={\"b\": 200},\n", - " xaxis={\"tickangle\": -60},\n", - " yaxis={\"title\": \"Percent\"}\n", - " )\n", - "\n", - "fig = go.Figure(data=data, layout=layout)\n", - "iplot(fig)" - ] - }, - { - "cell_type": "code", - "execution_count": 56, - "metadata": {}, - "outputs": [], - "source": [ - "jf = pd.read_table(\"/Users/brow015/devel/qc/classifications/logs/bailey_qc/jellyfish/WL106_S10_001_count_summary.txt\",\n", - " header=None, \n", - " names=[\"metric\", \"SAMPLE\"],\n", - " delim_whitespace=True\n", - ")" - ] - }, - { - "cell_type": "code", - "execution_count": 57, - "metadata": {}, - "outputs": [ - { - "data": { - "text/html": [ - "
\n", - "\n", - "\n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - "
metricUnique:Distinct:Total:Max_count:
SAMPLE1199872361151498849144904518736988064
\n", - "
" - ], - "text/plain": [ - "metric Unique: Distinct: Total: Max_count:\n", - "SAMPLE 1199872361 1514988491 4490451873 6988064" - ] - }, - "execution_count": 57, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "jf = jf.T\n", - "jf.columns = jf.loc[\"metric\"]\n", - "# t.loc[\"Order\"]\n", - "# t.set_index(\"Order\")\n", - "jf.drop([\"metric\"], inplace=True)\n", - "# t[t[\"Order\"] != \"Order\"]\n", - "# jf.set_index(\"metric\", inplace=True)\n", - "jf.head()" - ] - }, - { - "cell_type": "code", - "execution_count": 58, - "metadata": {}, - "outputs": [ - { - "data": { - "text/plain": [ - "Index(['SAMPLE'], dtype='object')" - ] - }, - "execution_count": 58, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "jf.index" - ] - }, - { - "cell_type": "code", - "execution_count": 59, - "metadata": {}, - "outputs": [], - "source": [ - "jf2 = pd.read_table(\"/Users/brow015/devel/qc/classifications/logs/bailey_qc/jellyfish/WL69_S27_001_count_summary.txt\",\n", - " header=None,\n", - " names=[\"metric\", \"SAMPLE2\"],\n", - " delim_whitespace=True\n", - " )" - ] - }, - { - "cell_type": "code", - "execution_count": 60, - "metadata": {}, - "outputs": [ - { - "data": { - "text/html": [ - "
\n", - "\n", - "\n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - "
metricUnique:Distinct:Total:Max_count:
SAMPLE1199872361151498849144904518736988064
SAMPLE262001001866435484247075059457258654
\n", - "
" - ], - "text/plain": [ - "metric Unique: Distinct: Total: Max_count:\n", - "SAMPLE 1199872361 1514988491 4490451873 6988064\n", - "SAMPLE2 620010018 664354842 4707505945 7258654" - ] - }, - "execution_count": 60, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "jf2 = jf2.T\n", - "jf2.columns = jf2.loc[\"metric\"]\n", - "jf2.drop([\"metric\"], inplace=True)\n", - "d = pd.concat([jf, jf2])\n", - "d.head()" - ] - }, - { - "cell_type": "code", - "execution_count": 61, - "metadata": {}, - "outputs": [], - "source": [ - "def df_by_concat(path):\n", - " \"\"\"\n", - " Reads in multiple TSVs in a given directory and concatenate them into\n", - " a single pandas.DataFrame.\n", - " \"\"\"\n", - " samples = []\n", - " dfs = []\n", - " for f in os.listdir(path):\n", - " f = os.path.join(path, f)\n", - " if not f.endswith(\"_count_summary.txt\"): continue\n", - " sample = os.path.basename(f).partition(\"_count_summary.txt\")[0]\n", - " samples.append(sample)\n", - " header = [\"metric\", sample]\n", - " df = pd.read_table(f, \n", - " header=None,\n", - " names=header, \n", - " delim_whitespace=True\n", - " )\n", - " df = df.T\n", - " df.columns = df.loc[\"metric\"]\n", - " df.drop([\"metric\"], inplace=True)\n", - " dfs.append(df)\n", - " merged = pd.concat(dfs)\n", - " merged.columns = [i.strip(\":\") for i in merged.columns]\n", - " return samples, merged" - ] - }, - { - "cell_type": "code", - "execution_count": 65, - "metadata": {}, - "outputs": [], - "source": [ - "t_samples, jf = df_by_concat(\"/Users/brow015/devel/qc/classifications/logs/bailey_qc/jellyfish\")" - ] - }, - { - "cell_type": "code", - "execution_count": 66, - "metadata": {}, - "outputs": [ - { - "data": { - "text/html": [ - "
\n", - "\n", - "\n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - " \n", - "
UniqueDistinctTotalMax_count
WL8_S29_0013504156484331326701032711102939692
WL39_S28_00154686186568094415618271307481992783
WL84_S36_0011297593177164748637249735850185318513
WL187_S5_0011105270631139161117441396328115287050
WL121_S37_0011400998829168207060049391241006576649
\n", - "
" - ], - "text/plain": [ - " Unique Distinct Total Max_count\n", - "WL8_S29_001 350415648 433132670 1032711102 939692\n", - "WL39_S28_001 546861865 680944156 1827130748 1992783\n", - "WL84_S36_001 1297593177 1647486372 4973585018 5318513\n", - "WL187_S5_001 1105270631 1391611174 4139632811 5287050\n", - "WL121_S37_001 1400998829 1682070600 4939124100 6576649" - ] - }, - "execution_count": 66, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "jf = jf.reindex([sample_order[i][0] for i in range(len(sample_order))])\n", - "jf.head()" - ] - }, - { - "cell_type": "code", - "execution_count": 70, - "metadata": {}, - "outputs": [ - { - "data": { - "application/vnd.plotly.v1+json": { - "data": [ - { - "name": "Total", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 1032711102, - 1827130748, - 4973585018, - 4139632811, - 4939124100, - 571038766, - 2085678513, - 4490451873, - 3068748784, - 4565505282, - 3683206620, - 690984726, - 680080483, - 2777555392, - 3877020916, - 6777901266, - 7213102474, - 6686813123, - 4994741593, - 4065147492, - 3018436897, - 4123680896, - 780111244, - 6922026222, - 4339960607, - 4399469900, - 5873266948, - 6467864364, - 5755290440, - 5447737629, - 4651469170, - 4932882224, - 1833213532, - 6797994372, - 3245957654, - 3591705527, - 4074521754, - 4459970101, - 7926177327, - 4707505945 - ] - }, - { - "name": "Unique", - "type": "bar", - "x": [ - "WL8_S29_001", - "WL39_S28_001", - "WL84_S36_001", - "WL187_S5_001", - "WL121_S37_001", - "WL142_S30_001", - "WL57_S40_001", - "WL106_S10_001", - "WL134_S34_001", - "WL70_S39_001", - "WL147_S4_001", - "WL162_S15_001", - "WL182_S25_001", - "WL183_S26_001", - "WL1161and2_S12_001", - "WL1141_S35_001", - "WL33_S32_001", - "WL172_S22_001", - "WL55_S20_001", - "WL113_S9_001", - "WL64_S7_001", - "WL1382_S8_001", - "WL180_S31_001", - "WL68_S23_001", - "WL79_S13_001", - "WL3_S6_001", - "WL891_S18_001", - "WL1331and2_S21_001", - "WL115_S17_001", - "WL381and2_S11_001", - "WL110_S14_001", - "WL148_S24_001", - "WL40_S3_001", - "WL124_S19_001", - "WL2_S2_001", - "WL112_S38_001", - "WL51_S1_001", - "WL130_S16_001", - "WL93_S33_001", - "WL69_S27_001" - ], - "y": [ - 350415648, - 546861865, - 1297593177, - 1105270631, - 1400998829, - 157205970, - 471542428, - 1199872361, - 917535868, - 1240862269, - 1023199094, - 219245754, - 189714738, - 683196345, - 961213226, - 1964080341, - 2311563072, - 1829479162, - 1525010392, - 1259185512, - 702833038, - 1065237509, - 198972324, - 2078677939, - 955109301, - 1282359806, - 1144686818, - 1724900246, - 1288952178, - 1265307753, - 1008320998, - 1100054477, - 288836463, - 2095014377, - 877525748, - 605602717, - 808146061, - 865246664, - 1364801098, - 620010018 - ] - } - ], - "layout": { - "margin": { - "b": 200 - }, - "title": "Kmer", - "xaxis": { - "tickangle": -60 - }, - "yaxis": { - "title": "Count" - } - } - }, - "text/html": [ - "
" - ], - "text/vnd.plotly.v1+html": [ - "
" - ] - }, - "metadata": {}, - "output_type": "display_data" - } - ], - "source": [ - "data = [go.Bar(x=jf.index, y=jf[i], name=i) for i in [\"Total\", \"Unique\"]]\n", - "\n", - "layout = go.Layout(\n", - "# barmode='stack',\n", - " title='Kmer',\n", - " margin={'b':200},\n", - " xaxis={\"tickangle\":-60},\n", - " yaxis={\"title\":\"Count\"}\n", - ")\n", - "# print(data)\n", - "fig = go.Figure(data=data, layout=layout)\n", - "iplot(fig)" - ] - }, - { - "cell_type": "code", - "execution_count": 4, - "metadata": {}, - "outputs": [], - "source": [ - "def lc(x):\n", - " \"\"\"Computes the ordinary and generalized Lorenz curve of a list.\n", - "\n", - " In R::\n", - "\n", - " > library(ineq)\n", - " > t <- c(1,2,6,7,8)\n", - " > lc <- Lc(t)\n", - " > lc$p\n", - " [1] 0.0 0.2 0.4 0.6 0.8 1.0\n", - " > lc$L\n", - " [1] 0.00000000 0.04166667 0.12500000 0.37500000 0.66666667 1.00000000\n", - "\n", - " Args:\n", - " x (list): list or array of positive numbers\n", - "\n", - " Returns:\n", - " tuple: list of percentages, list with values of the ordinary Lorenz curve\n", - "\n", - " >>> import numpy as np\n", - " >>> t = [1,2,np.nan,7,8]\n", - " >>> p, L, Lg = lc(t)\n", - " >>> len(p) == len(L) == len(Lg)\n", - " True\n", - " >>> p[1:4]\n", - " array([ 0.25, 0.5 , 0.75])\n", - " >>> L[1:4] # doctest: +ELLIPSIS\n", - " array([ 0.055..., 0.166..., 0.555...])\n", - " >>> Lg[1:4]\n", - " array([ 0.25, 0.75, 2.5 ])\n", - " >>> t = [1,2,np.nan,7,-8]\n", - " >>> lc(t) # doctest: +ELLIPSIS\n", - " Traceback (most recent call last):\n", - " ...\n", - " ValueError: x contained negative number\n", - " \"\"\"\n", - " assert len(x) > 0, \"x is empty\"\n", - " a = np.array(x, dtype=float)\n", - " a = a[np.isfinite(a)]\n", - " if a.min() < 0:\n", - " raise ValueError(\"x contained negative number\")\n", - " a.sort(kind='mergesort')\n", - " a_len = len(a)\n", - " p = np.arange(1, len(a) + 1) / len(a)\n", - " p = np.append([0], p)\n", - " L = a.cumsum() / a.sum()\n", - " L = np.append([0], L)\n", - " Lg = L * np.mean(a)\n", - " return p, L, Lg" - ] - }, - { - "cell_type": "code", - "execution_count": 5, - "metadata": {}, - "outputs": [], - "source": [ - "def gini(x, corr=False):\n", - " \"\"\"Calculates Gini coefficient, the measure of inequality among values\n", - " of a frequency distribution. A Gini coefficient of zero expresses\n", - " perfect equality.\n", - "\n", - " Port from ineq package in R::\n", - "\n", - " > library(ineq)\n", - " > t <- c(1,2,6,7,8)\n", - " > Gini(t)\n", - " [1] 0.3166667\n", - " > Gini(t, corr=TRUE)\n", - " [1] 0.3958333\n", - "\n", - " Args:\n", - " x (list): list or array of numbers\n", - " corr (Optional[bool]): finite sample correction\n", - "\n", - " Returns:\n", - " float\n", - "\n", - " >>> import numpy as np\n", - " >>> t = [1,2,6,7,8]\n", - " >>> gini(t) # doctest: +ELLIPSIS\n", - " 0.3166...\n", - " >>> gini(t, corr=True) # doctest: +ELLIPSIS\n", - " 0.3958...\n", - " >>> gini([]) # doctest: +ELLIPSIS\n", - " Traceback (most recent call last):\n", - " ...\n", - " AssertionError: x is empty\n", - " >>> t = [1,2,6,7,\"A\"]\n", - " >>> gini(t) # doctest: +ELLIPSIS\n", - " Traceback (most recent call last):\n", - " ...\n", - " ValueError: could not convert...\n", - " \"\"\"\n", - " x = np.array(x, dtype=float)\n", - " # filter out nan values as list is coming from merged dataframe\n", - " x = x[~np.isnan(x)]\n", - " n = len(x)\n", - " assert n > 0, \"x is empty\"\n", - " x.sort(kind=\"mergesort\")\n", - " G = sum(np.arange(1, n + 1) * x)\n", - " G = 2 * G / sum(x) - (n + 1)\n", - " if corr:\n", - " return G / (n - 1)\n", - " else:\n", - " return G / n" - ] - }, - { - "cell_type": "code", - "execution_count": 444, - "metadata": {}, - "outputs": [], - "source": [ - "l = m[\"Reads_WL69_S27_001\"].values\n", - "l = m[\"Reads_WL84_S36_001\"].values" - ] - }, - { - "cell_type": "code", - "execution_count": 463, - "metadata": {}, - "outputs": [], - "source": [ - "tmp = m.copy()\n", - "tmp = tmp[(~tmp[tax_level].str.contains(\"unclassified|cannot\"))]\n", - "sample_order = []\n", - "for read_col in tmp.columns.tolist():\n", - " if read_col.startswith(\"Reads_\"):\n", - " sample_order.append([read_col.strip(\"Reads_\"), gini(tmp[read_col])])" - ] - }, - { - "cell_type": "code", - "execution_count": 464, - "metadata": {}, - "outputs": [], - "source": [ - "sample_order = sorted(sample_order, key=lambda x: x[1])" - ] - }, - { - "cell_type": "code", - "execution_count": 465, - "metadata": {}, - "outputs": [ - { - "data": { - "text/plain": [ - "['WL8_S29_001',\n", - " 'WL39_S28_001',\n", - " 'WL84_S36_001',\n", - " 'WL187_S5_001',\n", - " 'WL121_S37_001',\n", - " 'WL142_S30_001',\n", - " 'WL57_S40_001',\n", - " 'WL106_S10_001',\n", - " 'WL134_S34_001',\n", - " 'WL70_S39_001',\n", - " 'WL147_S4_001',\n", - " 'WL162_S15_001',\n", - " 'WL182_S25_001',\n", - " 'WL183_S26_001',\n", - " 'WL1161and2_S12_001',\n", - " 'WL1141_S35_001',\n", - " 'WL33_S32_001',\n", - " 'WL172_S22_001',\n", - " 'WL55_S20_001',\n", - " 'WL113_S9_001',\n", - " 'WL64_S7_001',\n", - " 'WL1382_S8_001',\n", - " 'WL180_S31_001',\n", - " 'WL68_S23_001',\n", - " 'WL79_S13_001',\n", - " 'WL3_S6_001',\n", - " 'WL891_S18_001',\n", - " 'WL1331and2_S21_001',\n", - " 'WL115_S17_001',\n", - " 'WL381and2_S11_001',\n", - " 'WL110_S14_001',\n", - " 'WL148_S24_001',\n", - " 'WL40_S3_001',\n", - " 'WL124_S19_001',\n", - " 'WL2_S2_001',\n", - " 'WL112_S38_001',\n", - " 'WL51_S1_001',\n", - " 'WL130_S16_001',\n", - " 'WL93_S33_001',\n", - " 'WL69_S27_001']" - ] - }, - "execution_count": 465, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "[sample_order[i][0] for i in range(len(sample_order))]" - ] - }, - { - "cell_type": "code", - "execution_count": 457, - "metadata": {}, - "outputs": [ - { - "data": { - "text/plain": [ - "[['Reads_WL8_S29_001', 0.9090146095067351],\n", - " ['Reads_WL39_S28_001', 0.913570932442656],\n", - " ['Reads_WL84_S36_001', 0.9196135574361254],\n", - " ['Reads_WL187_S5_001', 0.9324099182971409],\n", - " ['Reads_WL121_S37_001', 0.9331910532731721],\n", - " ['Reads_WL142_S30_001', 0.9334601849534753],\n", - " ['Reads_WL57_S40_001', 0.9391723495988155],\n", - " ['Reads_WL106_S10_001', 0.9411824039277104],\n", - " ['Reads_WL134_S34_001', 0.941670088419166],\n", - " ['Reads_WL70_S39_001', 0.9417569461720154],\n", - " ['Reads_WL147_S4_001', 0.9422166311690412],\n", - " ['Reads_WL162_S15_001', 0.9424098259365055],\n", - " ['Reads_WL182_S25_001', 0.9431260398089687],\n", - " ['Reads_WL183_S26_001', 0.9439590464887125],\n", - " ['Reads_WL1161and2_S12_001', 0.9470078716458851],\n", - " ['Reads_WL1141_S35_001', 0.9473046737473689],\n", - " ['Reads_WL33_S32_001', 0.9483332340976087],\n", - " ['Reads_WL172_S22_001', 0.9543482806774273],\n", - " ['Reads_WL55_S20_001', 0.954602969659547],\n", - " ['Reads_WL113_S9_001', 0.9559125905958469],\n", - " ['Reads_WL64_S7_001', 0.9560112647240003],\n", - " ['Reads_WL1382_S8_001', 0.9569027006037267],\n", - " ['Reads_WL180_S31_001', 0.9570089761418632],\n", - " ['Reads_WL68_S23_001', 0.957584608813767],\n", - " ['Reads_WL79_S13_001', 0.9603084647628244],\n", - " ['Reads_WL3_S6_001', 0.9614719896150129],\n", - " ['Reads_WL891_S18_001', 0.9627900890951029],\n", - " ['Reads_WL1331and2_S21_001', 0.9647834854805927],\n", - " ['Reads_WL115_S17_001', 0.9655184502195532],\n", - " ['Reads_WL381and2_S11_001', 0.9683482285286374],\n", - " ['Reads_WL110_S14_001', 0.9684447037141958],\n", - " ['Reads_WL148_S24_001', 0.9705861324473523],\n", - " ['Reads_WL40_S3_001', 0.9735922382797029],\n", - " ['Reads_WL124_S19_001', 0.9736333815028021],\n", - " ['Reads_WL2_S2_001', 0.9798021256022506],\n", - " ['Reads_WL112_S38_001', 0.9846289596099688],\n", - " ['Reads_WL51_S1_001', 0.9854320793432455],\n", - " ['Reads_WL130_S16_001', 0.9855101675320994],\n", - " ['Reads_WL93_S33_001', 0.9868658196348955],\n", - " ['Reads_WL69_S27_001', 0.9889584726899195]]" - ] - }, - "execution_count": 457, - "metadata": {}, - "output_type": "execute_result" - } - ], - "source": [ - "sample_order" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [] - } - ], - "metadata": { - "kernelspec": { - "display_name": "Python 3", - "language": "python", - "name": "python3" - }, - "language_info": { - "codemirror_mode": { - "name": "ipython", - "version": 3 - }, - "file_extension": ".py", - "mimetype": "text/x-python", - "name": "python", - "nbconvert_exporter": "python", - "pygments_lexer": "ipython3", - "version": "3.6.4" - } - }, - "nbformat": 4, - "nbformat_minor": 2 -} diff --git a/resources/summary_quality.png b/resources/summary_quality.png new file mode 100644 index 0000000000000000000000000000000000000000..2c695ca7cc3ef87dd17a71d137e75c5fc3190645 GIT binary patch literal 192026 zcmeFZhdZ17+Xrk_t0=9iqDB|BOKgIcR@Ew6d)BTkR$^CcRE?r`%o=U&9R#h~Be6HF z6*~wb=6m_A=Xbo%>wf-#_jVkOH2GfRyUx!z&r8?~HAU*nOqYp>h^UpGDQFTAk?#-@ zkv3c+2R@l7-R34Dx?F85FaJVGUY`AhtCN+jy(JORv#`(c7hlG9+-Sob_A~R*euzV- zxCIhvKBmdo;pVV?&{+EO>d%23sHkODkA6`KG+RT z#t!-1yY_s)w=Y~$FI;U^GJ{;54%|HY_>o>~@PRpXq#-&|Q=nbyMQWJX`R`imwo5gR2kBAI;AG)?0++&E-ivnPrpcx>c$( z$qN~q4lF|~hX+|ngkig47CJ1RbeGvYN#vDPU!#-hvhSPJkEwW;Yj4D=91oJZe+L#{ zzONB(t(SU(Rh(h&J}&&8Sy^(dLPHtYD)h8WKt}mSdeXH&0uy(=i$v4JpK6mPVAk*A zDDPMb{!~%d^D~2m@}?zhaN@$te_BF7pSncF#1uSazODsC>yb}4T_n5BCV7dts_E(| zkvHvSISwcH#X<6V?Mow}`yE_KZXDZhz1-ph%q7wt?HrnkOjp3YM^o4hwMI~Aa5|3S z(~;VAJF*}RcmE9$`rYJJ_n)b#-w%nl1&M?go$qB8FtWi`C`m)*SRatOXGBbL(wPPh zVu%a_E^4|ET_V5AeuJ0vRy2uFz@-9`)h3Q;n#(_~lw6Dpy!?VXGGOlaJsXn3-*;+A z90ORLFG>?>KBO{!tFcL}B1ii!=m9OgW{4ZReEY4k_cx=N=SeR-GJC-rM|5AFb0bMlhOJEta3Q?8?Htn$RyDW1qLXYszEieuouNgwk3ao7vy7Z>uc zy`=xfI`no$Vd}AxM)8Yuw5~9{s-i)L5&C55neavAH6*doJAQe#M`Br0=xTJ(lE#i0 z)rIUZ!8UPo-Nc(JLRRz~Y+7%>{z&~{*gE-x%3Q{@RF`S^=4$9}TkC7BQoGV8qokwc z_RLibQtw!r|2VIRLsEJ8Z??5s&ThLLI=4A9IQ!O^O)5%L6bDte9L~;dlKAj9kojNt zXPpW04^C%)Kubl@`_7akp(MBj?i`AKT%&Z8Lxq+;tW`nhHJRY&nlRnx1)RnlGWQzp zetHJG$Eo=sOuh5==NPr5g>Fi=p&znVw2=9? zR;*TTuUM{>2x*V$Cgr4lGtBofL>NF{K2fp^d>+^N=CkW(2)8EF2P*~hzJA*YTTa{K z3e-3KZz`|SRnMW99 zg)3LzXmh*&1(Cb2$T7YyoI>(T7)>~TzPUc9pCgCku;;skN$mT~eFbT}_Nmn?xze0Up*I(v#&#t>) zbG*diKH_d&r-P8)LgRnK2EC-slZCXB+7gSwh2SS?*3xarROGOCB{aMKxSq1U&Nt5I zj&G+A>){H4<8YV|c`$ZZxNC=N+rM~#-C;AeEfp`&AGQfFZ#oEwlyf!pGS&MX%U;f| z@uKUFmqt^TQ8+8Vs3EWJnm+4+a5sm&k*>A4h!1qX zZtP05r&+klR&u7nOzsYXRMrMa+=Ll*Gu9`dkdh=`BJY~+=MZ-nJ#a!7Z zeoas4mJ?e#+f3u2*YZlvNW3ktvWbTy;>dMxTZ3)6e}JN53}ZjUrg7GBV4t%pxu|m~L0j;%30pH?4)V0WMCM({V^K>{ ziBfZFZ?e8;kxKu7qMwX~r$VQ|xQ|DeVUaS22d=ZBC&7LB`cUZYEln3lu2BEJo07`C z871=a$+FIJnW7K+?r$n*-~3o960x$YDuTwZryLLH@96iA@445miWV{(q6|$C#N*L5 znZDU4t@RPj5`GejqF2Ro91cWAB&)^o$BRond{BL;1XO;8;H#4$kRZ^>Hac6DGwZ#B zKf=~kk2_3N?-~$S|Au9{n<@QCxTDs$%VzKQ;MmO7pucKk{mKN*M$-oE+S1H&1MXSr zYZs3#bkUPKCeHy+hBd!NYeJgceah$Dd)M&K_ns>UJx{?iu1%C;mGz#F!Cg_?!Nk+SadR!PnjMah$E{l_E?c??p^# zD6c3-y<=IZ!N;Y4?4;9<^NDPKX#pMK~c!!)2XD# z{64sRJE{1yd~BU>eVHkk;vSPbzH0s@eLSkq6um(Dg<&HBo<@;(*{uZZG zf&0YEMjKNYd_NY6NO$+2ebg)8-TYSZa@2EHJDH+`o}Fs)uR%ML8FZ&OK~jMf^7!~Ze59TNUx6EkKC!(-G05Fv$^o=`;qMR)6vuM`Q2q%@W~oe1S5;z zT^NW^wFEz?YsNCvJF!tRdLP}MYyRc+Lvc4sQASY4-7oUw$o};Z!(>8#ajuC$!v#NY z@gzYBE{pKdfkL9og5q2h0oBja<-#rmjFS?%bf`2+^V#IKrE_eid*$Y(#gh^ZIS?t# z6Vbl=co^MxNf1gy^q4k$lc)p^?>^yjiGi=H@N3fbC&#I%HOL<*q;e6NT;$;7Oy=Nh z9AGztdcHs|GhbpSE{+>!G+!BRFczg{zMM*t|B+Z>1_{}VwUR&~eIXDBYiHM}VB!RaMmTqS3UJmw-5J@la zoqx2D1m2&0EO3YYA5Glsz;|?2U$DzNxmvP|@C)-lyd!g&ot<6U)xt_rQ{m~q4hQ}R zzGLI&<}4{7;OXhf?+M~}aIQvFGkpH2;f6fgY zDt-2;1eFkUj3r3L;o_A-}$J|83jrsI~ag8EC~_t|^khj<2fdGOEQzx$@Tb{kekU;DaAb4T{!^}AQO zN3V-rxTZ%R78;7yemHi$gO=jg1FB|Pm28FQQ!j^KzBHs~_`LAF=ymomQx8_6+}nC1 z9b&!FeWmLP4uQ1Un1P_6=~AA)aO++P?_cg$Z;;W-5fT5z%TgSPH!XTKZufES|IzZ< zC0g{{qrX0zTm~H_aJFBc<%j=|v$1EifdYs~F0r5gBFA}yJ!2${C#2x^`Hjv_Atx7Q z{g<7TBMMaGm6I!`)48H2|JN-80$5RheOp8%aNU3aW6q*mWx@YPOJZ=^Uyc3QSW1=> z5hK+MB`m1_kCr4bY0|$ME#Ow%UK5kR;5Dx8On*79L?mQ8UgZDB{4D(fT1mPrM2q~z z;yLSp2TTszOd}hoV+?&_3|r3m)u?0Q`>NIx%fGO&;5w+G*kKmJ!ohaDr1+JBjCN_B zWTMI;c6W88YqhwM->HF+D=a3aoWO7N#h}_T%)gDzzy9URm+h?HYkeKckN3{M%LlxH z@M~xg^{MPZUz9~pvPhX_*Nw4KbH)5lWAF9*VDG)St+}?YrM~PI`*QXGISlPX;{EY) zeZm~u=>ujl$L_?hq%_hm)TGvh5&N^@IsT_7j3|LtxQ?s zs*wB2pu(Ima<6Q0j)ZKR!xZ-C`1eKGXsL}Fd3}9-*XQ^+EwxWVDg?+j|pE7xz+FzUvgnm!o7RU~8PRgfNvPp%&Oj__+(CE<|pc1csmXE>29l z!$FIlZlP)+9L}5?%is~HN-?e?MWR673o1_10|vuX-^YNj8}*Eg_(0aZ7B*9&-H}vF z$gNi9u#AF2R#lo#l>Z5?N`CF!Ewp4o0;O0gG^kc1r@G00dV+7nY1jAnYa*}>hx3#s z`;Vvl@7*S&eI{TE8&pjZiFj)t*-NXuloO4vZ1c;d-^n^Z>^rGTP0{ldfHS zQX);b%3@!>t6v26ph6T&K&Y%bcZCU2R!C)tIZlcbS_J$)?WyG^z!_z51L-FfK5OP| zvAMY%(5)7R1z=1dtpo&r!~W|eS%1Ir9f?pPl6AToOq#dF5<0WYye;x0#d;mK!SyEv z=e=M%pY_U-d7yLAJt<<=^}VT^aIBBw4SvI$%ac>P_efxMc0HQ>=j=IC3`GS`1~8l0 zj=+noHzfyiZEG4fYFFpK#Hy9W|Au=`e@aefA}p)>zX3aX`0Zq~eFi3jV}lNM?INul zyEXAZ-5w~N@Ui}Iqb}1n5wXdknjDwNSzcdn*j?o<2zF=l+c!h3m30Y`;~jyaBy4y# zt~S)?4?`%HL_|e9SBAb9s+kA}dn%xPz42rD-=HFel@?TL9y30zrDK!ZI?{wfz`zNs9ffs)X8!8$-jbOU39M4;t=J+*ChS`;t_wl7KgY-C*4@i9-|{l7a+u)YNHlv(&p}jH$Ddn}tC-+&46K2>Q+1vR zL02T7?M*^ZS9r=0)q35&p2OF|TdwWeuDDwF{2A3iSxep>INWW&8x=<*v)=?8{}aN- z?@#D5`Q`J}NClxnbW%0pNQt!ATN@K{nf-;HgRch=N&}ZQ>`#)cv%oVhKy)wk=%6{T zi-Ze67eP3)q%^52%fr3(*NfvHYL6Dh8b49;*EGRu8Ov~`ZLH<2IIPcHgxEERThgE9 zlfCN3ju1A#B?(I`5+5I{E+f$wzEqFvRVE`yb6S+T;HNyhiv5pQf4%TJ+t9H($*q1M zs_DV6S~*TL4IRe=dFl*wv^W9lG-$35(3d@Id|tYrzGLI@9uPX4$u5vzxn%=hToVqY zr*o_1Q)F>}Id2@r$H!OZwyY_LD@c+n^tX9R*DZChl-=T$JgsNd@asW1W7!ZD;*CKs z7(e;zmc!!cA+}LKY{mz2=eOOWvG5Pk@LTNALs+=)sdfMHx|2W8S)`Lb z*`G@zN}yOu3K#~kC*HZZpdik7Z>%lhaYaw0k4*Nw&GvkUE3glP)83>tI{6-dh1$kCqgpp5GHee>(4w7|0L%cRL{qA=92S8|i#0i3 z(Wxrnm?qs|Q!g-Sl)3s*l(TWCU)i;VUPreW^k}5KSCR+XP392=pu#VFK|_NKVg~uT z_v^QBuGq^)V%YGDY(8jMJpfp)dt=rHe*r~JcQPUdB?Or21^c*GWgTdHxsBjKJVg=p zTgATXc7gs(4>}X$$p>ed9)|nR(xsOyw#BQjS0>avCDmpe@J!G6k*;9uV0(avLwY4# zs15J)j|99GaT+o4M@kXq4}e|by-HYQ9WjKcZr7L4o6n-6${h-_c|E70)<>atBQL48 zDWQ%feD*hM_OiMX>m}NJ;oe5xb{s_}4L;C%0Pr(05+gSas2{df+mFR;HEhrcH{CcJ zi#bUh^Hy(he7|wp7Td{Y$fwSw$?td5)iG%rGEuT8`)F6Y65*mpe;#z`q6AU-=2nM3 z^Pdz+Mw0LW>xSj(LDPXa2dRUdWpmYL>AOksEK(l7oNE3AKSQNTr7sfte(M?r*(Nz& zJ=oZv=aglH6_O_xS_(n;JJkJV5o#e)SHL51>(c{#CI&sTK=Mm^oesobl+La-O@g+MZKlhEgeJyn` zJy=X4^(#cbMfPwEmD>|ixHZ{WoRxLQoPFs%gK;RE*Y7}yDc~x4TaPa}9x!8=Gph6G;i8eeXSxK2lcHn}?R(vq`Lma=j-%1P?=kPMwPQfe zI4UU>tg@%xBR|4ICe(exLSO7rzwGg{`bpOP zYAJ6yl*JCP@nQMzDR!*&-FgSmtMIgdr2gOH=S0~6x#t;1|DY)EM8|8Hk?P`q-tE8A zF`^$KjLb?ZYOicSbwSN8wb-FFcaXGIttCJLBxaN`8W3*1a3M&R;mOSXHE4vYqGA4iu z!Cg1C{Pslh;%oL&BYLzqVIg5)?|C`ce0k4zS=r=rT+f)sC1UV^lxTs^q7>Y=56U55 z?7!2e2r}w*Ifqyf5vMn?S{X1qLX0D24s7}|DesyT2lDlq2HIe6^&!#}FnZSVxwkG!JD~5_LQLBXGZpfR3!~J$tkz#jyZ9KPZ`LY>s<`c@kUfxBLBd=NDq) zGdj#KnUHWgIPW3J#tt1|V~x%-K&PuED>fVO4uY^y`+E;P@W3^$QOqKUyx`&y{iaYMXaq`KI9(`E$O? zyQQAz3~&*idLtr<9Jw+_;RL^x7f~luVe42wd|jF850ceVexus<8kac*|HSBhM*w4u zDyoZkjcSFr3`hCoQuic7(g0O( zAF2}MvOR8Be80-XclT8i$XabX(fdhIk83Aa-aXHx?IdiX-cAUE>*kM(oN1@OuFRY! zVSS5@kv`s9DPY(REyU^66^N-H_H1^sR?O##9roA&fu@ArTt?fQo2omhSiQnM}V~RS^}%0#3!;IHPs}|pp<4#p=+gW`d#}WvPZWagGYAKvG#UN zoX&N?o+1^CDw!)N@4d_y1--IeD!qf2&%{6UVDj3Yw9?r{Q>G~Qbra_YLe*K})F4b6 zxu1L&gJ{Tn??xtO9_1sm^@}c(a3)Zu^2mn=s1v>sA2bnqui&O34GbqJwxiz{du@I0 zoabCv+(sAO7K0z!IOU_s4gG^0a~;c zMIwjx!~rVANR;meWH_TBHl!t-A!Hh5XlHPPPyafs=j0H}HdE{VeZA~gLyBW9*N*=B z&=R5uKw4Bp`RKzRt0f1ufc`6g#&z^^eTxxB1Hp2p`}9M$iY_hX)M45`-31eHPLlv& zWG>XrMM@pzaaK{@QQNk*5AEy}uGmh#?PL$CJtd|fs~ah@AeU$6@hgJTOQh`yw7 z^7A^=R?U#DvCYm?EcEh}=v24XC0HlR`fsnm~s9Dar z;n4_;f-*x*J-{A7^q{^8?t+iGoU#5L0C;BdA18QKnV0JN6a&h;HaYE8m9=7sX=R$z zcA>lrtRL@`*rYxRDr%N!o$)_Cp1;pR@ZoSuUifgu|K=N)5hG8_q~v3_0dLS+(!;~m zl@)1*T*{*5=#(@_v#6Vw_9|GFW$Xr>g%FN?{Dcs6c(Mv`4f0i_%9z_F_0#3B^~V4e zWet_QS5)bfYhC%3XX5oO2lt}popCj5wsVJsEU^BBtbFq- z?scpC^kX}w#iWPCB={Kq3>|IlMHvydW3)U?cc@(A;GC!KXv)ZLP# zzRG{&&t0i)0+of(>=n3y(BNZCLwMrzgMn_^YO`sp(_GaQX^OQE0co71diIG}1>L5u zxI#23EO@r8i=VPk7B2rV!xBaazJLVAeY}aV_Wvywf!GqtQ4%7d%AAg?wLx*|Az_tE z_2#ap$M|q^M^`ly@1ao9)bL*Xf|9)VW``8EehxqY*v`^z$YM7IK)}%wS@S_OGM8@k zvwyNFuATRzCJ7_Ai<#*CK>k%B1nVX`;Mbcfq2+e+U{!+YUW`&K$A!p3-O|Tr>H^Rx z@*xuRu~xMU0DeW;sEe#}F*#pb|Adhcbz6FY0F*NLFg0Sru};Gnb@F*OQ~xY87@y-8jWO%Jn`1mi?WqduefNkt*fOKd&{-` zc83H0Lq{7RAt&p`E2janR>UZRYBD+5W>{U2tk3tsde4-zc3I{1{^8(+yJ;@nUt|>D zY$As>Y`H4v@H+gj-dFUOBUz}{A;8)$hHl>xKpOg>cL6rlgR(zoW?qN-s}SonuxZ=T;r zrNH_th$Iz}<_{F}M*zS_n7H*laRF7lu6^o)Nla2l>GfZDn~Iw_T<#9BS{%8oyt*@> z?pYSMH9*yNGhWS_Vrh3}h(|ce42rTkMdGJdU7qVi&9z40QkknhsmiH)KY1Uo?i~<3 zb!YW>x$|>`PAvrf&)z+3o(rCm_clTFeysWiwwfC!?S*VlA|UeEzCr^r6vE0}hkQq6 z)9>dy3R_Ga6|QW3hJ^%{t5zZAY{Mc0K;B~9e1EyM`YNKbva$oBdoH_gH#SWm+nF2_ z2Fs~nD^-xqli;duL*FX$9iNQ>GkLnPGxWU)E2b2vM;paeta6|;+|6|Ay z9+Bg%#IP>}_RZoQBirfUy&-jagv*}f@0S3g?bFT|?Mjlug}YGUT>$R8t@<+W%+b@+ zyU<;7!`B|3320apAVN8v!vV@W@JDx!Gu8RAjj;o&ei;F1owi`(@;b7eG}y{lw2-m; z(5nu~!P`oOm?WsGyZFRBwBTH+W+710MG8}k??F4v?6-;)Q2)#ooFb!4UFZ>;p#r0Z zH`BUgKx=7wtUjAR(B5Mt*VI^#(w+4}6G9CrZO6pil z?o6vPY>q%V9je1quxYYJ<%N(XJ(QS~Dpq?!#LA@hkH!Es$S#;ZqV|^Oq|5MON8NiTGmZUence#NCivuA#gAfGB)5 zTxehoUYz-gyYxZS@6eO83W!ay9IBUZ4X|3e0;+% zd*VgF$e!AsF=OLd370Fm-<9EW%5IUem_ZL;k9pi!+Q(!p>c>Sk-dtAu@GG)h01%)Y zLShcx5}z}QJ7?JZmO`KksBS)#>juSdfH%+NjPU*57AB620x_NNQRC<;!8G5Jr z_69>~B3QxWV=8`W9^GMHEhl-YEO%ksp4Zo z$A0_9J(1beU{{P3-Rh;dg=QHCsk^0t871BFCw=i#fm(p4oVZDO%k<*86vHAg6|e%l z72O){twx+>Yyd~55}4NkvYRUCHnNSQaNCa~#37L|B>9c85F#YAB5f_j^k+`!lHQ@ohGdfGNl=M53 z;?8(HV10K1&YYE09IgS_DM=qa*2iA~>mDhWrfS+nb|l0%{#~^KleAl*r6%#DLQ#KK zS5YQ?xLaWoFq5472)u>X{(uLsOxF67WPI@s{Gt{h=1la8)vIy&*^$r5!g}!I$VB!6 z^QCF0VRx@rf+x#2=t?G>8jl~(+^z~pqi9cRN_9w*bpLj=-zHnd@_eoCcyFTckrc$) z^YRjMyOYQD*HuMbe}%1ZlcUFH*1n+Z+s#JK9?+L&2af60%+OosQkiz%j7Jrz@t!lj zBa-#W(}Ja^TWxG8$*J1fTC^~Y^roCTY`p9Kjv=VtQifsu&ox*vfUDyDh20N*BO^{h z_U%0YyWrhP{&ZK-svZkukIK=jmH3yx4;VpK@6sB52-{7B^{Ku-dB^0V+!V-}rKoIh zk6N@v#KuhI0O-y}k`zGTQ58wO&YM7%pd`Kx`V=L(%Bzkz>Ocbi_f~e4jHCmTn*N45 z$lqi%>yeHfOk;6Z8Gohkcjj(96H&!9_AE)T>x1tNqvO;s7O|W%T0}!SzZ2Wp>GgoN zM;cFtU@HFiejE0l&*-JdTsJcFsE1=5Yve)mX^b4bGo)>X3{{C{b3cPW4MOwg&k`rw znxO8~Ww5zH7S(-g*cP9DMY{)L$w$L=8j86e<%>(1iL>mAzh6DYldCgfVB zo>^ibq+!{}vU3|S-6iW{($n{Uan66>DSGCZ^4X|QUcgA;SE+ehCtvmCY)7`YJcj5x zoUIqhgK!My8OnI-S_cg2yeh;mK3Ls&>>vnMX@+IJG1YcUtN4h-qzbFj zNaE~MSc|G!cE}v;?JHQWfj$=ak1FHCtZceVu$52-g7;F=baL)Ut^?xtTS|-N{+ufL z4qw1Buf-taq%(M0?Yk2NH;lq|AK!8vu$ZjZ5kT(r%RyBHqzAOhtExnuyQ!=t?MF+R z{5;MFH7<0dsp*lT?7^o>onWimr6$aEbCNF&S`8A@)R|Jl{ejF7wW>OEEO=QOAX%B1 zm1tiVxLp^d!CRixZcE1Z;GJ=?d^H*yJFsUhopQnZwb2iy}$;iz00xAs0c z88}OB^(QUs6Lq+HzXadb*e6sTrd7gz>Buv4!L`#CCi=!yQg|0g=ha-nCJVB}PS3W4 z%MS=%RFho(f_7^FJiQi?2i8bGz%tAnNje;dEg^BeQkf%5lL5nr;!-08dUU7liZa(= zzN2_8|5Q`tQw$msbH(Q@ybRl^AcVbciO-AyD5n0-*c!HJRi22o8h*D1~2JO4R z%>`2oocYgdzWv_H28W?l0~{1=hWER zi~cD8@Zm#+?UIj$3%r^)T78|K9tQ87V;F&!l8n>?`2`m`!?J~;wE^R2F6$TO5xr!z z71ahyA{;L=AkSJ@WV=smiM3c z$u+B*-m~{f2;&AI$KW9(kfobzJX#Q#v$`}2Bv?4jnKXh;>yNg(26DCZ^ccnDr;@Q_ zDNYTHjQ~Q=B^Y_=jbl)8KW?BwR#p$xJsIKda4C@Ev`f_!%r+&9-w?v@+EpFU^y>?^b&T9U>rL5)Gm`gFg)Es=Sbs|V zLo)D>tkdgDs_VxwH?uT@XkQ19Q5sa_eO@wj4QytTixvQqaDm4sELOUYaVRQTMt2Hk z*8#)RX0{V_GMoSSxID*q@A2SCVcR!NuOh`~FF}FC@^SSuM>aR~qby|pJRqX!;qt0y znu#exl@(uXW2)R;lFdYmyERS^1Zt`!pMbOUrT6yi%)@5Tn+yp-l@)*}volF=r^ieV zHx=5j3nSJG+~#r1lb{iGTz#^c*;I4zVzPGaYOVV!$9TD_n{g+4pu7Baa87r{8Q%&! z=+iOF)uL-tg&%}W3SX=cvwQ7jYH-J@-GExnjj#uXqK4upQta0QoEC_Mq}+pAm0BOdm8;F-m)th&1*h79kxm_l4dJKEM~D-9htZ zy~PZ$)bp!P^e$D1@!P<@P_sx1yB1UT=xbvlZwlV&JLKg}Uxvk5dJBLoGPu-7U&AUa zQgR`Fx>$aQv=I$>U=_9V3)0`QI6xJ}Ff9MDAS8|J5a2EhBfp=h;dd}7s=GHu*H(ZK zV%=#CGt6BjED6Zht^=aGrdP)%rjj2}4*HqHi zs6_%JkNI70%secQ+HqA)m@$lcPpvWW3B04?wB&|m^&I0+Nu<@j-*F6Nl^bV)oL$FK zPT)iZw%_9I`HDf|n$1XbN-v8F>5*8&7EldcztKAPV3niCjaU?O0?0)tJTeNrH(IkN z3W=%kOa3ES*=C}KuLW3zd@+dly<69ON349YD#j+bZIJcju$}6Q+f%O>sgFk6WUP>) zQ{bt#?#aOMIi4NSI_?Z>A&X#tksnVz{mPAG=cDCk1pqc;Lr5iM+4Ygc+oAFpf4ZVG z9<95E&Dy+uTy@(8UY|l(&iXPZivg0j;daH^tCbujmImFau_g!o2?Znj1D;MPLcIDF z4}^agA#wKAtLWQes^kZ|s|;W5HAr9_$Un^?)+z!8Ym2b+_uSfr?Q3X=<9GRm7ImP4 z<6{JJ)#GIB_CkV*BXU~YN?*maUAlQWI6}Dj-C5p3mE*Ir9Lmss+Z(8S$wMYk z#G82idG7*06@TrBQmzOThRRf9+aXS*d8Yd`i8PWG!p7Szb`Ui}9>6 z|8*{F4A3#9DgPRQma-hHu#L4rF^tti%g^v6%-_lgV-^F{nHdTPBpl@-4Zr9V8)qRs z#^DM08Gnu}lMu7(@Kfam0Kmd~`4V|iIFzgalUK>KIw|ZQ$@r)-k2feWC?MJ`SBDGBd=EV& zW<&3Ou|}nZ?bLZ<9qYbK9Rjx7ZKk-L#5XiDeQB~;$Vr8eJD-V3$?tW-qa^J;gUeN# zq+@egMZA){tlXEB`ixV;wv!}>*xxU`h;v;`vhD=#3vRhGJs`D0*qIi=^HD2wnn!`- zH~*2A0&3;x=5RpeSNIhvE~d$=)CV0v=}=<6KQ(ta`4CuakUa$`F$N=0(%3~rRBa+Q zfgFDgRZrkg!5ETmhhe6rPnkBulV7&ty6fb>8PJ_oZ8AsZAquVgt4YLfzGT)DhOba6y}}L8zIP|%BrBpx#^5~juI_W7{byP zU(cORjGWR6)m+~ok$h)$$JyxBtNTFd25!T6a;nznOj|$kHrDUTZ_W=s@%jNHKCgy| zm`vz0ExPMjTsqyQrG>UnFE1N3?f4va>NMOr%Wj)7d})XH16JmJnEe4`!+wjvb0Z_T zzu3gNM&$Z+pqx~#DL;V@9nReXy~K`Ay1?qU|K}I_Ta|Qgx~xgJb1Lt-M-%ATGZIWt z=)p@%@B5w4DmTA20R=I#g1EIL3E>_exK%IuEYm0$l_lE+(4FElf>#D4tM_S2BhIT6 zMXLc7o9kpBVG@8#rkNT7)RsOm1=ia3S9M=*O%DK`*sUDF=ZE1VpxU;p@vF!a5}5W4 zV0M6#*-$1l4;R-b1`{6*86eB;Iop4331^1$g-c8BFQ%@dSJ`bGgNR6=bimPvK$VYx z*rc=k^oH`|bBDtixN+ksc-0d*r@X$Hha{KQ?gc&|Mgr2I9Vn}8nuJPyz4GkFIcdX( zXSJnE62NpkLQj$t1BH;${23$JiZn^04#^)GK~MKa&77}}|Ap{> zZ-~D)#NQj@?+x+4=+u8f=ig-We~r%n-^pgnZS=l9QrN*s>3Y?d3PWyK{0+q)T=z-% z0~dRCx0mLabGY`{#_BAbxVVd?&32P4D{bw9-#Xt*>_WtCpJc3!FHGL z8%b@ROkV!Ca(p``KUH*J zgaa2s^?8AdsNAZ(Q>W&SGTF+?{V{6PAc|YPi^-bwI}*f+Rw%u@mDG#i*`=O ze9bur{Fo^NZV{e%r6;UZ4yV3=6^MuYvpxWYL&R<*&EgCp-EZ{Y{RqDtThv?f>&A@ju-lIex`|SHFCC&aN%c9HJdQ zK!%C)osBuP{QaX>I~Wx$9Bf$kxD_53GF(qpEfC*a+OxWlAX0AOu4~>vlT|-sgLr)u zI`trtJ~qcZxbr8U!-aLh$J&#klC)@?D0ld1dUN7n@ppByCKcfc;c5Je#xvBn#nUt? zi{Z(IKx`3K@R@@LS8RiI`dtjwiU9qESHmx_et;Ds)VM>`Kef7Dx;+!-mf!}|uO1MD zDqzrg`_DW1(UgjY59HN~FV$1t;fxV4eG(se^B(1l4YKoOx}Cq}wUqZ<7I#v~m(0RZ zOD42IbVxuNHsltghH}p9CJEO+`L{J)oEJS|T~!ffK3k6wa}6*oP0G)Wfx>E)lRk^( z84zULOsRzJ-)qhp@R=ZXC6WKx`O(H1ImX|}U!4tBs$suVazXO=$e7CEvcoTBxMYFV z`;R?sD4dqkjdlIwtT$hcHPf{SAw9b6=7(_$ZVs5*b_VonE-^CaM?l&sv_dANf!(d+ zHLzDU?B1&o_ARz?hgLap*9#=$bb) zd(f#b-Exf_yz?5xAD20ou=rc&HYj2688%;5VQcF4-kK|;jGv!SzPYc{ev#P#&u?G+ zqCf_Qa61GaZ(Gg%v^Or<39sfId3urER^5YTP0BA#h1qapyqWvoOei`9uw^DEYyM|T zss%;|r0wa&*mlJ$&8XaUs=wuXplENUcz_RwbWssN}VEg8iq;k*F9wJmK&~ zvas^K%%`0H{#yV!*xx6vgP9kfDJh5BJB+g1RgCC;BiF>QOW6jhFuz!OgtQ?B`;!({ z=0#u;0#e0KZy0J45re4}v~8pG{fT6@gm(&}V`U9Eyeob3aa4|C%RI6y3U*A zmogmY#3<*>dn-uPY6-kRq6g&H)hd#qzd zK=IB&o|t%iG5#YKIb#{hYb>MY-#dGxoB2e4rxEp)Z zkD{_LxZ|s6%)yZ6{w>ZRc*R~<%!H#`H?7`omIK_@`7I^*!s(Sm*CvktEJ!ur&ksnl zME)m~UGlo%6G)ByA(Vvh3EY`R)rnOOJs3dcUmx(%&H|nU%3n0Lp>?;LFDXKna#xDQ zTlW_5`{r0}34gs*7(0CUOSCYqQ`ruQ`)(`0RQ5UdcEt+@lV->E=#)>-G2R=LcQUGt z(nHLqF=nHcT^4IfeQ$)T5NcK?peMtP8d=Ch?I+ll>lAUZ9=URJz6Z@=t8jK-#9%=( zC;j+sn5W?pF;c}}ab;1vGtPU`slyea;S0;z+L~!zOk8fLvism`5<<2k)I*1GK)#Gj z-5}KIiEcmD+jQ_2KypwI_7n-k^6)c0m>Q4<P z**({w{5@{F{NmVJ|9W;OTWt6>hnL>!{yvSTnQfgNzTV0LUBwH9?zu?ObHOWbotm_}iq z;*V&?E(=38Wuj+YS3zJCH!iNe?WYevw4@q4GX@g|%+{0Lb?b6=S*-<1-=abg?k;m z2w_8M;c&{-!~XFO`Xdvi%Phd|^s) z*M3!rJo80fnfmH(#d;an*zahmnY;UHx_SGS-nJ=BW%xK-Ee+~tH+z_$>94vVn>z7;@t`OvVp!RUxG%$8yckJSIBE8;S^2~!lJ=x zdvH=`up;BcYI$a*HP5Y~)jIuC;eJ{IsYH@IZlI*-q z|EVbB=OZV&Le_Pq>c`&wId7y!xb5NzcZ0jO#Zp&suby&(W&ZVqe8x>6*FtYzsAcu< zNATEnh}GrPf%^)#JT*}4xRs|06lJ$xUZ=ihLtz)M?=Y%AHeB+m-zlqmty242Yy=bt zbi4SW&bU<_7?bAl6RyIW93cOP+MUg?oJ!&L9kW+u(?c1n>diwT@#|pyNr5P(5Lzq3xgV(hoN+$kfJL8 z_?=r1K*bFz+^~1AR4RN9NJ%y_pBjkreSVaCTXwsDocWvO278jL$u~qJcCbaL&;;N8 zRk--`qh{-zG%Rbj<&eW&SEj5UlOi{ynvgZ`F=MIfs^wl~xtnR&b$dRO(7dn-WCVV5^YM_h7_YwE_*!j z#@6xN-b{<4C37=jYuM-tpa1^xkLUcQf5rN>6Ce@gaVnYn?%x7b?u5*T7_R_RrYlA=_((m9wR6fa2u$dt~{x{^|j8L0^{8#`sl$9pI@a zX6lVepAQ)I6jYHvGl9yJ+}SYjVxDraO)eL?^zbQZc2Tg0CzILgU13v@mE49NS{&JPrS4@|r!H?O|>CuiCVM}^J z!Z-YUvC8?=`^k16%rb=ZBHZbUE5mhS?lys-P{2x+$f$*zb783EL4?*ffK>d)s zh5aCfWG*GW^gy8!yrAYc+!j)^Q9FJbL&N=U=V0^m?acn1mmy?>e?%&8*AhsnTOCSw zu2E8l?sr<758qyR-W{D1Z~kYYD)m;`_a7j)q~QSaS9U&+hN6{8>vYsv?m-MAN;g>T z3ONrunKOS3PVBP`=PxUZxs+eyTGivoVH+WYPQUq-%NKE@`EpVo$^e?76)S*@_W8%W z(g^R6R~$*D5^Czfnmu~vPDb~euh3WseQt^*|0?tSxu&{{Q&P26ZX8DZx>?uag3wYH z;p>ijA$A`soe8d?=n`ss9X!<5Gw?x+f^(#D=(V;V~*g+|g55L?uA zeuTd;hv)yniK(P4?P* z&bj7%)->i=!PKRfqL&$_ao)1tDCHIyY;d<>aY_XBg@6fLEWlL^Ju`RnF99A4(R+ zB5Wt|L%12F-8em{0`jvoPcZnWZS%t1r}9c*YAI;?j_!vEYm+l% zoYEV60c%CY`>YE{NNFX%4GV6M`>^|?`J)E-XMV@C2^)&(UiLGp-Qk6q{P13hCySZ4 zbR#3C_fo<|zc(4CYJK0hcfImNbrYDSXjmo)Gw1u*E^|`uW#+Bc2t3Oj@0c?&hQLT%^(s*_Kwr zpmK{|jWf3O8l%-E_6K{?Fe}|HjF9h~<34`5pJ_-lul7C(0)`sWWX5k;8p=E=5KPbW zUa9Tp`p|-bF*dkSwMn3*Ecq*}Gvy5bSSm_2Zd(5wTriZZQjK))FDo>1nQCwB=nD}u zT&2H89ru>2Npm&io;3u~QFlBS=xycH`bporkw$l2$LNePVSVD^rZ1KGG2jRRj6dXn z3QqA#4Kj$v6Y=G4aR<%MRxiQ%biKdCy7=DhPneM!g(CbDW$pX3@vKAE@8y4-lE+$) z)aYT>5<1&qwJ4o1m+Qe_x`iVzO0y47xHySwLWHGWOitu}ln zY%U1*J@_Muz=K z-`+8Sdw8dmCRY|M|IXe0Ua~889jWS76IMUw?Z8`*OYMVaYK1us9EYq*=>bUqXan)v4^3Uz8r!7sk7q<63n^kEzeyY@_)N zE7~}flm=gR{MAAz^wMc-+r}$HqlmluvH%#;q7j=khrCfR=oN4H)MUoA0d-d^?+Sv< z-%3heN1tSOiGQnpvh-Q}zPe;DUW}i6d;^OWTG5d0a9)r%$n$b{ekS9>Din>P$7m-w zrQmC6&pW=n->KiuF)S)HA-W`4nZx(0_3NA0SHzx zW^Gx!CFPCP9z7Kza_B#jk%;k+CLSAcUhy#JJ_Ek#?PNI_Fc%c)s7vjbiAFqmNkp&0 zWc#}Yiq4SyE6QpBp(G1*;ZwGXO>)LL(xGvPR-KnJXPs+lLf4L@MVpad`$jo(kWevB z$TQ!$?&3PqXG@|~iAu7y%){koGFy90eaz46Wi2BXg)EKm( zOtxsAOE|GRCJI~{1CNNNP8M2GP-{wjYX*-6FhMs%uX==KO1|#5kLtnJ$a4U1UWJgx+HH+Nt={LPxV=bI-|mMxBsXBmD65-uV+4ec}s4S z&+koh;RkF;;Ci-$2sF5&o@lC``KHRbOKGlnc;`m34VpMZsU1}BK3$qAYw;1QPOWZw zCnR+2A`OKLS*NXY;1+G-*N_-3uoPNCg=Z%If`)^P_2JmVz)TL&rXA(g;D+PoWvK*r z84T7IAVPoi|gKXs=Fw2OQ7{0D0yzK>2@GOLC+5qNf-5hoDj2vx47g7}8@69+1 zY~@4ASY=@gMp$$Pj~U*;nMS|ASYM*8NA-f{GRn>r3Maog_96vpb7meayjaUdw|!dt z31yvqDfaI*!xMj?Vy#|wg5O^GH*WAteo^shX8QH&It!|-{-Si%JtKt?hM}Q|TKlPh zH6NKB$z_1DxpVx5G&Cl1LO7rY!R0^4@>eRdFZJ85wJfGd;w4%qZ)#Ua_6Qv8`;8g} zu2avV%e~POF88+!4BOgSyMIcuPYtT0g+Bcd0v}NLW0UHHu*cI(?52Mq%+oQB$T%jx~50)UFMe$>jxB#=Gc24rApBLrEFJ1&S72I1goRB zKJFwOC=$=S^RS@8n=vDoy!`%_<1EW`i`6qru~~^0D50ippz8F(Vwd`TvN>riuEZN> zS*uiFKU>mgtjJRdw>UGsmAy|UefcNF1_7Sk>HglAwt2Or;(EI*|nxx=KGu=1Uvaw6aSS8Lk?+~7k+}rj0Ha~@Fj^sSC7ViA`*Pw51*bSPH5#n zneeH3Nhf1=&+C?6wTL48L`&nZGQ$7S0y1=k4AJEU;VOVMi1>G$SR=qpxD9{>we@jl zB8sduCps%V0$Vg(@hkHOHpHdPJ&XvvtacRWqvHYcgCDuCvM@e(eeP#}R72_2Lj8Kz zyG0$0gq63?f}z1kFyzWmdT}V7n1hk9CXxqgyEZb$Y|y^5x8*=x5QyDyJJPX6e*^g5 zXOk>D&EPft)3P33?LscBIZLDIQq$f=^*DLry@V&pX2i3R*-U!X%Bs!Hwg-`*zEAb$ zCNwjL>5}7`vkNi35z&OIpX$`Fc_O=gGndR!M}iZq!dnUgOuj`e=eM$VIM4nFDqbt7 z2ob#)jj_PeexqFLFgCWCgYd#9bgixW2K<0tqeLzS|J={dh-t!a(fihHqz_Gdc#k=@o2>Uo>mOTv%Wl*BhukOFH}*e z?$6G3%>c35Oa=b)@3XFCsfn;79egTB4#rc{%;03gIwVCI}kA!{kA|p!&oCCV+M17`Sz#__6E0VH}E3|Bk-z6NnMBJ=r8gCw1nk9bx zGBw@LqM!*&BPJ!A2oB5Ee)7z9Edm=(l#jB1UGOH1-4o^AKkgyy6KK-;CuC}_ znx4seERzAf5R+16pMxbv}maundjvTVhfBmST@JBNkYghSrZD)h&Y-jWk^HA`7=i&@NuVF?#~N zhs1A?vARu2>*PRBi|%@n8L2r3eKXh2JE@cCb z3|vTXo}TeWcgbm9(qP((bm@fGw?cWP;v`j9TEMvpxUDaC_Jl{p+FwfIof3TnQr=zx ztMAiAI##4^d9|GsNM%vbmg}I*`z^NIlrEmV9`FCKEC7ig%K1l-Ce? z6D@&PZiw2ZzFS|onCPs(oh+rn-Zj1FCgRZvfEwp=`*NvGzQ>+NJ^JVpEgHUYnaK*n zrj)ww4$Z=cJFYIbZ<#5;1FPjC3%U^)1r3&Tq}jE(M>PkA+U9jy2RsiYvb?%(nQmr$ zykFgKZost!=JEI0)97pp7q#gc8M~d$L&<7QlJna===<r!h*pLElt+f(2S(-};>VBMbJ5u6 zX$O<0zVl!;J7VzpWZqd;645`4h6GAQRG9hISkZ%nqYd9@W(HYZ27@mq*w?SNIImtF zc-{w@dpKwsA-)+&_1z=cqkHN#u0u6MXY)1(I2aquV&>aE66H$+uNx(fVHbUq^wW>- zDX*W{9QeDJVz3qucP3`F4~UM5g0qYAcYjRTiyq|d%Gsmw-~NnF?|`WUJM$Zfo&wyR z9wYKN`g4vv=Y(U-IqTSt=?@N6c`Fv;_kDyJ3%|ySQD%apnV3Wk&vJBX3KvMwfLY5sZev!`DAh&6wI2!tJ^O*yBHp5bv{IQ z##?ELFRL*7z-*H~CBudP$McvfxD|io<0!Fe`?fw~<6$zPeF&CHS<^eA%Bf$4nS^9?vQ6c2%CxW{npx~IT$--S3%=HC_gyf z{G@ZPq_ToysgOHt2aVM$9++$pjFe_NCWvW)SE98IFl86f4(ee{TrPI)^#b~;h^Ds; zjz2NnPd(blEUQgi;!L~~#9L-=F_G%b7}hM}&?>EL(*5cmG`J5AzgTa{jkgP5TnQg1 zcFC6bqSZW58*SAIoP7<;5Sq@d^gG!Xc>`KqphOQNyo2!L`F~3vQg9!EJm89VW;xw< z_+VwOe@VvBactj#09R0fSj-<&r1UIKFRPPS8zbI!_I~+O6IqXeKGV8nzxD7!$tScZ zdP&wSFA%IXDil|qZ&?Os|3e9o>mqTU^|K=PK@SGYiCU0BPU;7xLrSm8&V2CB26XWR zT7P;tq?@$bDmU%gq?QcUqp_Le@66&nzX)x)|GSGtyue zSXG#6s5RC|pg1U<{xo@cv{J)(HO-*8N-+y%9!UmGWxg;rw{W{&x+sW{>+z;X(@32Z zHkvXC!78zTAwsE{>v=K(WJciGg?^$)Rmjnpkd==klsX31@jC2+T6Np8=4-uBLrUoF ztU|p&Q+eB>KF?sv==;_zIo?yNlY>Q=;KJJ00e#;eRstEVri3W|e9)Uw40q?L_vnhe0V=VE4#;3koTw$IP z7tD7&lyVlCJn!$D^v2u8ZvM_>?QQUmvpc5RWwKOWTEvUE$Xp~(!>d6&XBzdzEYHO} zahP;GFk`EMVIH#yFmB%Hnr+gEV1^yVQ-TasgVpwNPeE^%Ps;UPn`oIeO+otR9d<(e zy_pXNlZuG5j7Nw@9ePM3PM;Dgn&qHTcK^cq?TQ|vD%0ncGvTm(V2Z(33cwmiH`)B7JJ=5M`}sQ80&+xmwit^uz91CZ>@qrS|6VzNQwl z3E6vG@^h@ExL>QHpUZ>hyFn6m2jIuGXz$m%N;gvKC^e$Sgwi+-k^?B&1XxPpxUOj^ zocfc@i^V;1QSZvK6iux)Y?{z`eZ!gX_8rMT(vLcvNiJ=!Rwiww`FhFL#zHt${@O6x zb7$>tbCF%|97_C5sO50i^cR6#^2+$|5%x&lbE`CK(zyEtI_|`@!y5wYQp)8GdqJzd z&tFX}yZP!%cxiZ{A12T_473^+)Tpgof|3U4O$1nOn=blOZ@#82L?B z{IM>(o^tn~aUNJ!^IB zq4jY?b4)7fn|9wGk1lqEz|A6g#>4@xDX|ubL3SMKQ*Y?(Znn#KoXI(6<_(|F^_YYQ z;$f+?MjMm)qCQ6*Z7SUKop#Il7|k!=%VB0_6J3Q9$fL~ucp2j%QBTi$j;eswh9Oqt zXrgvX@A~XL85SOI{b-8-4H3R^rN^#dgQp>t``(uKHF&(~1wD`j`7-{QQggq!B+qO3 zq^jeZVV}r?{b#vjWtPI#9_E`Yoc($0>-Q!=0v_;hgKws8W7!ULI&Yrg(dgd`)pwrq z>G#I{P%Q={R1RpjSf;8wr>~Sqq%4!bx+5=EPMIr-`|8xWpdCsHYw@h~qOL2_Ud}3w zK8g*7nfrBZsWgL=HI4Ts%4_6_=zUy9PypDnZgca_Bj*BZLHhDjMy}>zay82|snvO# zfj|2jO$zVr@|CkUuj51O$ zxN3_~yXtCXcZVb+u%LDsv1am$dg-XgmS+h9_^iQodlgkR{OTvRh^ zm&PBIQ@7Q#NupZyFgmt?$`V;ov_duA^jw8Ki@1Zg?^~dI%|qLZpvHydeSIt`{YrMB zzj!-fi4Zdvg1k5q$2!tto#VX$!!XvFg`ITzqUAl#`wq0EdFp?JoH0|t7dlUG@xu>R zARganKGFU*%h$kx6e47o3;!yktvO$l`)S5w#m$EX=z(K1!eAw1k?g)xIMif0qJ8Gd z)Qg!TRp*eZu~fu-oMiW7r!b4#hK0rrV6FVi+oh9XzG#XEhte>+st*gjV9UfZ9u{TS zM98^Mi{adi&t3F{+yYM8rUg^wR6xjRfoB>OK0@!4(btRD#me^AZhAJMh7y#ox!I7~ zjOxp)f#Vu<^M1nk^rca&so$IG9cm3D*(@0pj*7;Gg4x>>f*6=itP*Wfl2^RveyllR zQ4=;5TX{ff0T6At~t@^N#%pg$F*}~mmcz# zQfePYkPpl?cacK8Ei}Q2>XWDQFM~_;7{|W0E^;-j!|OK>mz!M>>si&5_?o>>UjgJ_ zk^8k0l3W;{1ATNYs?}L4ZyfYTy6h zB-w-{xmR&#`e2qVmjwOv1uRHcv^gsIp%U8)X>m}U?cJ8*bQb-!tMXsjQxySV8=hkc z?B$=^@TAWnL? znTN{#x_~_g+;Aqv48!V`8EYYu5_&AYS3Tf)(W$|$JfZiy!DnfKz()K0yutzN`eFt8 z#ZQt`p!NJu(=z^ZGTjL&iS3(w(p?9=uQqHVnB?N=ACj zzy7jeX5!1o=B)At1r3N*okH*1?);pb1`E6FTQx%?$q{6$LQYe8jS{IAq|8C}fxgt9 zKD+q7n_>=D4r~&@F%cQKV};fp8!>DUVvayM@HJHsLwmaI;E&fAnPSwUyK`GTVdc7n zC!Y@t-6VFPgVrLtG{sYILf)!mjyd^PL@BV8l7noU)wnTMR{|kX=!9)J&Ub3$&}V8S zz!bD6o1@4ye$1U}n-z-g8e9YAhkbv@N&LJbeu!tmNztQVEuW%e~nTf(}?x&w^ z+^}*&{xf^jlMGxNMI(Ij74TKuPBwRRmHW6vyKiW+HSrAeB~lEC$5v(M_B!&bJS$&5 zKN(-Q?{pA<{2VlpA^f>7DLIJeegk^S#65Dp2wl522ki|Fr7@1(jBZ5|hTj6dmQ^`T5A||m`njX*HlwYR zOMGOyzD|_IW1Eo0Laj!1rLA&LkL$KQk=}Xy)JfXGv2z?TuAXE0{#fKH6@x;+ss*UcLvwxU)O^hloQfD*`+-n z#I|y?1~(8#I^M7K+JD=P#eFk&o*~p6%~6sJU^5J|@5{`*%8xb+PmCZu*TTcOv#Y0? zQb-*B57PC=a_D4_%{%c0yg7?1G-mR+W+zCZapj%OOqsQwL-wk4#Wbr=Id*@q4 z2!}4{?! zeGD#9U1OZe;4f3QoGz+tu=wc1-~3U!T6ukqdK4~Gwgd7Vv`G~Yj<1pQ?-_Hdwmadp zwCBio-CEn4ia8d$T5j$1rE+XU1|O4&JR zm&pvomp_9Jc`pZ<`lL}v<=WNwqJS=@0+tDdZ^hXXI(n+@PdZdYAbd(E+>0$!p@ktbl)_jn<_2WPMU^-i1<6&|xEo|?o{?>Psl9=iA2 z6XXM)KqN9r=TA>?j{TA~dufL@EquGYeblRxuE=6mBSmjX`8$GyH*XG>tp8SM!s zWGO!`{pMl*oy^HRe`#gkRcV#xH+%&OXWyI~J30b2p4`KZ<%fIi3$5F4s_8HlUH9fs zK*yGO`1C}c%z5YYi^NrXX=#NnmsKtAnBRBNTordu_hppg9Q*LJ<#5LEI>%`qltq(pP+3+Hv|>a8E2(CU6JGnd@s4M^E2bhPJ%r)Hqrt|&uo>K^ zxH8l0n=Su&=1(`xX)^f6bqCO&D=_vKZI?ou99ji3o7O*Z9CrHmp_Dw%gj(J0?S>I1 zx|?FGMW$b3&2AFi_CqrylL>1tF+WcK?ahG@tt5Hw(u#fOtx>hVN$Tmj8aS>cXn_qI zTSk3{W=Nf*cqqy~;oHg7SC1r@tvN=yhP5l}_PA(d*kIs)y!(r`=VWI=o#%hb{B0mp z_MyE2rkySrWAXZBK0(3Qo%mvX3Ao0y{#5R2o)m{rrM0F8La6V~W?A&pw{FnKUY)Jw zDc%kRTcC_TH(~tI{;v%J-2Q~g0QBnjI`l8h_qT8JT&Kz8*{FFe|1X=X{_A$znSgPT zx)NFcW?cXILclnC4__z^s)eZ=|0dUeQ##1(u634lQI2rMrPGh1lN$YRWe;bax#VpD?ND!NrM3Z!Lh z!125{w>3T|U(>+TdEjsH^e>04qzbrS`?2T4CRf;p77p1{fw0pvb`ct-Bx2W|J4|(H zB^v$S|F3GpzpQ6Z69^X83#s&Qjv?e*8`gTA%PaX2X-Xmz<&%C!WN=p|&x1c}g#P*& z`z7FaBFPsIM~#3_w@4l?Ce^HzG#joV&1jc8Xp)l1v}(r5KMnX9h$m6pohLQ)>_eK< z**)D6bSwGKzMaGCFQmCSa1SBt=n7l^cjP!l_6Z0bPkSmA-N?`3NBkT`t8C7Kif>4g z!N(e&O`D#_SGj#&{il9CN`e3qF%jL+H3vRxSkm6PUJtc$j)?y6D+18;zgql%YN)A| z5wrXLY;n4SLa|EL6w1}r&$^s4qP+6 z3v~Bgq9X@I>84;5#B`s%s~Uv_J}a>xjD6BWq}NBMw80^e?9$X?8FA8U4BtRLNacX6Y{a|fUejEFUYf^#LCt6BjFck|0NKTO z=3V=zX=HnieTb=l8$tUYB3*(06 zVmiQ;g|qT6k?;71s5auK#6%Ky9Z}6c+)a-Nx)Js}$CR1zvuubvQ^Om`=YU(f$flGQ z^OrmS^INPqa4}EME9d9s>jqh<=MR%Z4#)GvefvL-E-mmHcV86Zynugmb?NPf;s~d% zLhF52`NTv`tt0hitt4F$C%i%bk-i${xNof$~ z%Fe+V12k#Ye}26WeyYH46`W)kaumduCU2Q1#V#GFGBW3-Bm+Bvj*&Lre86fFsIE+x zJEwXP)bbZg4Y*rd?KXhiG8Ym#iEjRt*iaYe*nQ>e})P&0Ot3jeQ>N?*C(rf=VkRGnrgYbrNiW9 za22U6%xgBrDgk3QmdH3Ck;zLnPr=~o|Q9V7RT~j{O+djQIMDb%G4|QC< zFwo+%5ln#?AZ1$W8?A0pJw$FIm!5pSvsKbwA%IQhrVY`b=?S(qqI;ihc?Q+=kO7gi zPMb_4w?21RxpDH@jkClfejjCdGarZ1c<Zf*Qo z1xO0A9JK$`_m)YNz~nGz{oK!tqno|=QY`!s6rioZgGDKk zv7Q`~gc^ei_4&ia;a29Pm{yO7hD@Xy#q%w0BdZ{otJ!LoPgDKs>x>{QatqmBffP33 zFjtV2*b5@^mJjVhH|sJ=l;kbrr;-m+!2ve)GYD?uxgfrq<~w#7Fo zb$jqs$~KR&yU{z#X&znj(>0Wt39AByUqdfMC`_>9kc@WjZvyO>jO~VLCp1FA z-fsh>cbu>^)K^9P&wS}Nj#S_sVsh?a{U`I^030lGz;kfLDu!>U1f@{}p?;hbefDX8 z5(Wu(P<>?)Y!;0g;t`tVq&Glv@vq}IEQP#AHwSxi>8@R%ZRE6K-Z4A_&uryzsF1c? zZVYz>p-b>Bar=|O)`&;Ko=98<&IcK@MS{+F-#W^(KI$X)@+Le{kI}K-FXDYr&6Qg# zGBhr9db4nGSzYg5`O3wN@8<8=g{B%i=2n6koROksmuGgqKU!H~wcm6co;>2$s9{0( z$`M~&-+XTU{^(#tF~sDV(N(pr<^AjA`iv`ORwCH_U6t$?!a7;TrK8@$c%4C~;|phR zRuUhty064%tn#Wm`Pzk>JqUPwEMdCS{kYv(c2%C;7ipw!pv6^|HX2)Y_qrELQm*D; z0)=kQheSVVR7{IepQ^M-LnwMft*$3=?a3KRt5J;>SQFPsp@IFfZl-Wx*r*3h#+{DO zent=#2E{5#L%vn!>#?xl!<*agVGmb*_&^@DIt$XzDTt6WF=(Dc_w(chTPKdz=kYnk zm47Dp{vIHh0H|8!IVRRJXnP)?S7B}yXl}ebqQt*k5c=4AQ?_dN)1xnGVo6J_D~8E1 zDRRd5-NuMxFB6mcWu;en=-<5ne$abiG@u_xyk}0JvVe^v)+evX-}a_;baGBe%RTKh z!6L@5VP_SXd1TiqCW`ftC{16hYc>zbxi`BB%PO~K=)sX%#IGJu!z!1PjD4rH2Sb}k zq2|JgF~&47%`=te?qF5PX6m5|qt$v(mBtOo;p-z$4Bh@X)nTL-8>r_avB#1PMxRkP zibmkVuh|o9zsflwA~MKF-J{ZbNvE3ahd}#4%`gz z;vGl4YwG-G;HELINxf_8?d1gQ)XioQxWJwqem=nr?&n_#>fiPEfSAyfHVQqJucsF! z{yelFc{(UPTP#4S>o-zSul|KEJ9A?ovn;6|8*;~oZ!q`Apv&vM{2@lju}uHc*1UL% z-;RA)@C@~G6ufN2YcASrTaoji zdMCkagtTv-iVt;$#(O(vU2__NY^xNLewaDEHSzK|@Xw5OD$$`nPwuyRwK(OA71te~ zyh|&Aw*!DPy#E*2i5>q1@Z^tDC-?7=gWmYq_&Z_gCQHwWPZc53&L&?S?EPZaLIij(hD)SZk<1ztC&s)P!d)X1Z9&d0$5Q zpmalqI8}tXK-)w%;z#tFBvlV(_qZC5De0bR+KpsOoSJ4kXE}Db^7e2^-oN|;1t?Sv z<@9Cd3Yv?P6{5fFj(A8$sxe}msT8i#s9IGCJgk^dJ)56B+Behk_~XDu@&YK6_$5m= zI`#+}S_RG_D*f%>yB+=(YLwWKzh>JJ6Z@5BMb=QOtb1pgJ(@!;?P@>hP&M8|1xC@e zq^<_9w~YI6RygkYrSb+vU2OD2?4*^3+%lxQ?q=aNAgAePEzN6kjM8t`9oX|Hj{3%d zNhivtVxwjAI2cFJRDU;a%ys+%!aBluJ8+I=-E)9BZgd&O-P$5JRuEC|ym+iQb!9g> zj##TK8N4ZHYRVwfF8~S95e91r2-v#X1jk&?>Iz7&PFE6v4Xju*8D#OEcADEs#M4+Q z6#ArH?Mo9TFU;VVVY2%+aoll6A2;d9F?+#uuUD1NuMj-uBu$$c7{^Qt_TNi*3zj(5 z@|pS+m%s?8z;`@ha4pSCzXT8Qw4f(3a#=kFumnNe(Z*&y^#4YDSFVavFd!8yh> zrD6rHj!3Bge4batw9!zZra_-UyLweI%J*09V>^ zB8Oy8odsD%;{)UXkpD@+r?pbAv&Ez9?j9%9-8I_dY(Juq;mU-3nI9+iBMADShl6hTR&z?dkF0!`-E6-R_NX_gh8dE%zs)H2s=8 z!n#gg7b}NF6BJ&bLv7@v;UXHNx{zDcwA9uT4qpdDEKu|28wDk0UPoJy1fT>2<2zMC zXZ{J+iZe_-$&Y$@&wO-Ng}HM|5u>ttct=Q;kjKY5{K1TZ)Dgl&gsn6H;t$k&ML zhN%_NMGJBCZs)c28uuf_m@TOr{}?y2~7NlP>tXHGNO# zJx>nmB=`>K2ku8TS$%)<N>wYp zmiwCj9`+9W^s1Y4>{b|M-a5f;FqVnX6{4X7_-LcWhPT-J|7#AOl;*zvG7F9`1|e8OUyb+74{~}8h2N9gwDoo zGRm2_!kMV`k;oGm*4?nWqj+g1#%_D*7G-9v^ySm$Or zp+;r&rpU&$Ug6>qaXoMM>rv)L!F3D*Hl7TiAR$QT#-k*cD=QF-XN0}(bUVuM@oexwfP!g%sbRKNc znhFy_omx#IWD~YCj+@-4H=BS{3fsdv*d9vg=Wo8|Edzf*K4OW*hqt+!R0%7 zvjqO0QVI3o^AhULieiW=dnn6co?^rE`JwvA%^s0Nbc&?L<}7UOYvmbb-49-3cI{mM z2(f>yFt>gVcB5nbv!wE#3dT9fa=om#({ALuY-Pi%9cf4K*s(_@iBWV_VPDMv2U;g) zUVOiy3iZR0`A_xRMlMz<()T1sQ5G&Iy6^WKw8`LWM2X3H_<8> z6X6%m%6$nDEk48)EkzH?=1@;jv!%kL<2xO!ZhnPBixKJ!$3J9-xrOhWV^2$i_W7M& zOX8N-2sziAyDaXwVJ8MZwx4z0;6dzm<3| zbr0i!2FV;H5ywhpeh&+7d!%kc2f26t^C|Hj&y=rJtX!8r-hF36`RL5IdWjd&bwM!9 zW-jPqmK47v`k#`S^Y?$HFlj!{HH)J|Vcjj27w$UA1MWRg&#x<#hW66~=YOr9hfd~Y zJFMA47<=cL2<=eou~i8SjaCJpS@iDL`{Z8jN1?iNT&Q%abiZoMtD~Qmaa1}i8O@cs z>g7!fKI`xYW}R$NsFmZ}ukBk8w47Eq z(@FzSVFIplsx``$^{17)UKVB&zU@idmDN!h}1j1)grz2tqKf5 z3du?yOLG~#=?W`4c{k+par5+0cbsUt`{*oZ!K{z}G%9&2*sH5mEm=|p@7r+OZQw=~ zrYkVJSS7dAUup+2Fno$2Xu9|l-SS<%(Y~Ud@I40G@>ALJ{_~-9KB-Pmo)uFKGWku- zNw?O-edEZNV(V6tu>P#2Lr3mq$dlL54@QWH;3EpJy*Y0(H*Zg5%CP`I>pT* zRJbyh6tC(I@vg*mezWl(+V%2RmRaQP_J;jCGjq3BV1qGA=_8rE%V-Uo9QUZmxyRj; z2mntl_9HtB$1-*{dF^)B3^tcSwZrPV2Fv0PwyO+@y)}ZUF^b)l^drzK;Dcvn*QFJei|2L! z+OzmqY^eH`v2lr1@Rn7e3$@QTkxTQ**%hyLZ&v>j zGXGYPvQE=e_LU9A22C@zV_j)KQYRh#`*G3r_QQNH`&)OTOHZgW{k*gMXQwk`bBSdM z3&4R}7gFnV+!R9)S2OLTQXagc7*NZ)c2NHPpK2bI{C+_<;+}&YmX~u#tVqH*Lxc#k zWVM;#rT(h(&^xC4U9VU1t#<*9nk6`Q+KPc{t}cd^H#0|#F}>GxSuE5%w&RBdw(wsZ zN8P(pHN2O;$mC;svkgELAVKP@e7&^V+-n=#N4iyH^0G^3)`7*mZgjBFpnWIX<&|)- z)=;$}C5TgCagj86i#zE%%f`1#qr&lvkKfSGHRv&%Sk}yI7p}<-^9P?6G7%C=%$R=) z4#SKpiLA+lv?EmvD;f`D5Vx8KEY}sH_9X&08O^h);fG_pjKKoBKAE9S~ zwBBW zTVXS<7JAUIRZLyQVK`;pay5}UxcETEbT4;3FJS87a{w+XS5f|>IQ9Sv;b(Aw1U0!T z!wQrGT%LL@qv_L9TeDXe(eGWc@xMsq(ll}bPSnc}7Ur*}ZQY}@#vaX(@2nckeyQfP z8uPvz98_g)b&{i_BJ=INBf@rloq2MPScoJS>nx$0oj5BqwP>u1;1?pfga^5w%-^~5 zk#m;#AcT7;>ZZw z1@^!sm65|ObFUwRgAb8ZKf_9HN^x)aTp9g$_9URk;%htfS#|x1kP~E2Vc6C8f%zmo zswZ!B+^;E()irje_rj`+3_G*}aZ}q|*&v$-q)!HakbjrvA8f4+3z%96n+@Bph$R5s zMxNQH07-bUjaBBA{DQ9;67<03;zvsv{}ixOZvg@OO>Xj%8_y7O$K%CK|4b#3o~*FK z|K|SzUhuyq4*%b(I4aoArlqB2xEmT79c0VmPXoq#owF_2{oHxkOG<5OWHSr@E+Gu! z0}|ax8-jn~IsB14VqsPms0Mj`WhK8$VtPO$E5(gV2Xf5b7O50+UF874nLp1q41O8? zE^+o!x6kP<&s2q%H9%tb2tc10BHgYH38+oHTXf|cH*lBv|Ce{s!JX7fOlY{d<@yku z?`tCMCo=X$UA$~&jIOMFS^EBk?gCJYb4jqh^E^;B@T0N;m}H)T0d%1?SLg3%)i5(K zhMyu+zdEmw@<2-m`0B*lCNI1h@rvSC$)^qQ&o<0*H`0}IU5`2#C-KW|rhn`yuw*49 zS{~N-veeJ;n=?fqENYMVO(BD3scc**E+BE#1^c50NEj`99{*!?+bjpT)f){@X0lZ- zKs>8r3^hP>*5_&q7M3W_02-!_+)I| zI-?k{(h_BVyh$==&=yGPO2aHRuOqmoDXc#pEP^J3W_K#RcYa|EK(`_Hdhv95$3TIL zF7O_5ELOmAjEd);XW}|Ofgs0SrKA%`4P8#Bj`nrR)EKFLUz>Xv7tio#_a56;!9ZUy)~Q66weRVCvlrluipZ1!ju$Uz zf0f_fetl&kysONsKg~RU!bvG<1{c*Yx{g92CBh6mRH^VS>lcs_{uhe@9Z;Oj56rH7P;z}MA!JS$pXFili)Qv`1J8gZI7y@qDMk? z2%6Khb&0Y{PUEK~syw>tpi5haYI$7-#AKr8(J(yk3y7Tkm&mi)bBfQg-+l_%4;Rk@ zH6REZvKfr1Ynvl*IP<%QfU&)9xO@GV@9+m6z>}BQNzNqk!CdTm-Hk+XZ`J=Z!P@&fN2af;Y*{q~0H zsnc`6wA=q^gbvUyCm?|f7k-iDq2fRtjAm|o_qzh0o&yFHGR%wxFVmi7!i&&e-qV`X-TS zQ6NT~-2zht0mgmbl&A3jlsEkEGpkR)d!W3=Q&Eom#Fs$w<3^D!O^&=>XMksPzSMEY z*?nr%kaoZMUOY7b;~xrWw$U-Evh!o%xl^!o9$#36`+J}doREreL_u$L_H>?*TEh*j zULThPuxIcZ@f#q?H|TD;N>pqR*%zT`L@VTct5V{K&-!UW(E85_yM?Nw_`|Cc<#?f! zK)+$PU1yLFWqP@NRnBl@Eh&oLzp)D@Rdq9UK3q%`q%%F*p2&0YvoF*Z_}czw+wU)w zo5vM5;|Empzq12YZ7;4{l_@0V01^)nWcvOWWW>$ZfRPk^@aqp1$S~vaNfKCpMCOn) z>`BvofBoC=OQPUI$XRh0U=YP>=;tU)ns@VtJeBi%!UEe{nC>HeTi61#=ft;*oNsT9 z?;cp)ZxZwKmlODE5ucqL&NBuQLJKkg3@`x?QfRTR0z99@GY0Hx?11g`U-h0b(C>=~ zh>N2NaQN#3hflGv)Ajw$lH5stGFadPjr*Z{#o)QqC1`N3qKmWTXsNYswX9l6uZZaC zR-kT`@A}XE4~|g}Lh@%S=R4+ZcKLTgp4_A_k??R<$kSfnMFAEni{X|#xU*V#3Vh91 z03zm}e4md&q?(m$=*gvjzbQ4vv(IBun-m-0f(<>IJ zi?SyEoe6LN=U#&kveF>{+6IyTAu|qkz1$H+5CxRDeg3i}0F{z*Vf!CF5R}9)+~UvA zcgFdUa8AO3V-XaxoZoJr&!&u_!weuY>dY4hDZSg)LzzNWW){P5zvTwE-h09uKQQ+W zJ_8u(gZ3xWgb!XDc6#~dMP<-0rBDQAGcRb3kOyhJ#}{z z`#E+25wMZgVqoY8xzD6)ifiB{mS1qlG*0*pMZ3h*a$v0%reDN=9&qa!)l1@0t*QZ`ACLw3$B8!qerYiEdr2;;73BFtQXhZ7ab(Z{ z*}8zGjM9JYpg>AMi=uC(+W?JnA_KNsw2BM}G5W=|K<;bWMc@%jfk!N;tHB49C{F?? zvEdy$aTxGqlnI#6){j}JOo98y1hBbTp{onhP$yhKW~?+SVz_@)pFb2hx*!GwEC;li zJbGhNOTLS{ns#wFpcGXVYZA}57j=dF>-E~nD(C}w4xVCVn=~+l^1TjGjC-3e?h^N> zC=sEIg*72&4WWN*yKoWx%-#C7h&n@Goi@cf;zOk7wDaN{onR}i zsf{v|_grc&pE{ISGcEARCRpO^0S7LDR0qU9qyNsuQ8EM3$-0LFu7CtIzyge>utdn@ zUWC2|;_=`!ityQ2P#7+W*LWJdqeUoO_7BKkpK|}fxVXUd;jfM_6nClmV}*HHV%NfF z|8>>GJh&>-j_`;;Xj{pPk3~&%ju17{_e$8kzNW6OVbneiIetpE=>lhksOaMDD}&G% z2xYhcT!?jtftx#lj4OyOs5dMXQ2QAmf4b#lu4i=hKl3C@=(o>`yO(I3&*mO&pjG>c zc0UxXAgnu%7OJ-=A9~NJ;M@} zx+%Co`!oC^_mV59i4-DI4|$`cAYpRL&D_JfN>ua)(Ze5rry8Iu{DF}kz>$#xviXMi zAq~(y8b07J&4Jyt&&mf560uX!V-47ZE+3U9Wk(sToj ztEP+Rqqtkk+-Oui-Sb-)Z>A6oHxx!_RK2umQyvh|pXUy6ul+j_a+6wf>$^@wOM%U1 z4CG_0{Qw6B>W6?W+?WuTt7 zpQO)|I^;dGIG?6=X`*0Wr9*3y?P%g7!yiSIB0WY0XTM^?N zMY8%!U>WEYOnbz9+j07ZPXQmsEX*%S` ztQB;o{&>@KuDl`9O+q^(i`P~|kcZjc84w>p$D{^iBL#@hp8q{J+DoKFCP1TQSy``v zD5MP7RwgFu&~vb*2C^+`ao-s6qHgxbKs5&v5Py5DCs~~Zrr+)DT~U1nD7+)zF-@j( zxx}==9?MyTOR_^gJKE0$UckHG7Rk$6j_eWrIiS{HuEN!2dO*2im~@0u2l{1*3GL9d zR#o@iyMC{$3y1atQ;^<_kp-2td1taL@b|ZT-|vW&S-)c}3(ceHFw~Ltck*^o(itY7 zQ+*N_L<3SY$XFgL0B7`H>q2RACkcaTHOmI+p?U(g9B39GUj}}Ha4Urj-kK!fJKtq2oy;(2K z$q7cgxa#%g@oV?s?yMJQ8yhMKcb+_6EV*LaJ^ehI*gy^{O?p^=r*Bs2^ zm{}areNIgE5&GNu=qg0Ao_lNZO+ZYxiggzSeq;cYwaZQ1@O7 z+sAcaUhWms#X-b*nsU;>dy1Si`%O5D@zda=e$N}jEwl@}pIXZcj8PY+u{y^$AL|t* zF|H~FIX_5)OCPV4y0YF@(hKK@CK+Z_cz`-{yP zPcz*S&-EY(&O5>6>OXJ+EBM+k_pTdNc;+XTppJo9q^?}mIo!p1sej88;1j8P=GAZG z0bH^mShn_k+idF~dVX$pKwIl{LtZ%IX4F8Aq4HU9`gsWv9zf_;T8N>k*IGGZ@Ky>^ zvaPwUPzB>wI@L1rvvz~^)md~7e{WH|tmt(bjS;D!KL6!y1bN%2*0)&MHhATwA8kSG zy!9|Vc4gLB6tNCxAW-N8_LhvyMA-gKZ6%hbYt#RvUjCT846Ga6Gw?#k{R}y4ocz%yWKrd-ps;XOZq16u#Q79Do*uU9LMCDY=SyE?- z*Hp$F(*HCL-rI@i-cy-P8b!tV446a3J(=6b8*K@V4*6%+xJSau$~Gf@n7OzsbSh7E z4=|0he2rN^Al5J-C_qj(7Q`%9VRYEnGx)O!HL0(0i;Rqbd-)qR<8hoBmHFoEu*;JP znjDi0QL%S=DMR{|mt)2h1j)B-dwF$^bn;&wyoQ11C`4u`#A*N>d85+$#}8s*J|A!m z1`77=KJ{V{D&-2gTf7I|zvmm8iy(jx^N+)TD$;~j-%sybP*k?h8>g|6Ok+PS?w=8a zTA}N$q*VPdk@LyL=O>@$?Yvh_YQR>-*Dp!&hI7w&NYSv)VW4=?2@Vx;rIhNBwZRo- z&+E+k!x+Gs<0KzulaqAp9be|cat2tJ*yRaj=NhVY2=1FA{a%3u!!#3Q9g~og3H9b0 zGNWClrnQhhr*7(hvHejNQ6-S$=4xiFUSY##;Xfk%DrOz$k6Nhjb<68RyrJjh=qC^l z{@1V%r0*6PwnbF*0U9qpKn~PNq9K^99IE=@_RwT{gmag$$ZH7Mi;D#%#r*JsC4PiH z9=YraxJ&!*?H4y&=TY0YoL^mE$RD4skIzqRkY?)YGx}+k$g6hRI{a8L>d)m>LAM#g z3lMQ&gu4-~c_Gn@cmHIp7!}GhPlY)SrwB_7@lqY<3C47;*d=s z%FJ-Zg+wc3rUT)zV2Qebzg53j-7BGkXxmqOISE^FB`@_y`1+YrEV^AqvZQ6Zqb_)Ap8#9lqOss+D4yj;qy$%#g zPV?zgE>M8q_<8PcBed*@p=Qy>0Rkdmt zf9NXzjn;ku(}C(j9S7)yaANL}cfV9k+L@cgUqMx-+vhcx_da_NuFV=m9ofL+hNsOO zLz}p!wyM6_nP<0ZJABeDBZ%@oj%m`bnJy;y-iN}>TS%6qddHG(^uZ%Bi?jJ>#xVS7 z=#up%!wbiwFXT3=%hyug1eVL~#AY^wF9oen2ZX_AQ}#XG zb@FW|DGF!zd=64A=a&LCIJ)E=@v{340*b#&U8K}%m&oUx= zY{{?wj98rvU3J9{*our*oy_aBpfH(_nt3_WP-5;XzlOgb74+6clld&v7tdVNm+3Be z$*WX5t_kzrsln%xKgDr~xXF-CvvR1!x1o%SVRyu-BGRfU$0Sy#!;jBUZWQ{dUh(}r z3q$R3d@J#RzO_~~ius^w=D}wRM7ggIA&aI7O!T1dB3{tp>#l4sNMxETUxSc#^pSQ9 zcXwt{%4f*%d!M=WBT$bnxYMIZ+bj-jt+Yqb! zC{nLXH>^*4?%;(J;M_l9KO4H6+Ah$yKmyWPWJX^gnMExE79p4zU}1byBnmaizH)hR zU3$&iCtCEt03G$1K0)uq*_K$JZyZ0_+aGU&^rCf#MO|Ghs>(%eWbsqA8gqtqto+D- z<#$U}74f>sCY|JPHfoc1G3#NUOafUmH!|R%*m~TwQaeE4XjXC>J)r1tX#cgmzANO- z_2rk~RPs4){=d1LQs~=59-UZxFbFc|H(0BCgKtb$`UmY>jJ{^~-k-u4S2iF<1qU^J zgjMxAWGwRI1R%});kGy&V!^RcKl+EMk)@*^XXIyxomim`vUQ(9%QQJEG}eB*F0aNo zT+9b1I&T{qjeoQ|kxHSbM;B|8I)B9JdWE4;Ve%wy7&CtA`>iEU> z2{=2`Z;)aucD&n>(L6g(L5k$>AEo?YZ=MVNXb1mdGialPnyHYYGc`*Q{<>Me+sTn+ z?i!-)7-wzB0o7s?w7mL)I9F?wbWOd2enOSN`~ygPPAY)Ptt*b@0q8mc$$Q`R^U{Qb zCBRwliikG2gdwwtw>)9<{Ls-uy=Vk!y~^$LA9b%W*?T&Xv#;8l!@464K{-;A*q2G$ zq8OKz1tX#nfQk)}i$kTVat7P=YwRZ3aOE8Dyi}^oG<%p%3!JlCBgQp~Cu#hUf27^f zYkzr&U2r!v%o3G8^2xm>B2dcJ5umHvbU?O>LxI4O8ZElH$m~A`=V(wkD|jvU} ztr;6AGIjnl5YtEz-Rn!#*O`Ro8H2cotA~tAl`cpY4><-#R93CH)XLAB^QZ&RB^HK? zH>uM{rj3r20Apg=$^D6_@1ctMZLAYat)LE{RF=`p%icQYko}qt_zcyipiC9A@w@{# z8>esB{$+v+)Xq>_KeRq>*$LW`$rWoJ9e+b)F(<<{}Ho`o1?DgQcrSKBAsb;Vc6k=@lO! zX#|FRw^0Bg!7U!(utBZ?>i}*I^4}GcZE!@dzWouz-^380k=5A`+diX_!}XDg9|tSJ@N@ZPm)bSR7+%vLXEAvi>eiRLk9 zK-=7??auQR-Gz7y`4>zavV$FTQj8Xm7is{STcr691qJ~s9T)xgZ`~0jjA_R788|JzNrSz|OTIPiQqdrOTb+L! zEFG;nZ=hqBV(KSIX7=91tweqDID6^J`}=zdi+}pE*DMe{h~Om7;BNEwTx$}&!q|AR zMx9f}hR$nDZ#kdF-^*S#Wm4XI#NIr_D?WSv?hm&iO~JVtaxR1$k0BKLEEo+AE=Ayn zjl&6?Q>c_&wrk2(j(spERDWepyY%Es*$ouOG` z&!)KCcAXvhJ06q1`P)yg8XWw);-=NfD6ad4epV!1EOod!Wa!~+EmnfI9H~n9IL^tr zmg1o*h?=mg$c*_n1=a@N?Vmctz*C(jhm{fjS0kNrQS(kQ8%)MT?!(E{e#`wSb-ul{ z$Iy>0&F6v$mUzIZiSzUnxM=Lp3&1?yamaH6u~n9}Tf}9;vjg}M=Pl85%iMg6I)mxt zeyOnTW)tzp7W)|EwadSgf|c_sRpTe;c`W<6(@4)_vG=WnrS_lRxH6|3&~0LDDU4m% zo2OU^5Fc%*g6Rc_eWhKpLq!F~vuRji`7h|t-X5RFbckl;BfIs;EctO>qE=7~xl7+x z-YP+Em96&SifL2g%{tLL0V4WlT{@^+c5TT%JD*S@qd%KwHtq_3(&5>`B)w})thQS+ zV$3zzMRI*0i_T^?nD^j*|98yoJ)lTD%$-+{Ic9Lt`)2HmY&EAE3Y~YmS}0qaj+Z%+ zA%ekZ&i*D9dY-qO=}a?UiwRlYIP~N&RKx_dEile)XK=|}%mp1v^%cqm%{TZnBy_*} z_mTb0x{P5`t=4?@{8))eH0Um~+C|WDcZV;aEBHwoCBXaV{cL@)?-+G$Zj_cQvH@p? z>toJPxx3G9n|D)cHq_EvE1d248b&4*nF@W?pqnU&Lwb?25A8Tnkv)ULB?%ug^n zFSfcXBl2Llm0;>btFrZ{#iosnInqLiU1wzdu=uM8oF7~iw`M8!^T`~3K%hLtU+Qzr zE3f0NLz-0;^rshAm1XvzNDcP7wwP5xZ~Y!sA82B$-aN3hPS+X6s<1k+5&jO~tEg-& z|6wOKLilEWB&B^;Cd*V{PGFS~2dYy^=zC*+nATE-qeRKw z1k~l}CUX`c5H)#rU2Y#JPkjO7`9<;(37GR$0o}&GWI_hO)rzyg>EkrAb!B!r#*>L* ze?OR?6zoiQs-J6@h%BMf$sR7u^9N3r`UqlR9I zrXiLKq1_DkS3;%@hs$v{u*!&cORJ{XpCi%_hXpD^wiH$)Qz1*(Etc8!Ac)pMS#=sY z#y>pN>x1yesW3cymK>J83)A>Wv!hhg5IuBp|9Brv{N`wSuMPzh^?H&=K*HG&6sJ7NRIXs4Vm(iqO?@hvJq{1c zQl4M17v9f=ca6JtI6;5H5jxfdVU7jOuQ5EG9aQhg|0rCrBMOt%Id&QZ7)`HXs604o zwsiWqMBw9rrtJ-(dmhvXmLM*_9gmlyNM|=M;37ykW@)Z*fF7D-%9jyJV zjH!w6a_ie!Tlv}7#$3bg_H?qHI_vr=<95x24|y{`MGWtpOM=A>IU{lMKoH-9v2vK+ zxxm&A>8Bew#Bp<8e8*06nQYAdwxDX$+pX(@OmL_2kgv#Rgf5mzHkF%d^9f{A@SSDMtVHrQG&6O2C&?boq$6Ks)?`W_;iGtC2L!m~@e-G|P$_uG0qO(pX%Y^T!EBGgCn#=n2nK?q0z7A69km%=>Oq3*A{^-To1z9(TYFf)eQHjC~rT@^81D2cGocH3JR*g-)Y>vR8%;N&SDL*)vCnD<${$^Zc=@6Vt?WVvfY9NTtUYH|x zBonR}Z4mpNPVCG&@>}(o)Ovw8=%DuMQ$4R$_)=l}h3zu0q2ozNwlLk>jZMdBC~^Q7 zb4+%bKz8^)3Zz6@V7#vow!sYq{U%^E1T4<5dkaiFB!D(09*)5CqW1(zz}LT7bKm<* zG;@CzeDhF6Gi+eMd%5w!czSOkBB}VGtdFi*e_CH?sYu(u zF5Pg(ZKEb$Fp8(nH@m+1yMihLT{WDJD>v<=tCuhp&6#vvrcg%B;$}s}Ukfvbjf{fl z*RZn5ugCIBr}?WU9hVPG4eou}VIz_YV@`xjdUTV(9AS+skXL-$Gl(E5Tl7L_&$H%q zLGI&6a4JuAt;7=aB&HpnoXiGSZC-&w_#f7go-l~*J+&T{9r zV>b_&U?wb!Oi_I^AhQc?aQ0rVIiA!ki2~U=YI@9dw%!K)i4^~U^bhC#yO=Cs;y11j zw9N$Lv7Dt|gw_I0CXx!u!Zk(OzC5=A=~!xJd&?fx>iBtTgleAvRxqa*I|V?$?Nt9qoB1}T{AhR=Uw9mp0S~FPF9Y(lRw5JPpvuqaUZR`sQgl{tO*8nAg{&_U_S-s#JFeNnrIvRy3>p{=G(SN{7 zyKnJay8UXQuO0((J5Hu*&E!39#&oUCePTD7xfMRn~S&iI3@@v4eU7Xc-~He&jLw=4+qe>Ynng>w!`G9mQ!|F09;~#omts;`6y^gY#39kaHlXkWptU}e(?MgQU=%e=Zi z$!rbG^GfQzsigr%dcR^z!)&IGNR-{C0hs#d0N!506#*&}{eN0syEDtDE^ze< z195h4NcKO|zpjc+OEqtshrEuA&2e`#3!r;*GKIfW$vQTGiu5fu!gm^$59AZ3KsEVD4DwI1 z3JvjdkM9W1(@#C}SGVCNPoygja(7T~ezOy`_=5vfp{6)27|X%lf0e}+fb0bAn#Sf; zlA9jQ>nlMPw)Xe?OZm6LM$>9;&Y?+lRx4;(j}JU>31aV{8qbr^Gi*QLpJ3@R;L*#< zWhj>0FS^jne$%u&_f@^=eu0#caUy|*K{w510-Z5C+r!&B<9GIg8uP|kL)%b!h%=L3 zMGpSRZFCcP5%N^i$kgHBrK+}LXx0+gJ;nNHT>MM_o=gLS47?rL6tcbR%L!o-fM_;4`oC^)^d zlVF5-aPG;p=qq7oCB$;kQ2X(b1ZNlD?*vJ-dG}LuhY67pXv8^21<_I9zN0*mYSO=H zczKsWB^4c-U@c`v3nbXwc&u?U02$$#2N+$LnXr5Ie|7=Lf^o$u)dBbMA9)XOC7gil z@z;m7xujR(`n(mkb4?SG8{55NhVbj8e|5B`wAtv`*Csz)nhI%isd~w7L~Xqr7t4$W zx~+Q1V?fJ%cp_(PPOrrLS7m?Cuo%XqQ~j;DA<1Y7qDaA02RziEXUqb6Qm@!m>lCnO zuqmDtDc1IwtK!${IxVDe)Gu^~kgYN0rl&}}Pgfm~H}2}L5W49zEY=Q8h^=K>KNPdn z+8cUsbGT2XP9zLS%3zEhGCSGlfxEG+4^jkA!h! zoZdQNDjml9?8Dul)3>(pJO?}e)FCD^R@5QQBr`FVi3W}dSmZSVA(Fu-hq&9NRbE4- z`jd^MSCX*J!S$+HfrVC$hc+nZzjnSo>uYn&P@1NzDso$>97fl+w!sTg4g$zSOV$Ud zGT}~F?Zbw&Q39lsa7BvJ6q`L8m`oF_i1sxBPK(2{?*^Uofa#9@h?MJhZ_hmnIcI0$> zu*peJB#p+*GJ~9OhLqPm-DbfhBqg(jsmy) zoyIMsK*AWh8hxHz6}WwhD=)Mp!slped6EZbL*IIJWvfBE0)sWL!O?MTw=;R7ns9v9 zCe&O~BHw>rgq!6xsnhqydfi`tj4;%_NHK_5+z>_+xkj|kLqGYQj5gd^NZe3(lZ}-X z{et{C96RPSB!W)`H{_-W5T~fn5iX1ciqv6MnqUQLH zz=LRQ)g!haMN@<>*##%L>)regc$ml zrrBHf?CLJIP@kpmM~JVon0T-G?=qTjstar6=K|b+msc&YLYOH980P4jxoW%1OIy?w znHl!G(EBG(2HFMSeh%_>ri(*{j5|jjU0ZhAV3pI|1zTzaR=)c^c#N=5eK0?Pn;<2O zu*QBg%^v(M$@xZ*)uHMN=C%YF+Wg~u!VwsXd^2vo8G5xiQK?-}qTS`h zYM{nMR^54H)%@T9VY#`a&+xzh!nK$lRNA^@`4q2g&^U0j!fR3wonzD6ToX~NpuDYA zl$p+{yM*ACzd7v;NseFisyRUP2@qBXpG!QN75|lP4BfXW>He`!rm;+#K#xg^H>>E$ zq>6E(Dy<*us%Rg|0_JLqp)rhi+NOfik}Lq!pUrTkl2*{K&Q3KCWx+Nn0*931h`JgJ z%FnR`JF{rFhz5*}0nHZ-GZw8B{)rLGd&2yuV{M2)A(sTs)GsR?U?yBqAOi$Ko zDfl&=_PqWIx)a0oj_Y_(q46S^m=@Ymer>5HKMrO!+{P7DyLIoEu6z9*4Gx#9%zHo`4!sS1Ke6}J&C;MVWQa+pf@NYV)1d7(G@f*7VS(L23cOBa`Vk|Xfv4^?H4@WkdmRloPjK~K1 zPVkR$-t}%(a>sq%pr#kY?fNhD^QQmg@(k*8jrghbO(OJ>8dlg9Uw~6ccip~PMMoKYe#+j?g)=88m%{lF z&(L(Fi5m0Ih(3o*$=--^zUr()N&w;4dMX@7K#$+4g@FpL3&^R?=f8|o0HYkBt~+-) z`Hy=g_B<;l!8b^zM~Lz~tO{s4NW2z%%uDua+V!+tQ?Af`Na;!o(^N%sEY`M15<|iY zu(krpYDVMjqbryuu}?+Fwu*tKvzbhqSUT!#legELXPM0=U3EC8$#=ZMT6c+grRU=s zy#%zq7Ge2~2OWL-IQ*6xwH|Ryn2^YMYAMNz4k5!|SU&sX`+8nEhO1V0pm84l$uWuXp?!ItAxoZf;d@zrZGrX%rzKE>azL=rUq{h^=dt z$Z0RhCbRgFjqJ-SQlq^|7vNF8%UxQ(XNPgdBK@^lz&x+&Xzi0o% z%H0qng@Jz9X_MlAWHaqvWxs0j+q3A1bN8ZA2GX?H`P9;J-=vBNHFUIXCWVW+eSAka z^xg--DZn{cyDUqvkY!76p3`ZT0q2-JEr|F6(8c}x?x5lLLd9Gl)g=IksEQ}R0SO#= z(6fR_i40Ou5P%u%AgpVaW?S@%hH>xc4Xb=Y4;MrKcu3pija$?8zmK+UjpPrbd}H== z1zv-q2aVXZ*@|&ryebRG#1eyo!Y64|k)xrSDK=o0W!<95xF(bopL&k*vdUWQ6&fbT zj=tGfPsj%5mXpFu=oH7CO{)3XgT4L23+v9AFg-(HZ!G#-aT-`~x@;Ryx^jTLxR>*Ye zyC7p}kkFhG&5~`Wc3Y&`e?ZqJjhzA`x_DpW897+@MeU#kdpxw~ z+M08-*oEsT*jc{mgZSC4f3cd<1)=WltuCJt`|zzV+GkcmetkP0D>xITtspOkx3K0A zrT|;C(5)vK3q~oPu`W||8deU|R9hJGIWXTSgD7&y3;BEgcEm8C-1}@DzM7{!#V=v< z)eAkFV^mbHnL`co=vgLidqCTpRB3x@tc+t>q+AR;hmor=+tt7?Uu$15;HsX&Ibd^f9j$u1+1I93 zbI58t`X0G|?ljFOGZLCvZ!cjBVoQBTyg}#T0pVz5>J4sw%{+(f=?q)Q6iF<+P6V!f z;R=o4FF$%3JK&n*Gi=`oGPPjv=0(Ua;#NV!EE)~56T`71(Rl3cD&~%mq!L%OlSdEb zR(N`%Ego%1KuW@~UB)Nvn?3MdcAlN9G$yw9-VGThgN^;Qlg%`)zmF3;>o{EUIlk^} z9S`X88OFu8x6Klvp&^dd#%I#qQf7xK;0Ii3PmfCLBVz>6JCx##{P`{AC<~mR3x z6}Q;lUmMbO_9ZzX`@=}If{Dm{i3%<(VUm=R-Th?5XesR7p5kx#mrvJ!AIY(L`UT8y zQ2R{Ks%PJVMWBG@lbQt(bEw8u@EQ|Mvyp0 zHqUnoTq$25q_4YSetLllFyHV$<)tmIhffXBgr;F#k4v$W7l`>@K&&oW{`|#$PvW3h zcIuI9KKN?dTO(MSD4>9+N{6_gz_kKvkXP|KW#R%2H9^LtEM@t1(C zD3&Dp02}jZEAfPh%?8b=;-V7KU zD9HIz=l+nh-0O!}=-Xstxjb4j@hm3|LoNrz|7?o#lOLN5mpJm+FaLhrU5zo2 zcmY_RHWKAdaSZKVzYqfG=&*#rbWTp!>B;AV|Kh!wvD_ubK-uXn=f3LcRJ*joHZ2OJLfBC_+5)e)QNJ_ZoJqSSfcjM!@k&;gq zQWDvnj%Ur?Ylt*j^z}>i2ABM;4|vkP+Vjb0V~KcqB z?^EpSW8ZrB+3N%SQY>DbN2fAUMFi<1_Y8^3R^ym$4%NtPJy#}O7Rv#Y!6YDN@hio2|+riR_u+$b{@>z zQJDDM>xUR|BPs}Uq`LhAVdjAOQ6|Jc8{>Lu0SNew7!WZrT430J_J{}AWA=KOj`hn> zxf%RbANCF@ioheW{*}uF;lHkSmH8!457Sm}K*Cq_iNf+Vw5TWH&eNys8@oGdDe`PW zDTZ-9e5W%p{r}49KA$8n_=w^T&d|s@@mBXM#LGoHYRG<;7)nk{-2zN96#hQTt0wG}}oeLHIS!&c(CawmMPmOCi>*_yDIcXsqbY#O|X zr?yr6r%4Gjd;Uh;!OC$j$oYbf#+avSwpePe)Ux1zn)4Ls|OjB=J|o!5f7a z*r8`0Mq|u?Z?s29-!9QNLjw%=3Dqoau!~bB{@IttzCeQA6N4`3Banh?>$9&!yONfk z2G|w)sMTxrL6^|WhMnB5v_`5ijhTn9I-8cEQp$eTbRJubt{flU{!ud~(^SF7iaMJC z$E(G!71QK6QmD?0CbWH*lLQWk92;oT9H^~WMui9k)kZjS>nIku|tdV|1 zn>$)J_Vn+Tpp(df=nP{rSmb=ZVwJA1&m&^=Eb|S;{Mwqb!+>Dc1onM>>+!H_XHk=z z1rk%i$90d~^9%m)^hl9V)slW77dO7rUw?4Ot2uGO+mz7U$(ipG73Hr|nur=99T>F! z`$hB%Kkw0e=|8vVv3S&Engu3GDPqkg$lIdA@iHQ~Kg}bg08ydaR*q@nyw?IGh3>U6 z=8E(FHQ*c3Ewjdy00A!00l~$m4~rGV6?$hPqQH60|&P4~5n`6HxW{|PH@*De885(fQt9>Kbr<$r20osi^B zcBs|EEdg@>kv+1C)>sp9I;H=pZydaop4kN{q$qK-SoPA1Pth zG`9D}Nic7BfBNLua%5+*<@r5RLsbwA_ z43;hV*%6b+a5F9aHz}dBW(G~(P7yb8JTODrIl&h{#}ZrB=j+dc{EBcE*A7WRTf1Rt zfl%KS0k)2>$+oAvNktSpn%g{kv87oe3l{~SYtwZboRA5$rAHKa`#DrEq?16yofa2)f4N)QLW4kI=X-$lGyRo*0wn@oPC&eRRWgXtz4Y$0t z>?udvP<|F}N8k9E1=YHvz?9e7w!eJFKF=!Wq&V8wwMIC^3~5bz#l&24$vA6zaAgp( z+oTB8anqYyEDH&dYIJ?^2kUdEs@0Y?;KM9E6VG?-yU#h%Zon~i)D14cdEW@P?T`SH5yb(VH+JC{ z(V~cM)_LsjkF$pjAD1i2gV9K)TKrgf9^qoen}MZo0C@(Z{gc(JvHUm!hf5_LjpBgE zKcLXiBm&gQ{){9v6iShE||tR$~{PbsxqIN@Fk7@ zc0xFo_qWJ{4|`sU!fdMfz6a~1{%gfV2gUDAVlni(lbnGf3Ln%vPtGeOxnH3y4{Mt^qQwNGRt@c*X`qD(R`Aq7afp(yH(EVt1qkcM zXOxCJ0tM(ksCMR45eJ_k@Sdbnc zS78%p6V-ORWw5>X{g@MH`PZ65rcakF#Wff}aLPqh_7~o;ju*kbrsvlx*aXRc~b5c$Em%HC52gy-|)C z4s!sawEOq&_pwBY*z7Y7M!y=2wkemzcdj(EES+XJS-s^mdNl|w_@7MBwijb3f5Sn- z*9DuZv5h&>@%Zr^QqIoGKMP#l)HdnAZW|?$25WroFv2V~C2$WZ z*2}WGt4b24>Xtra22V*%{C>VgP}|Kgo$7nse-k#;7A&$`Q69#JoOO(%!|gbfIgR&VZh7Z~>A;<$#pI?c=Nhul$2 zxE;NTUjF7w#2s>GsdW<#qSX~p3)ZeUm%;(j$A)x=@}vlnx28L@}@o!)zeB~lK}phRI9wR(!aUb^$UI*olYcm_^+DyQNNFj+MJj>U79uD+g$Ko zwXvAiz@3&}P?}m26_J-(f800NE8pG^bo(o%It+O6u%Il{QLFa_+AP$HzH{gEdRdX1 ztS^O;2Ili+`T+Hopql0UDt^v{fwHXc|CD7n;y|z!{YrhC;En*hKRLA-&Tqctds1x- zH~u}0JJB6xGHCmlHBi;Yw7D%60f@0xZe{U`ia>)yWAKtR*u$OaDWj=t!66TGh=BXI z#Wy_}nTRIl6M@~!a-3Z1uh#9mtq;^@3OUW5zEjbCU_5NPq9R(eLF%Ma+*8(>-?8Iu z=7`@-C^`hHtX)khTCvEeTe0YS`}#e$zM6L9upuMa(J5Y%(mkCtGy`)uk zq;=fR@=qLLOXShjpAD$`OiOB8FeS29^gsr0z1X-lUDi@PBg0h({hWxgzoBP0&`{yk zT+709W*D%Jd_j(29mzEeSOG@}U>!pg0a@<=m+$}xr8t*!7!VL}nD#lWycS6wGDNUN z>Dx{1!ybFp^gyEh_2T=+ABWN!^?f3jyu|A+G1t3qae!<6t=ip_@8^@V!{DkG++kNN zv(n=BkwE{ef6OL|0{)e-u`!d6X@mc{i%_g0p6Ixq?)J5$lBAU)9|_PBPz=NrjsKE` zhoA{V#_OPovp(%kYNPWk`(5stE24xK18?x<+>MFVR$0T{-96CC36P=hipoaKQ=GuS z=r7Cm|GQZn#L_lSP(LbLxLDu%zzgqD5rRM!*wEU)XZnUWh506ZspN(9-F zFR^X>pxG~$f*WSO;PCUvo`7&#a{aYdnS#u}Nzu*e8!fRtF)V~3oiKipNv#~wD`_}V zx!y2Ob>E3E|Ml^8yo#FC#pI-waXT+#wPZgdf2X5v_qqCSkyCW;k2@--z4%Ga0Yq(R@~VjEO~U2|+e;zNpmQ4HqwdJC>U zomq)+5d`ae?zAApS#Iv2XRH=K6#n;D6ybFE zkTJB^lQjETz2B#~*)o0Mz?#^FfVc4M|03)wqpFO$ZdE`)l$4T2I;Fcyy1S%9>5xXG zLAvW8-Cfd1cXvvIbT{06e7|qp_t(8+@WXKiIG*+F6?4rs*FMuMxU+10$T6eItvp!$ z1_PNi$aP%(Hy4Z5tqy*jK4rC&#a`*9tM{Hx`2FwVy`kmysrxP8i|42aEbhK3Dw* z+k8kar!fp{YzJkrt5u_f1k%#!h^!;Y%pigOd?$pgL6MZMhp(nM>2lYbuS`Qy@n20; zT4L_f(qd4o1CnboPd+e~aV@(v#zSt1EPdH;sg(DkS|PnVmx7s5w~zq+L|M3taQ|I~ zLslv7-KHDnZ`sZr7dqZDVa}L>*2E$|e<2>~$2w6cFdt*+KN) zKrV)=PFr^1w>s~ExijLg58$4o1_c6pUCdWCPysE|%L_sv$t;{@>zU6s3M5NHk5^Eg z-x(XXnUEQ8PNb~%NBsRjiSeIBxew4^{}}tsIue~cp=*;&bn9@5m5G}>D@sbo2!&hr zONw3F7d+15?Q3lt>QxmU8DVQI%@UG&OukezdERT8P^=pf&&nNjk3Mpr<5aD=kLjem zM23vqE1iRprD6D%ZYH`G*@kF!!JNOY_H93<`xUhqTd*B`8fmtxi+~dqNRPLqRh^e{ z9E-NBw7Zto@Pc*^`s=~V;1mYQfIm}Ue0dHGA_9HqsTtiE1~B`c4D_7>J($f>(QWHT zPGb{{hdC$$Cr8G|u6;D$m)oVZJbJ9M%L=6`o!`PgN2M};@k^+GWGwyMt88jD&Tt$%b~&s5piWX!T>fxEr; zxwLZp)V~5LprZPD&!7On!e;_6&7XtZ<%akPBF(5j37E$Ztsqv17`;;oph3Jv`b@}% zL3ma_5|+^I>~-_w+QNCpwznMjWfLmO_wH^j%f<)&kNQ{(zC+((1LZ)z8sPQ@n!)cEo0|kS5TTPc2Lc`}rJN{#9({eH;6IdGo4j6n{BxgP{Dx`tq18r z!-^5Oln#YOl`|HuY&w+*iYrrw&z2;@bSkdI9T7>=U+6P^|~Gt%W|jn`^v|6 z#mIN^qrIX3Jky=FqHxN8cz{C^VZ$w-p6W>LK3StS@^B~Lbf#y-*!*dsGCw3dtxCCd zspNE5(q$xB2}3fR@8l7KQBdO%`s@Nm!4UB5q7)$3n6bZrQ0qm3I-?OjxMvJFBa{U3 z?!n@d{@&Kw>Jcp`@bpUe_BKm}l}pHE-(a-7DNf7#_#u&~g~HD5E%dLApzgT-`^{eR z-L;*4Iu}MQo1l^+Vud` z*1k^HyK_uTbyT5T=FAOnPoYQfY*3z7X(GClxWN2FTu($VlIMzs; z!_8$yxKw9iLjS={MDgov2`-5ac;9>D5oFAh?r42SQH4 z80)Lz2TY-nCQD3A+}DZ`XP4(x5lw$!LKs^TV`r}}7o;X*c)bj_Oa@fs_!i>n5nba^ zczDmP?-YXaDSen`*yAR?D^+nzR6n^%=+aQ8*XoziW=bbajqdf_^$i=Y{w`Ilk+$Da z#Y{2ZTcf%3i&(ZPA@tY+B!pc(lbks@aJw~tmdJ;Z$pJ52nGUSoCwgCv3M=@t98qwT zcK<};C=2!1K|#lc*B15s{c`AEgcD-((Pv*njRKU<8>KI)r+=xCeRnrK zzAi88U0{^hL|+ZJXF^=2#aK?pCr-Eem~yvFndvo!!<*gvdR)&z>YwQB{Yabusc3-! z-cq#4dip?Q-AmC%7=2$hDZ6oDRwu)c(@Og~5C4G&xsiI6gH5}O>ns(57^g3Px*v@F zi7BuuUI8K-r>3Q-UPur!f=~I4i=hV|bqFN0#2C;}a-pq01FnZp0X`3eN0EglIfNIe z=dTPC$NF3lJ+A5kd+*P)svk%93eDNvQCan?lm0%g=DHNMp8&&%QH4QRk#N4U785qT z66b#h5i<>g__|Mso~m@+yVvi4^@<^Iy?wo;eOIDhkLU-fZKMD%Nf1-I2=5 zulc%YfBqCn`6D9~{*w*gO@8QU2?XqbY}mFB#kRxn?%=fSQ^0905(-okLhCj-t$`;d zaTE;VW;HDXjUi;ne}PlN64e@5a_TzNe)? zs9&&_3xaGxo?ll}3Ef{Ymb@N`R-S31%Dd>CDaT*#v2L1VyrW#gdMjj8vB@9p_k-c} zVZ7Vzp$@i4BytXBAfKF};k51B4Bm6SEC?s-2qGg=R zp5H+sPEW%$H=b5NbjtfC0dX>b6na1(WWfPV(3Njc{xK-yxf;tNTXrYOorp5Iuwemc=6z1gWpNYb+3;}jP7M}0z(dIjO0PY#tC-5akxJOjq+d* z2a!vv-K17+LAVyKtjWPG=w(ly1H834gL>mtDsJwf0p-PyU$e9k&^!_6V7`YmPvaYE z#3g|Uc=0hGkt%R7hR_6Ps=^7Ph!`IF`EMbS81VV45Wtsze`oE;j`c!r_{L$P!`))( z@+mvFbe-&Z+uwfr$=iwug|0k)OleF`0LGrdW}<_@QelN_HfrA`+kSiic;j8aPlvVE zOsOi@$qOD%$`!y#kP&(%CxN?`M67`B%78Zw{>J|;7J`X;RM#5zOKiGPWci)5Pcu|b z$XqW>oEB@55>%q5@=?AZ>2Z#;NSVFNjnHp@@d*#<+gd$Gy8%ZIe?`D6q^bC13y?8r zm?TivadkN2s}i88fdH@iH86?|IAKn}drK(XkOLXM(m`hwbO+B-M-c=^CqDkc0A1

ve&bl>e|)2*6U&?FlRXnn4cfyal`m!rc83 zx9N*LNqt4M+2U{>Pww(kqp{&yry_K?=IE@lJPH5PNrzt9_kqi?sE}#dlovgemBb{> zU-6G9BWy?&nxgsk*lWZui}yaA9F4}BQ^IX*CbGRTp{aw!8`*TOs_MBF{T;~9=@*Yy zMv4D#;O~IZ#>>I+9{)M;zeZ?7@IPd>zYu5$41Tb<;le*hq`f@oK_0*JazIgibAc)# zk<)EYTk|+&RIjClPLzOTYezPFpS8A6B0PGunH4CpBu zGs22Gh-tiPQGV|y;-2N^e)kcl9aPCg**S*R!7tnC@(t1G2giQ=Wsf4V^mF z?WUqc8lmn8h5BkroXFthu%VxKDT<^(-7y%rqwqVcb2f?>d3Qa#?h!=Uw6zbh{rkTC z4nGUV#p(4QS5!Psx|pVXe1S6x62Aj^L+rip!Eaa(7#OLrmvW>e+>H8~Mbjh5l~;OKR0N;w6nLLpuuJl3bKb~qPHI@ZiTy2n z2nD|GMgdp=(RE4y0@b6*mK78-Yv||N>;BVF){qd&8ggvyoZ!PEJ4K9I$rI!h5#Fd* za_#?pZh|48qjMfs7UjCsz$InGfdEC&Q2bPN_Iugl#j?Y8uj`+-^Ot%w%~|%Bg4VsxGw5aaqK_OBxD6H`3x4}J0ZghRD}1$ z%di68tEiqE90DX+Jz}Q5;qN|6nUA$DN_7VWlxJ1Ef?9L}g&NQUkGh+rzQ7n1<~=Xo zPRq034QstIJ!T-ktY28@TUe0hN3P#p9ZhNImttmPqXs?CxH6)lh*Vb{>98x0{Q1PM z1#BuR$X9HJ0#d}1g1IP&A~(yQQ8kOc@9386IXK)d&8bj#KMb zk-xV|LZjfC;V`SO^}Rp34GY2k(+L7tSMlS zT*9xG-}n9A=5-9}-F|;osHy^hhRLQB^W+p}p1xoNT)KUyCB@T=IRBJk1`J zQeLa(a1n=6#8*RHTc_hy@WW%l#5S#_mmyEHx#GhHJoK+EH&2qF{FuoTP6m_%>;sd# z1bl&5poi(ThNg9Qk5O)DrvCOb@bfd+b_CvAYf8SWHNu9|f+y*QV8pn+yn>bxtfiZ> zY+7nWo_9siii}DGvP4%8l7u{l?cqvU(_wC1d45l8!jG`94Q>z4a!oz{ic)=fqf~vH z=(Byvk8(EhD7b(3`V^G2`e%m)1Z+K+kpdgU3yjR?VdPWKY8eVM4XcDyc~}og5KT&w zHu@IY?|csgw-K6c^Eo0v%lkD6@R#{$`SRX;kLa;?hK>%PG891Hk;#MPaQa#iI%~TG zv{yp2k#9Ws{M$FEMSD<-?ng>l&b!YVcdqpB8EFiK%4W0ka^w9cZ?kwlnpOA_gsDR9 z4~hVlYHi&=%NHT2E-lE-(^ClVCW0#~ief1>&zfd3XJb01JQ>}2!gCE)w(=`v?~jmE zs%zIPRkd~}sg`Erp}mxB0szR@QxH@z>E`<`)x%}#)Z6X!hPh6^4{fIXw7O@OrF1{D zpfFtS;oz_=x*j9}@890Md{hOXS3f}UN+aOC0*}6d03wQuS;3qF*z_An9MsE2BElu! zAGaOJjsM=3aA~HdJm%i; z|AHhBF6VvO)Yr&JfksoL`TYPqL-lD$Kc z385P}x?*rioIQ|4mlMe(m06y=Ky%yFX4pKLcGD1BGv=M0H0Naw_GTLq2d=4DKgbLR zlO#&Zm|Sz#L{HMWm}6h1C3jhlQV~`)bV8x4-Fp$A zkFcCSa*aj^Ps6VH);mRPz9+E#mJ|N`4tx!_%W0pTA-b1?p-1WAZrbuW3r;u?^*j z30HVMWp^6Q(a#H&K3HDscm@)Nn9%IKM)?gd8=R=9@r!7@kqUPX*&pH2b$NlE81jRo zlcLj3d%aDL1zJSj>u-{6Ib*N44OT}K)bjv2wtJxhxG+)fG;W5uC%LPLi3*3yNK5we zpOjpu$QAi{Nq%EG6AHN{0UrDfjWOZrct~>;w5FHmjbFsxlzf)qKU(?GUqO-s5?Ib# zN*eI;dxb$ZuC!GcC4<@qMFY&S`TzLdabW=Cw8}HbbtsMxBv2G~m0NS!BvzD`@)?*E z_wH)Pzn6KCCp7xk0!U$u2=bRnpWuch3q`XY`CrL!-jO7hLUnHB8VkN7-pW$_vT2jX zy=%LgeO||p{u|Zh@ac)JH}=fztofV9PZ%prK*-*Ec>1z1Ix?kbZ@~O2Y4`YN4i=1+ zrV1t}g@*yqSGk=iFuHQRHv2_iSW}EjC-n-@cGl8p)5*f$Zvp&$ZJ= zIopbA7jBi;oa%lD@ox+fWFK}&%KOFwf@XsjB!e67${lPFO)b#b2IKo+uk0UfvM5J6 zTX|k$(((tYP7HJ`%4dPg@@(D@Gt@lrG$4eibO1=DS*(y(AE8W@t86_-ua6+SNdL}v zNEQg$=*37mcY$I8y+krFym4)8=$)JvZx~ksY?JXqWtTn!+*1U1bM@Ya;78fDs2RTf z*IyG(Kf~-rVFmQ?onO1_PO_|pRHt;hd%5aTml&b6F$cXv!yTIG{*ts#c3-q% zyiaJS)Vf5T;JutQlue0Nx5+~>04P?ULDb%OR|b~mE=}NEuYg+fmoT2)IX3Xn8PHq| z)S!vDPe=(uF7Ah(_H$L``9GErNKDqhyC#vGm{M1o$`eSNcF3{^|4}utd9QMv zWy_t^vIJ?5#p*U?Cl@mzpq3Hrfib60iALv0gFQ=0F>Mys@Iaot?D=TWc3*m!m=x?3 ze3%5y9s7#IVjE7V3mtJfo>LU#_XIPVyJT6XxWqSfhe?w50(tEr`9U;FD(W=zzTASu zDF}mCya}>&qgddX@85$|@;?lHFC$1Lr=NMpQpga0G&VabKzSsXb<<@?}oDsOX$sQ~F{mk9^fI2_>6~Okm&QsE!;P zKJy1G43wgtE5|V~@`*Lew%@{hrNcv3D-0mbC5HV?GK2v_SC@Rd^kLFuG&(KjW}%};9@b5b$o}jY;{@} zA6Hj_4VQIZ#SiRXTwub_&ovqqit7?bM%o#B z$G4z(Qa#gg7{$(J{~Rpx7oq0JFh0T*kp-@$k+@k$05zRSJabsQujomFo+B|9IC;Yi zKciOx-&{~V?#3R#j^1Hz$SVIDtLWq)nB8LY%XcN{s(rv8RRmsh4#mW`vsm^+G5kbt z1WtnlinrbdjnkGApY_K*r-M|P0dSwF^);Pe7Gr(gIO<_PEr*tYVgU{tSl`v&cpyT? z*dKJUu!QgIAnbbE+pux3HSy<)F!sXbOXS(!fmwxuusia|Y7ON@@@sBPZUx>SgH5lc z8J{;UmC7l!8|Y@uy&CqO?L9yW0P7al*!y5T_ZYGBT6wLi+BEjOIVr)3f{Awcz*~z{pq6?Diw>1# zGg(u`<-y8bhL3%%Bgz!GzlbO>_7L4%vnZ%kJX3EKt{qA_tDf1x0)I>a?Ra9Uk@j>h zvGs@nW#S{3GEhYSMj&_}#^p7X{BAvWQ3#hpVaCvrJd~Q63@DD-rib?lbS%8gQo6zdO~% zk;*8iByli0@ko^qART3V`#YXbMy$!-2U!2drd}qh+Z7lOUdz_6o1fthAV$6k?gL(| zYxtD})-xYZg7=PhED}3eC@Vr(Gr!zY8VkmSLtCy0nCW%3p23ca0k3ex0AA66h;98a z>d1=sCJ!RG~NLOKvc zw*!szLTzD~{-fC%S(9w+2*JmC50jGlgu*9rjqJaDQM{JuTi{E9`?rOHa8l4U8Z}_; z@03y;7_fxoZ=ZZHPa;}fw$kv@aP3vwg>Lyy=-v)b{9fhcxoOxzAFF$Ix~DqZNjp~9 zgzoRa%)WL^MWT0#5rV2iMWOfY^dYt>9brzJDvMBG;H2*V-QLr|F7tAIyyABV;=fHH ziW*xd#RxRB+`<>Ida|d*O-VMT4%YqGmEb|Ul5RwaF8NP}jLC*+`oVCdu&f<*XXtLdks&@C~uzr z(>n{yoH#g>Yp^*`eXampjY>zx>9|#Nt9&QI$v%1pWr}Rmz<3$%TSe92;CJI>#NsIc z1{C@kOvwl*Giu}TjX<1JJpvNqj-$m`C8I+b7m;MeUHlwqrNX%q)4w5X$G;Bh!a}yA z$&jPX6TNdhPOz;w)x|0kLS##p#CXodmEN;E{q8zPs1J@Rla}rZK{RFCzKqfw6qJ9{ zQLg`)jsgV(m>M#sh{ISVeSNWT7V2sk z0Eg6D=~km9cPW52LAITw0Uye>MqiU#AydM*>fvU!50_4j;ge@G$#{5S*Z4~J7|o!a zabHtYgRS60egRIXxq}W-=m&RB<6P6VB$w5-`ZKB!RF6V$9a`}Yk2jJCvS=`?Oqgxa zsz}j|3P2)Iwq02Gzjpy}V@5IR=K9ZJ`Y=wc=@s4@8yl3BE)K5pm8i6@AZl2n2C~BCZay*odrcgm2Rq|?!Rf7rc74H0&~Vv$ELo!#gm{igbXMUI&qQ2%a68ynzpo0R4;iF`()5dK$`w#A+=;{4`JR1RlV3XI|S(;piD{s zz>|V@;{QEETZMMwzlsL6zd$2X(v#!$<5wkHu%X~|8 z{1?Df=f@kLhd#Qd1%6SO)UN}Fr{gCMM*R+E&jaUU1820ch7K~~2J5Sui`6&X)@^^% z5h7%Hl+W4k5F8P_=LwW~YbV=Or)J+f*e&(B(>nBLWtq`@mOL`LkG$U>4NMPrH-u?AZW!bG#H~i}I zDyE>G%Qn$uiiVj^2S-ERadohblVG0zaNwr?96uzOmuR+UsKO*mQ!8k$I77zouK^~+>>P#eF|_^R0D*gvK3XWrV+BfaZKVeOt3dw=$|9Y%z=SfGLPXItK( z2j%?`ihJFS;#KKuQ5==Oq6pX~y^=JdDamXI;EszSFM9XR$jIxq-R`gJmS)37NuCO# zt9Fgk0kh@(qd<=a4DvrFaSp&A3m|MtA$vaj#C?9;v2n1AsG@S}-ipmc331s8&V!g9 zPUQ9Vw(Cbt9Wmvs%P&lq%pdv*^jwo%53fHI-t%LfQ)tX;FR0|gHUmy45P=mj9Tsk# z;zK{g9zD4tr8z<=$@>et&`4kA$m*fu)HJ3OIhpG@f4O09KJAN1?Yx&Tp3#>lCL*=O zLPG6u*48Dj@qPXGiHX~r1&ni8Y?|bZ$Z1!Z#ol6MXpIfK6+? zB6mV})tIbxrJwTL)86HwwgkK<6&18I&R>Nj4A1L(M5W$c!VO#L)kjN}{UR+V)cBKX z3KbmqbvzAtj2}<{UI6grWVS&qmC?m})8qusw>3tdWQ4rYC{}};S+(y{`ip9OnyW0Y zS2@0TA^s@;MnNJV#wtCXxjBkqlg)G~2%V8eBbBu*4z7LkXRlGq_t5*j9cR=Kkme)n z>8$?InyD|n*2!+F_~z<`f5itI*v>r_;XJ9GewD<@36^9$64AZud8`xZ&Sni6`_Cc2 z5*SA2{;>Cc<(osz)cUB6_5n$8v17&lxBA<7&{;s2AAkMt^5Y7$ovuS067=40Jj(gp za%=nAOiQYc&x6D2b!fKZA2W{e1aGDTv=7>1>MIRlEx))NzAu0Ea*r&Q=abq)K2jNq z{vcO^ZIuhhvBav)Qh@@6>tOVWmz}7%+6IdllxXI?iAkC+keyjkAc^P}jm@|S#zq@1 zN6l@f^6J=qc5cJXc}eIO(`9)+p3eoO8ArtL>XvPWcmN!Y3?3@0&>(-X=Z1acl%M>UKyF{2D>_95>c?@+0ix zV}zhB-rn!AeqoqVoGYg=Qop48kf?5mHs3`|O)xIg3JC|j>L7gd3M;R(rjX^es=1H< ztyh=yMWk{&gnfiuo3S6zLEi+~p*-cAtZ(el*}0%2=*=>#enY5Wzr!_$5w(PuHhIv} zTN$eJ_BCeK%OQGtOOJ$cU+t^g!N7f#EI-!m z&*G3}-jjWMw%58Wj|A}uQiGhkqxPrN3=#eEvur)jQAvMw0Se7qDu7%uciPO#7Y<`6 z`yS^%vof(}4;PjdWUNUukSI$_cdBt-?vt$iQE?HuoIi7PjI5|&5^ZC#B>=M>;aag` zx_We$2-dW0uXvQkdriQ|14%w|`P(zZ}-ndkbq_5kt zMR<}+h@jf=3{|IwR`PFMMkDyp?&ZR5fzj~xN(Wok3C;Nkzn9R@6fx>L4n8gtqgC4P zi7vA_9i6`QkS;z~L{i-~h_A?eNIA!cLz1qcqEKP6bY6-0% z1GUbXd{BTM31zl}6-0o%8(=Pc07a6F(ge)@x`rKIZ$8t#n=2|Xx%K}m__W_hWQ@`R zf4^5VGhPdC^Yc$fE?jfY`Fh@A?$oW|n5+Kv!qc3{0OXNK%W>A$F5g6d5r@o;40$Ea3J$AH!4Pd&W@m&qMFKer;7xTSHYqW)}rFMqee07F9I9BbW zHb#-yVYX+ginZb*^C?jp_4ya2v+(UtfPPK&p#N40Imq!9T(dly4`$C7X{T%9H0dJ^(4gGconAyU zfE%`gv!><*e@5tQ?W_{@5mC)pbIT|_?~G4kJgJh_lRkmOIKZX!*Y`bOoUq1marlmq zKz^aiaS+nhCB;%^#SUc;v5%Nk5^w@O@EJljw0U$?5QEB-vsu7;^z3vC z{EAXh7}A7m#%i!y@QnTa)>RAXy_b|;cp2|Gq1EhT`sAdi@Y07Fb*=oHtf)b{PE36_YRujDtzzrkZYr)@aKkwh zQQ-r@<=9^W{E;3q^^Uu75>~kQvh76=w(rdi!}cx6xh5I(HSvtzaMEETfLE9H7cXnQ z`H_gnovlyg8VH)n)~tcj^QGo~%$}%>uvLgzo{O#Ji)A>vtvHkG-<}K~B=D*NzXiE^ zW?BDTvyCS`-7E}lYbl>>UxOs|7iX+NT;`;#MG;+-8SEJKthI3DEy{wTcWdXi>K)VZ zF8&301E9X8ISeL&_yjrx17#Qt!NLW9-o>Slrh8v8JwcFK#YeoZd`TqyU3RR@P?`tD zCSO}fT!%Edx=nN(jZOC)<@tM>#r>R7G0Dl5f1r-@KF?YWH2Nn~L?;C)(XTv1ffshR zWBBoJ(FPDrQl!bLDz%$vaiT!{hJP5x=rM*>AyB0!?K9mwFM>=5Nc?6J_RmEob= z8ku-lcic}+yL9@If9#l}hUH)xvb#n;#f51}zlDsw<5M+chhBT+blHZHQR>j^ZB=ST zqf7!v&bZtXZb1GvNMhTk6phA=BqOIk-N=r5d+xJXOV^9$!dH0*fU(=NB zYNKOB=sT;I0;sPv9Dg1lIRz?!`f@&J-#kj6_9k6>*Nuqg(xH`%PwB2b&L139-vz_( zY~AUnaLZzP?qRoPOJfH>oU}&YH(cf}n14oOL08*URjDZtCt8Gs-+4`+GR)>0dbtNk zKzPE&gu;MfG#*L?hn%qF$G;9Lx9+V8!^&CKfbDnzeakQ2?Yr*(y~eYN1jFG|2v44t zfmWsH=4e&1E?$jlG!Ixq`aV?Y!BzhYB3TztFw?58uUWu*5wdm-(=)uvzQXzY##wU` z&*A3UfOf2*n|Xd#hiTow!WOSQRU39Id0liA59iF5b4YQjBHj|Q(L$~Lut?%=vX=1D z`tO!bzchBd0#o2ztU?OueY@b#NQ5BD)F5~Ct?`sxe9wY4YSQE&ujtY?Ahw|cElPe% z@Gr(zqRP3~x1>`7h!R>|hO470%X3nXx(NTUoX7hQGb{Et)B4c63V_@z49GQ9ek3l) z^;{n2>e?J;e!V)(gOQkz6U5Z3DX8^VE1UnQ%{VWm&0YfGSfy#w?JH^AU1ih}yCOs^ z%DGf(*wk+o*Tx!FVfKYqMM-VWfhX^tgxP;*X*8QmOIePy@r9Js>krB2QDAW>^T>FOUON^)?pB%hC!?D@^5(7JU ziJ!w`B2&O78L|7H`sNrFYZe7&03*^d}UbH;F@C+0D>{U-bV1Vv%NKRGl-yW(d%1q%|=#^$nS3Yy#| z;_5yq-H9z$$u(&HVHwMO>GvbN6JY`RdQ;kTyazU&k4D}8RUl80Fr#rge3Tn^GSUSE zQCc%AySnt155yZDt7ayqh_qzS)?=`|W6a{qCz{puMNoL!FIn{^>+UD?$Kq>~_!c}z zD0hn@Ui)Dt);DZQUyacd^`+*2E$)$9abH8#edvwo-Ks9~phurCxWUt>qz$C;{l{n1 zK!=-{ZxwrVU>7OnX;ApKGeku3#g#`g*uyR^j5o_uZVLf5H{u!s=I z>3z2Gt>L9;+XOFL&9O_gcd>8B8+NsjZ9<9qKODsjnrgBQZ~aFGQ2KY^5V9k_#lx37 z%nHGfR^}b4uvkvpuTE9u=@%RDl8csYobRn&h8!m$RymYvRs0QMj;`&Omwah|Ws+&b z3IC5$i9?#;nK?kkoluQR-CvyqoL&<6!S8?StVm-S9{*UcL*fCowOnG&UdT1qdVy(jZ?2o4 z4be>(=hNm64Vkd~O)YyP_7Vn@iBaPgp~=ot!_}e|<@Ri+#&&p3scMB~`?%gN&d6?4 zI0gL#YsQv;{gw3XJKto0;xo}BQ@xt${+>vPI=Fc>t%&R%N7Alx35j~*1s=aG`}L9H zEC6zLZLxJMlV4A+iYAq#4?~A8mAF$c(+oXG8%d&Jp0f)bUx)?jc+I9&n2@FNAyJHX*(cpY4Itekav(J46eurV$JRR z37hX`Hj5-v{b&5<%=nVPFQ51T%s2ZZQT~_eUc%{jhepaJOTu3ToRH|lxZI>T9yS^T z@_O7Jy2@Id@I39#SR)-@xi!k6O!$_iWq$T{2g?`Mn12g``OYn^AK7;~WpIJ$@ZaOv z`+p0vw!W-R!6zU;nyVrsjYF_MwU}>k8n(XXyn=AhrRzn_$%tPbpE-SvIT}pj+6!|0 z7C{tFxKEgM`MfpqeGlvD0Ly1QsgLPmgc_s@f3fL^37&!y5vA#U)|=NIO?$g$zOM}A zjGJZ$*t5LhYT8fR&VHq5v*83IkiRmoMtIuBUqdfs1;q*Is3=@$4-FEFWQ4zxSkcZb zL&8+lP34L-*bgriQQT3|*NN0womc|GLqF7i6O*ziLx}&kLIU6|^vCCh1gtN3{W7~O zK6G~bW5X|j60jLkH19(1xyktCS4)R-A)HcVcev{8b^uD|CFLzDkHaAJGE9%t=Hc#NAslf#PCb8eB)ju7jGF1jg8uOpqK>aBm&9qxoc4 z);8zWhrs&yz|73mDf`(Wr?5?xe%FM`vDf&elWnU~Z|pW+4R(7O7s^%)+WGFEoDS~_ zMSHk8V?Em-xk?UT=3eBJlDjO|?5@WoUtG>iHq-)iU!P1E!7vPX@3!T~yF-8rgJ-mPbC0d|1Twm{l`0LYTY%c>cJ=GeS3}%CxAfl1ruAX#sD4hOo%@4Ba#jf%T2MeeTw|JYIO` zZG&#~R_^-&sl!EAZBBGM)QpYSaC}!$@VkYKyg#qM+}|%bF7zaH`?HSu60J;#E$Gk6 z5-oX^6$-cKR9DuS4Co4wr@>`F&^JTufd^#(`t)r-%;(+rAD{!u-|ZEw zSxzceJm&C`mVueZugKTc5dXP_Z9mc))oa{q+{s>!FP!hHQ59R|v&ei8L)6x3A;ihLV1^EtN zpT2;vVUUKf^O4t8%SGM_lJWtoY8#?Fq`Ov-NF8%yM>3K``blkGCW)IKoENbIF>Ey# zGUHFI-fvkcz-%rFK;ZlkasCg%u!_CJ{y0bPIFMJTK=b5SOXLyVa-YNVk&pRvOL*;) zwz89D$rx)kCxeZV4IpwqRL&E&KZGN~YuPs#X;P24wA*1;|1{Gb|4K_!{hda78I<9s z*nj*GnPll3R7|>$dn55{tD%d#hhYC*4#s{4rJn2W>A{=x!Vp=om8smWcii$TVNQ9< z>7EnJ-PRbAzdXOO?)^$e)Xl1iMTPPr7!?P{L3yS;Mkh6oF&Zq`$b_1ouKBn;!>WI% zH})lRzB)Z(b*28jnKq{vbt_sd6KK-U!bD&t0qyYSB#Eb6H!G_y%)!1VC|m-d$TEeW z9J=#M=zC_Tl|CGLI(GP5peODF_`TO6Q>Mu7zEi(j!_z7+!QmBB+Dccsy;!mG_TZ};$^ZcORmMrGu)V-F+z&isg;EPYhFEyUG_|7PxJqD^IY?`U3bhJNN%52pqq z;bql~`~<|zdGx6DR$A3}gUwuXT$KLnBj@jTivO~=DVQ>i%TUZl6TYy%gkT&sNg}^L zSUXO1L&mk(7>zQlrPq$F(SW{H{k}v7qVvno6f?EpmA|p>87a>r!L;7yod5&GsOw(;19AqkCZ`VtZr3F(iMqKR>P&W0YmV>HnWlsDM)MQSEPvt&yoD$ibMiVFstD+|xV zZkrFq*5j`mv%gg|xfwj3aznPFZ%=m_?bFFk8nihj4Rs;DJiAXoj!7U9wT)GnPUbM+ z9`@yivTP}W#Q;fiz@7h-w*p-#Y%@+z?n4~>j_X96oi4Se^obe7Qrisa+HcZR1+&=x=iqvd7|Y` zuVJeQrN}Ko&zWA=vrA2Dq8H_-2Uruk6>)^$e*1d%lyUsBv2++G&|RNjGB4fBhhgDD zd&-Y_`15G3Ga}plA9x=M1F+Qe416;n=$woZGd+r7oA~%>M$+&Z*C1rY6YbBWdSwxt zaU&#$c?(z;9dmN}F(l1u0**o&yiD7KP+C3XtGCP4V#4{q?vgU&qGQ`;Lg<1CNMA~( z$NjsxCI$U+c0j)AVGTD_<%)WmOOCLm)#FzLDW6}$2m7KuGk&Uwnv$qffo?5!f*xGW zYj%fTZ2-Ik-4J?t$9euD2bn}|#i>B%_&57>mC$$Js6HjV=0*&)SmkxaiY`z4O~J?% z#E~B4?zuY#0XkZfvxlZE4G&9dw!zu4ot*UD>hKiE-s^8 zH>GMATo;N{*tjlu52-ExauF@jJLAR`Ned=R36hCn0LswIG7^;4sIG; zH7-YfF(>`0b2aI-&>@P2>fDU(yPj=X$c@;T7TWZ8-plV-658`iHEa5C9Y7N7wTE6581fck|axRm3c+8egHm=Lo6 zMd#`ednZGJFf-4YFst{saN*8hM$a(o>)!69Wv5G{^FMqjqgnDtul%N7A8mG{ct^FI za;PgW(T&)NYqssZbGA*Sz;^Y(SXJ$;Vc@V7xp%1UkuzcBm&8MPl#5GEV31uaU4KqrAZi`|VI;8ckrb+QxmYRKpk7uv#tDbY=!UtgB9#QLs(v zK-ga0ZlI_p%7{zr>vxjcpl8Tu#_Nz8i8^;vvMvSxs7b`$GeBGX zZ0@AP`6`L!u_^kV;57%D_8WXs)oU!=nU#(f^}GCCxX0Q*N#z3Pt=DGE^aj2mL-S)GoX_V@Y! zKpRrPXJH3RwJ$7AK3+1oS*>{eC323DRBD}Si70*gMe*h2@qJG({{^#~DobGDkKZu# zt6SNPKSyLQTdZ4x%VVD4+%e)*rW6O-XSq#?4s)MljqU41B=%{EISo0fFo#CYFzx)T zx;Ogj3ey~ehl}01OB5lQWDuAje$yTJ9zuoTQ@(m5VKG%vH`TECp{D6cxbPvRH8{@_ zA1vQLdr<`~3&k$wEM2hOD=xldl&Oi}1`VL4gtgyJN?=sq3xmIrU^*+QD^T1c>eR|K9#zjSZS zt9(PgZ$ZVV`;jc=qbb|pzIFkqrg4$t+uhWEZ|X^p;nW>@L|Q*?!LY7Z#9wI5U(UW! zHlS?W4X1rfg`{%l?RM0SUbZeoXJWk-XJb4Q0ShG2=^1t$PcG(zYy_pWxUbA!c3bpS zp^S}B+^MiRc~p&ibiwD}cH_kqV3|OVp4bndA7R^14q>wW9^2qJ26Vu|->|;e zTWL&}lIz;p9d8XXR0TrzHY88WdzQcC`YB_{cDbvzBt##f1CSZn3~P9!E!S>v`Qw)F z*4SD)@P==DP^E)0^JPlY{X9!t*2t>&8N16@tppR~ggbK!ZQK0OYRKC-z~5%a3eq{~ zNXZBF|EEV>g97Wxh0lf54h)rH^&~jUusXH z*OS$X6BDo2Zwz&OLX#&Iiqrlfx$*)3kT8e5^?{4+D?UlEu~MIn0Q5GsDa;fR&`Ay|&RL>5STUU?N;Q97)T8~U;w7cNsw!6qR=-91BGNF%g zXd)rF2|;4lz!xOHB_GVDprUjqq-GS(b%3hH{Q?eR%j2it;8k|-$+l0par3CUsN$y2 z$y6kx7v~T`J#YU#>d}gQ@P z;`CnJ77(j`pgd1(`hmx=V>ewN*lLTpjaobos<}`4|;;4ce8%zIqf8p$8Wb~)* zdI*15MDNq3i>F6c%(ZsJ8X7SN-YJ9Qf%hX`+}Biv1NwE?KSSx)IB`#X>Dk2(|Iu*U z`ucq)j)7v7jg3XuWLHg<54N+iLv%&zv{7Q(@-ulZ@&%)jbU1L^oC}_&L2?(ep`KxJ zSPehJ_+qyvu4PFub1N$B__dh?wy~ba^F65OwZe9|h@+o>=TYut+LaB(imGVgcX1FN zSWC*YM|l}HU1j#uzpJUf-SZ`8-%jS*z>2R%=L9K>0Bm}HT|!xgDa$J&N*JHFXuTUN z_N2YR#8d(mE(@Am+i5}W7noSlsEK`vsq&|1!FBq_0~~#mxH@Wwo8$sNgS=|+g;fqu zp!Zjv$rHx_;pY_={Xb4%5vq3VV_LZAkRKP|=lf~Nr0W9naKA94g!#1OvEOQwjdx^L z){Og|aI9^ZXD4Rm9DZ5nc8+Lb>FKjmbO}}JTExMjN^r04eRt*nOBzSn?BJSSD$b9W z1W2wF=&N$Y5jN2@N6l$c!xah7waG(0!qRUXXc|wYYQmqO(L;<0_3Bq4`R~Ab>HJ3NuEP(^nb+@=m|Gs)!&cDO%M`rO=V%L!YA%;;@L#-u{( zw@v8pO?2zYEl{{lrg?hSAR8HGPdm6S1Rgeo(kZ5IU(XX~i0t)0kcj%8!Mr5+4%I}y zMolc^Vt~=@p#EnqBN%~8TjCs?w>iy>`Zg=|DK%K#Emhn7O&WQQ+;L-q*nulFT1DjX zt@LKx_wOJ*QES-Y-F3C(@p>DpRevoQ-auxCAm`aQxhs9WjoQt}|(NY|l}?rubo?(S|0 z>5%U3P6=rcICM!%cMIGH-|zl#$9Mk#&KRs`?X~8dYwoox0UKG!_(#%>zR!51j_SeO z%lCUUE9}F|w0ZV5(p3UfyXUDp>C)&j<3XGP-sS~eQnU(KTRW0f%C9K=3zGSzo~fzn z7e!)cu3;*cQrhiXb4K0=N?fxt;@<^Ta7XHzeAmVma}}S?sZHzzTdQ3!QCfymM=*wR z`K%V4FkZ{LHuNHJy{u`F2UzL{kWzerluAdZWRm_p;=J+?p0n=C0w}&dNOR3PkQD7S zZ&Lp;7BVpa*j%~abg#}xxE4!#%oXwtyAH+$>74v!PCM!=Q*Qh&R()Pn9Ur}Z75c9d zm%S?H>Xgcg75^XvHE~SOMgpl~IHD1-_qhMFrJ!5~8fENS#M%cJ&taI?yE1Ft9U39P zu73G=3WZ>>ou;PL+sVZd$~MJbvGinSD&As5HAe%$lPA9;v_%|3uSp!{%P1bjF&M#J zbUB2zlSC)ie^`6B8HLkJ(VKGF6A)L&SDpl1Lrfu9OT5rm7p)C0j*jzUE7+hO`l)A7QiL!I*S-t`B){Cf3YR_7h5yq zz^upLLC&)&q)KL?IRxu(I$SK{`n>PJSCpt>{YxptQ0k0b14NGOf5#sAC5J9=U&5Tx z{g}zh7lkX=AJGA;E4mQwAyAn>ajbyvfa)tc91i90m1aecMvH-gd`WTe_}A~MlO5iz zP3cpL9{sn|xduysci#PXb6ajA;9!{!^l)b|?Dc5l*~@9}_M=8Pw=}`{p(QU)9kea9 zMW)S+8^txa2+WCLMTQXsG3!VVW!%>UNW!w!j7j%0M!9jwAr$vF3o{?${fVayy9CiV zIiIbVSMoWwg)4v@qLc+K38Ywe4kx>L(ImR*(R7#a{k%VAv)HVp>28*AukTN7R}2;$ zo}wZ3Spq*>+a!PYSMdYCNL2~{$1P0`iBq!H@-+SpdBCr|jF26@b(qu>BQnh3xDmh! zM8+4tto*jiuUfra%h~Pjr+u79C3WI0CCKpv`Tr={fkw#AQFve_=|ycU|K5BjEf}t@ z%^9>?k6OGdDmcC&iw{`${9l>5LZcAZuD=O=CvT`DBRK5DW%~XM&(JZVDg9j0Lwiqn zzGTFdfyNF{IO^c28e+iLyQ2bTlkril0~Ei<=QO}xhjb3rZ$v2p-|SD{+jdNHZGo%J zaYfoSt4#+&Yv3xp)ZK2obQTydIYBIXB1uxkBT^w`JJG)86$L=B0n=yU4dd`EHScM^ zm_n~(XB&|2PqAD1?{U zG*d$2UsePG{F#c^T+#QEzU_0d(Drm=vu!>RS4s(Ce&~ubSx&XVwduvEhxq*3PgAak zQOd={Kqh885Fam+8%M(1m)WBq+$o(tH9=S0FEIN>9r!YleMe4UO9`d(W z!6!r_WEI!$?>!qHb-YufJWr-_M$ScQt!84Z2R#e@%~{4MC7B_XSCYh-&(Hf?N{s9n ziFv(7bElQN47>Pkd&pRmhttZFGl`Hw7W)Nt<~pTa)^Q+8!>qOtn1qBpaI*qou%SLQRCPjIa{K#jP_!=4un?kgW z`)6Ytlo;Ti2xXj=lOA~t*2Al(a^YY2pKqG|MCbqZeO7H$n<6;v$fz< z{F%Oa&2^%(c)MT&#`!YZuxQ@1F~LCQ7JSWQIeg~y=J@FTY;jFUL2`0&? zQ^P(cspgFM;wG;HX~Cr|XvEK*9Zw$omX4`e`B2{tPc5~AS7h^blS;vB2eSw+0VzP^ zxbnXugq*}+T1c&Ag8QTS7fV~}nRu!t%a1}k(SKoxZyrEi`w;{I0?xX6x^loOM>Va= zuUyneCJBPsLa=6rhDNdBHu0*85xnqXM*KodXm~m;)_K&uQQHzY)m`DehIx2qIeHDe z6SZa-5h-b3fXjqxYuq-#yAHejO`j#hX=!qesZ5TnsdMS6jwKXggdN0{0eoHa$FXZy_jR)5o zU|1jix(>*hYXOkE0V(!%_u_QEQ89pn(N?`o+VTp?x{?ppJlthkbY%?x?q(~^k77*q zRoCpb=!0R5Mv7@`W7#~a>ec|fd&?8V^yMGdP zF`YGqc;2q6B?6BJ!!Y$g1C3hn)xIwnW0`y#VW?KyeIX-70SKBQ?#B^BX6rYkX!=8v8_9oC`~0mkmqDn-N;(ncc9! z+uKPUv%wISf{N799MbZ2py(b^;+;(l4vR8Y76*H^R&KDejZc*#R!$}YIxKoZ_oOv; zlT&i{3?)I{w)l4janqb>N_=sUYL-3Y&B!g?40UheS(24PhwL639(;1O8P->d$e%}Z zY=#EyPK_jwB1TcfFr7b8CHlvyq#1H`ahdS9k2A?_%;mr%Kc}xzM4k zyE;Yj9;3t0%GF_h+j>q&;XihIQzVoi9q@bX*uw7ZuZor^@Ijis!Y%;|JzkYL;a^c> zR9%&>Hy!OU;8WsSg7UT_yZycOj_K1@03d zmc|(1f5YH{cz{i-NaMH+$OvD=M1Ts@T>9W0J8nt4p9P;jb_O$lm8h6LkeV%S_+2R0 zx&8YuZ`gvYqO}W**AMxf{zZt+u-)Y#-Ir3Gx-B8BghYa*a4)gH&9a!6&do}}RKswL zq#@XzA8_z(Vo)$rEOZ*eJ<;h`@pp( z5KwAf?LDt9rGS4I*nN9G$7DmmGNl!A$0{^)`aABKA z59wd&|0kVVdmml(g4c^rh3c$g2<4rR<%Nof1RI=VwrcnZp;|w4~~$ z$*xiaPv1ItO7(YZjWyVDC%qi_vR%T6Q-p2QoWXnzUABuYq>TaA$h-+ieJw1&(j3+h zSjz1jZd&UC_dgz#a%6j((~JfI5)3Jklg)}4j#^By$dxW_>moLsTsz7vE~BS6@=SPF zFN=@ZZ+RyU$L4RZR@lEs5j(o0(UIm!N3v0c#ODv8b441l!18}!L`C3 zn)^1CoF^jiO~hPHbOg?Xtc^2zI*+E%%Sr`4Y{bzvw3D4u46Ms%$%OmZL_0?_EWA3q_Ffb5r`m%QmIJN z?r*}7`;P*+I$bgNmekOtdfFMnuEZ*1wTphi@~f&TKO z$C>$=d;%_lkJbk2x^p)&LAKr2ms`?jH4C4Gv!1D0P-zeYHcz{<^Ig+X|D{BcKN?MV zr#w6rADa!sItuh`sQ;D2tgFP1H!PG$&Jrf3X!S2mXWKZ14$r{nEl4{DSEtHyG|ncG zm)jJ$`wVI;=oBu&PUN=?U2CC%}`s5S`(-WrX#% zt>fTb4AkQTg(UW2qT}X8OKfNnjAe?d^?V4bA8LighV#OozU3u#G-4a=M&F-lae+4P z!-XhR%2M~xLWMY`R5C{CT4%Ji+ZZOFo9w9ej5v@Nx^(Y50w$_!hJZQL{WYbw7C2QD%SO%`% z=`J9|h|u@spkM>vyD4C07_`quYx!uUv*1UT&NCj)-Nhnn+n64P6l(Jbg!_htxs$?Z z7=pwQOnA4r<4miu=fm#lzoRTPT-E&c{%y|()!6@^;0llJ<@YSx(Qws!b*lMIf*bB8 z_@(hj9Y#n zBT|fG=1P%$stkxzM+E&fqAUHz{>4X+exqnL$ZAPW+usQ>ODJ0l*+uus=N3!NFv2L1 z-u{8(6WK$L6L}VfY-xB93C)ppO6p3GdWkme=u{?u#L*ls^_OE@tJboomONazce-Eg z&pNksN;$QvcyPBm3dctzU(@+7J3}^m>NcT={bHIHqB5h{v38uf)Qv-Zx}SVcbn(>q z^_{@Byfk9^mI|p7YTyb=eYs+8epa?N7u!b5HzdK>a)HMO(d_yLO%g;YGEI_sfS5Td8vETRieSN`W=HnBC zWl31@^j9zfs*_;J=k>qTwO**suHO5y5guunu&*Tv6LAPdg8_nsG?KJG=HPN=DXsj_m>S$B`>;Rv^EO^kN$A(h!(oJkyRDV`?|}Y}#s1AScIh(i z{3Wkk22IFiP8S+R`EMh#wk)Wmf;vT0V^ncNOMghPCnkR04zbR$WL){w;$k2f{Rv#0 zSJ@oMk~o=e7-SFZnc>+QbL5WMH{3In~|u7Y#hQ zzI*6#S1#dqqd>)M;qTW9a$G%K$_SW`pfK!hJ|wViEu*1Y^7km ztGD}g?#EY1hza<0i7RdIpDTHj3d0aKI@hRlykC5fG0;j;%`pz3&U?b^*p}K;h$|~Y z$3J@5Q@x4$Fu`ND`9n@;_$=#=>?H_)-J88uek%w=E$ zJIChnP|@vI4CS)qab=|2Fufk#RLCSvC10?&a4>R0art23W?}s!4l*+*1}~6>Vw4|k z5wU{lpDtHkovfgpTva*LtE`a%A4 z9~m{|VdnkF+_xw)@0{^6#rfUw?Tx1tdHc<@G8i5eyp*5nu! zUwIObA={K8%mxL&Lr}yk)Pxr@GLT@z7Hre;JVjRhm1fAE$s2uk*)75M+5gH|h^VkZ z9CAoOLjn`@U9{LLBhvxTJzQj2PpPW(od1%eO{a>F!Moe3-&bW48%;6rON*^?E8j`7 z%ycV^eu`OK@p#xz0E`Xc;?oRDZSI4hw@DGEb| zH;&zxI`&$IvxQu^@C$w<>{dS$lgil85;G4F^SKDJ4EzjQ_V}8a0+tvzJ7tfp>7B`Bj7FS2)wP(g{<77jqcx zEowk~2$iJpLrc6EGe7QYRRA%-2LBpGW)4c~)7&SD^$tkp^nALyl3mXiQxTthQ_{;U zO6?kcSZY**6vXouR5L%%UxZGO+5I{`UdfBekAc~uz1nXxS3!;@#U8F;~I5D|QJSU5EFVT?2<>4VJ^*Zf9@aA2rjH z8xbKT&8Gj}E}>FLR+%)m{#+%2om1!*r;%vB))$6EnW^2Ar>Zzt7(Z@r zDMjg;i`8Tan^vrOme$y5FzO(fJDOq>cm|gWKeqhq~-picDPh&Li$j&yE(HlhOQm@v}k}J!1GqECS zbi8R3j607Rb2I6oz%ej%Q|vZqRTL9Jq6smRVRDx(5Y5kFv(T)K?C8ep#t zXcM(6FJ%qiv*?OQzan>#k`(MVTxp!SjP4@Hf4!q;e~)cfK>XmKFBmnE z6Qi0j1Xz0T-fWX*Q8=Qp(Cqr_9e#4G4q)o86!)JEcK-s^ieUPw3aXIQ^35hM(ug2{ z;s3v_z;pL8yNJe@Ez^l1`z|Bp&!}WS*H3!?E=_~np5cUYmV3FeR&G0Ln&nW5Pu;`Y z#PA6@4N=7qZ;>y}(b9rixUDsUx+HWev3TB7i`ty>Z2>_O)qa^Bk2l(24sFGM?Oqmu zKk-zlCWXeJ9wg>2O+$Ih)^iFnH-TEepbzLKN!-lqso0qI!EfI1X-kWXs67T( z?(PSq^*_gXKld#;0{khAl~5cnKQP&5P z@*p`dbDOM#q5 zKG=KTqpq2HDS&Q`P8Vkz1k$Q zxMqM#Yru%+KJFN#lwr0;KBRM&6)XM17IY4CWH?25Ck!L9ab6k}pM*;J{hpenjAn4s zA5K}L_w+C?YGx}#d!Aq%FoXupFU+Hs!waQLe^DHEB~Q7wlUio)1&HWF*@!1;PoJytm5@ zj%_t^>co%+jqg8#Y^Eh6w`)G*%`ej~<0%mQbqu{6ab{ZT3bsUYE=ZuCX0 zj}yD4%zP1>iE{SvR!<9&yZ!uB*!(iK|GRzxvCRKlt3;qi z*X*nNL79dD`3#F?3MrV@{=fH)*<%p zc3pxZ>O-Ku6(>R>sgj=mifpv_Dlhe&3XCOt33+2d6XcY^gY*{3T1Lb=@DIbs-=uIK z4t^6xyRXM#!ukX91I-`cv5C8Ay zgSCBGUB`mJy@l<46PL^xMPQxpN%59Pbi6|@fYA&yz?J$=PfxOMc3IYT;*MJ5ID)*CN?4K(#or4joAoaq?sp zwmBs9@kI6V;U)KkH0!p(o-GZUifqU{ZrZnrGGj9ULKl|O>vlA+!TvXx9x5oc#0oMd z6Jd-1uPv!fhj?s@vO1}h#^liRaLFwrSX?($ryriJFJGneNG@NsvUA=o z3uU>zml_)uuX<-w%@hQt@hy)tficaV6=sWjf6F+xDFz+8{F@v0(Q5PQ#JJokV(BBm z8J4=99dBM?%QGTkuIBT+RE$#Co1=8rxUDZ470Z*PN1H&JE|t$^Ke&gQ%hKXrMp~=F&{hJ zg!|jEk)dlPP4)5TS=_vDHe*??Kz6H^yVq6XbER?WTE;Nr%v#ynL8i_;g4FYIzo2yGFnwC#vANssxlymr z4qBPBW>b-bIl}?|XV8!Srd6Cm*M)SOlAiKG3PSyw>bou}^*~1q7!d(d9omp#eVqL& z%J6SGART9LkXRRV8E~T+q!;~UdUC$Xjh*i6b`!d8Y)9#sU$S8ColBMd{CT8~?pV9t zcyb`^C;Bsc{os#LPBt4Vfa3{c(o((Fa+wBGLo3YR0ak$aQ^nl0m~53$Njn`x<}EC% zsv2>Mw=sBaIWJcGynAhNv7czl&qrkLB^ix{7Qvw067h~Y?WcAlch;bhVOzd5)m4Lw zz9x%`mw7;XSe0_;%tt_&HicQVKUyH1#W^6C3=M0PSC1CZB30_AZy9u(vl2Byn2^_+)#CN&8aQ4nzC!_;bWHL?lXZYE zX*Nq93wS0e$i{0ohZstb2v80ROWSc$^QOVlKRK)^HU+d*dvS4u<9bYy(zsMGH3;ICFQ)TXhi z4K=Xree6-r4%XzgG+H#Gg_?pK@|(ZtT}A1Jw4_;o1oEUgladJOA7g@kWlXT3 zQReCQab>-Izw7GD8EWOr_>c{AeBTYFsKCSL7__sciF1&wOv{i|^v2T)Kr12j*Awot z3x+N(@=|9en}1uuMXa8Sb3(_6cXCcW+ec!VZUW2wIrrHEyT=jR*hojit$9Wng;Yr# z^^o)35@Al2(+3SrtUB)nkU)O8Y*^B<-bL~GEQ%W$hf3>`4((V~VCXtW9H}O3r)sP3 z9CRzD?~1q1jT4oAb|T>ItXN`yyWHq;fXKO35gJWovGZeJCfuD>>cjIWwVDs`QkFDY zM>WI&d|eL>_*U5f`gI zxbk64ea`ksMZayvfxAPIOs(p23w)lB^;MX8xJLI$^1Z(5djM$AE9wNQ{m!dwoMiYL znFkEXLjz=+7+ie&nm}1t-K$&;ZASmF)E(hyZO9UX%jVd?6dYlezWV0pvxDEs_{TNd z^{80CZXHTO5M@6=E+b-D(+2V5CTg+j9(PNtyHg08tTp;W6ISuAa;-mUR=m$uX#ce& z*@UvEq3N(-@kr(k_@U;jnG;ICB8ulJJ^Tn{8rWsRH&wAqCsxHV+2aelKWnQk`ch@J zAThC56Rs;vzMx6&h9&#{vxZGZnG?FVCFm9;b}F)Putx_{EOFB#=%wnpU@q z^<<_9)zIH;*!X=Q&y?g*|1lnBfj{FN6fIOk6ALreGb4av|ZP>jw9sfdZRG*dc*9&xePC z(mnWMEX-vYB%1(4`Bj5m*{IjC(^7t1=PWX`YFAC&Xs}I@w!9#N7RUm+fY@@p$SWqW z?Rn*lcpPD#{=SB+I0)y1hUG(}JA;_14IG)a86MRBmPTzH-9KbKg7qqewb2WDo=3$_ zV=%LDUqslwq;`3;lwYv*M|8h%_#CE;2B|(}KT1BVncbK!h<5$slR$03f2|QZRVF)G zlGdLBpoW?ONLd^iQ<^2E?X~yJE6E+$N|4b#n5|?M8|k^wtP!a$GJY5 zBEh?EHsKQVKn>4H=?=Yb2r7RK3P-E*+ZHx+c%& zgL0AQ0NBJ5VqmOS{@sd7k{(FG#)ww|Uf+!j{L(79A3|>1|A_Q(uGlS?9ExA0_=_U@ zIk~KL{&u){e{oVa)WIM{gzH~)a{^!IqR4Gpvz{f^rX`GME_?H5JuoItJkGMoG$IxL zM$)hhk_WNGciHD;+&^84n9>xmgeGgx66fZE~2bhg;C>PFE-0PsMf4&M~nn z-w(r&yKXUOZH}lR4iIRU!N9%A8BB&trBRv_*AKbPa(|k*TS}@k4)2Khiz=D3sYH8( z+J!&Qhna71#beLMykG7m&ttS4%Z2kZPh05ajImyqs4Y4=az0#;K@Xa$@wckNbi`=9 z6XmwUK5^2iP2y}1=1Q?zjK|qFkab;1ZKNAT33|=m)VV@D5fD4{h-ey~7mjtlb-|LD z%2;4TFLR>{rBqM+%#aKYlKOlaBuIue+uV>GlfQK`bhb|1<5k7=FeKyU`K1{WZ1U)Yblj$#`LaEUvynRXzfP{+%yL zjbhU4_Zwa=`|!qHaWDl6i5tiW9-5({F`IlBwVB*n} zlaEW&2C>o+Y{DRYGPmR6?ws@G%WcB8+!%<{Z-s-?L%BL{H2pU5d`)6No43@|*FH<)=&PLT_`>8T)y#2BtJ_3f9mg^Xx^3riebdrzkq z?#kH+=vGan#yfuuDJ4KCmSBgoj#uvlSGAg%6&$@p>9Nxo)biL`(qfr$#U zIOu^54)@pS^^JfPcCpfDyTnzTiYC)07TRmvfFU2wBVMWz1fX_~?CA`B``5CKf`QZh zu|&(@Co;Gy_x7(0TIXZ;jo8EPAe*XZ_wx>o5e{K?x z(zn-kFJaJB#{Z|Vln&YVOk}eor>(quFRLGTshSZpN#gqn3eCJnS^K5JYW${x@tXq} z4V(SLeG9MPq?u>=@!$s??87MGHbL79?&@DV0n(1E{)%vP83QopY(j0M&|;B&$0a3JiiWuuZsU@vWLjT8*!2#3NlP;pQ)y9!J<`mH;IBg_5SJt zn`-d)LgX|H?$%|=G`+u?V*K9$7N+NY&fqfo^AVBr-)x1-hRq^HpJTH9^VsW|gYsfq zgbj;_``d1jm$UjE5mfKXojqTP?1emCN$P)!8bB=wp*%#&4n}o9&>*yPzeM0jbJ?NY zu1a#n4xSOS-gUV@a17vUa~7hMh#%aX%reoPP{K#pIx?jY{T&R*p~U=sbg{3*PUIX-SISX=xl1Q;&Vz&lBXp}aJ)KK zYI)MqY)f@}bA0ILShp8Q@dl1eE$z?eIapoblJ3&bz|+_IdUk27uMbKI0&kMKBz-dkza^)dM-KBQP*h%hedL)My(ERV$_;b{ZtI}d;&)?-@6d`O zW;54LaI4=qs1b3opaedS+dIMzfhlEj4CM(*yyr(`_%OWy-xKFM<1DLt`7xH$zR80w zIVf3|LiFvY--`;sF#yo3=a^~izo?r80m;0WW7={8@;SVX#leWE3~i1jectYK{u3i; z>DD^T%`UY!(eaVx`C{yVPhjVHXnuc(hD=6>n*HAoAVSYZzm|sE>&k-qAZ(dgTOD3= zE!$qt8Adg5r`wvgDv=e~GF_xFjL<5Iu1VQ|`Z9*Klm>gJwCOT)j)b+6;mI*@@FNl?pW@DE$SVrLf>;`{gjvj zLTFW`q-v(@w~4vtA=`1Ps^(@6J{cuVT_l=$af#lLG|R~~h&b0zwfEex)7MU|jkLN* z(1%fP;@?yA@cJTRD5z`4| z_W$EGLAJN)6YDM#x?gdl9cTEn)amRSnDw-gQmVL?KW9uK`>z<67{6kxNEX|WOdWUg z@ZR|ZT#7VGb7Q+i6LdPT+RnW9q(ZZ}ow4ZCJ5vGqQ`)hH}cO||OjYO-DL;=J2gGN`mksmdH z$AA(r6nR43A;tCHckwE~2DN2qH4bhY=yr}`gUoT}hCiiey(LvV^%M&do zJHg!6no<_ck$st!147D~qM{)Fsv+S1(-1!S1YPy6`$lC6@ut=eJPO_7J~dAg7w+h7 zeJvkF{-5+z4}MM0sey_!)rk8iT=&Duer@5(DSM%Lwoz6YY+bFK0d_OQrp$-4qc!;| z`HZV5WIi-JjF|CV8B)eJ*JVlWVrc2dKz*De?#d+*DjP<2kAKBMze^5e!`$T(vnfc% z&{+5Ucz$Wg5R&??ltuWIcSiV6t@~3Hs@> zm3&7UFm6&dP(3vzR*OVMI0Tm8DXk3qv8i3PWrCj|5Z=+FVLuRVOX?g-MPhk{$AGKx z`E%rNu{sH6a;~PW0d*kd9fh_S5Kq{EYw=fIET1f^ONPexlI&_} zxSRw3j7rDubWtMg)GPetbv%ohkkTVT{a>nbzNYG2mAglF^~?2q0>pJK2tj?kOinU- zNda_yfhK8HUN@yWXAjSrEll{)!$=64b7bUASzY{R7xbp7&CNg1Xp_|Qw|$^VeO+Bm zo17LVQ{BPijTuHIFPYiggFjlIkIkB*84V=>)IiYX5Y!6;!{K~Fe{ZX(+|ViZWOMgR zaLLJ@pwr<3dZ0>ABbqnNR>{nZ-Q{>OcegVPBOyrL8@n+`*xA=tJNjoNhr}N<9+wre zgLUR1aL{wVxzj?o$WGJ`OH{oSdZT@$y6Uiq?k0F{Q?s+y8(KV#6-Cj`lrliu5Ps*Pkyr8G)+_X9ygqp<<~z}P}u=PSa6$R^z;lLS%;XHj_b zgo4CTz*}*7FvMg^vVC6qkth!rCL(M}mD*;%c}h_X?N7g;QghTT`L}lgKy}!jV?x&N zl&KHum3g6I8eM>ubLGm5xgRo)yDQxzKIdjpVWidCJhIp3I?r= zaw|o#_Ktwrv2nEsC5rgUJ}yHJ>HyGCY5aaqUl;K%?bpmuC&csTN2!K7JQ_7GB^Lfx zgVH47Zsf=953?+0Y|k8aSSIfe@?D+CmKh@jopPMlrO1k5#Qtmhv||6nE(zYtda_^D zcEQ6Ef8WnPV*1=CgniYGj+u&D_X+suA&)Fs^72inIP5l3Z}Kgp_A5;b6n1$JCgyK#r3v4{ z2`4%ElFkMU{apEq37DxUb3kIhPCI@v!XnyuqTj)uKW0$-?b*AFHBZnKi(M!tjHS_1 zwBlzfJAD|-_Gx~2o^{_EZU0%~c zqf~OgIiaF0pz3#2JpmNz*f$kC-%vjY66Dz@BVj$bt|+w2*uFWRPs}UJ5SJG^3c_Kz zK#KEfZzEENmJmEvdu-az+9`Wl+4=k5VTXNnG2PPNPy8w-^9d}{T;hF5GTSeWy-jO4 z$j=r$rv>Nps@ZsaH}E|9P+Djfn9TSepC!Zs_^f3|S(2B6Qrn&4cPYMr(9eT&kWyJ4 za#LzH0Xe|7sFGYYX)QonY=z@{5f*>=xM8kW5ol5Arb=WM(HB_?+4!v^%S?@)b4StM z32A3pe4YlT&hq-+r{Ktm@u^Culwq^mUn-{>kxfm?1%ALLiY%&jy8!ENtTvfMMMe5g zu>8VtOaKZryC+uiLNj5P>d>=_(q4O4ZEk1zem)YdVm!0Emp;R1{;I8Zp)MMz4;qD7 zlY4{*>ohnG=+Czio_Y7MmbX8Cva5giu9#7}EV@%y+8DFsq<-aK_^!=2^Szi@seEy! zo6VP5Mzxi9mX$>|1;|};^ONd7_J`>Zp?N9%pD}#aZK&6hja$nP2=92&`T_XtnrVK? z)f_80CnGOZkF#%cIc-aQbHurplD0wN^ZgxLo!-B~3}|VHodVT;zgfB^248$lLDr+6 z<$i&)vT{B{pYh=M2U&L8K0L%46oqNX_H27_)V2QOYk|V86hLn8_=Z@X-r=wNXksxg zrFq>PDfcIE8CEDl237GrTy;*~%!!*!N`#??Ml{?hS0*r?Z}ToVk1@)Y?@u;F6didSnjZ zH)hZ)X3;BJ{%%gTzbsN4`VsjQESz<#n7~9#ZAU5P^Sr#>x`hrcvTJTjeX8$f8Voa1 zc{ZLA>}h<62MS$TZj$co#x{IINh4evCMZ$foHj##)~&eUk~jIIkrCekPJ-+}NyNsu z5I52;B&#W)0TH+*K%N0ja>6lU1a)iF-PAHu2 zGN-@e9EVJ~8GQ5>^|5(D|5S*0fH$)s#aNs5Rz8dn+$|jc{!!NY4aRU7ervqvI}6B1d>pm?QfwmL?RC z7_oJKLAd1dR`|r+KNz3Vbmeqsg?Y;0vvMteIOoFnytC%}G;g6Mgls~qHYb%_LntNp zW&_>Z@&kaV8^goC*Ms8Fp)f6R7?RVJ&UQwQMdatF{%A-e146v4P&Ej9wkvHV!z6Hu z78r5ljaMurXh{GgQgucXnSY1E@fEFfR7J*Sy{zP41v=92=NB9LCZlWHFP>-KLxCUq zqbw(nv%S-O|9T{(dwGy#SpSoT0lgjY6{4u{8YC?VQlq*f0Ao{se;sMG+x6^JmTOo< zFyw+k+#F^nUmy<0L_)3#DoVj5%+B&UKFq2^3rRwy7a247vtR)<14P(7jqV0_-~aT! zElI54c+1^r{C0#P(pl{Iqsio?&FXko5*P9@zj#*tDLwZzzaDvH{SvyRa&X=K;VCy5 z9M`UtE_!W&tAtBu9E!B*ZB>}-qqhwEDX|FsU1BO|@YvuTEk_&kVJoUeMH-~*VXF^Z zKo>IKr{R)ir6ytlEnz6=^DdDV@b25POJkdFpSEkw7Guzo2Fdkobt$67WdgI>vZaqa z*WW*6H)XRg2`2*+9$_8WUfB!w1P!}PD!-MOqb9`ZDxpZ+X<^U&dt z`u@lI;#XJn__m3cE7JbfHtBx`_Z2K4<*OOC^9fRad65QZ;kC=#7;beJNeVuai25p# z;do9W=N6MwWdDa|z|d@nYS$?(?-gH7>$tJv*n{X^Vhh9?szxBQuXwC)F$a5;tEPUs z+;KS`mobz6tu=lMekw_~1>G)SV{WT{5LLyd%jhva>M_npd*Fds2fwEUFc8ONkn876 zUAhU&Y+z`#-R7FcWiMZIGGHM=+TwPk1YB5P2K+6dl5eaD);(zUp9dmACmhg4O0cz4 zQ2ze#A7D9Cu{NMWr~6C_fJtHgxT*F#(3>a?iIekg#gfNqc$`mVYow5R>+x37YgT1$ znQ~>kk$e_*e#HgnlYME@1r7SH(G(l@&PZakf4B)n3RH43;@5WA(bJ;w1W$+du2i@jjV^$+AMwV39c zWqf&p*@ogcjIIe2S!JeDjLFN6XGV%OoLC8rF_w3A2^dt#2zXp%7E?l*_4A}y#pg3T zX-_Vc8oVfYe@a@oxl!zos{9Sm&tU1&Ju~FHhn9?%f z9J@LmQ0hBAz?0BANcp^kjxwv?E}xWKdRUw>*lDKzEv|~>-j)fvqz}=Ni;vf$><-ct zcw7*4DoZoJ#IEWqnrU&9Ij10){l(|q`W#0ou8)WgTPazRZMV|<(^DI2O4dIxPpaV& zU`+4OT9qJ7B>2b`cD>RIf-eVq^e?D8sDQgg*odoVSWE6Gn#JDm=cIWWbW<-N_wkg5 zse6Cj2jTl1UV9W60A29h@BBB>C=oR_tE1tQ0Jw2ov2d3BA`Rd(EU9{ zL75kON8W@POSI0*mkZdZ9VatL*6GUFj&IOWT0wB>DsidS)kiL{c8kk zwA5%}qnrR$H7EmsGuQJyB3P zeUh_ueVVr^UVzruF(}OK)SoT8%b#aK{`dGySuw{(;%G! zo05`}?(Q@2`JWrE_676KJ8M0$!q$0gFS~HDajA0zJdtpJI&z8tmGB)RbEL5O9W*Fd zaEy*#&R0>^ZXnc`?mF5lNIV$~A>#J&i{S!(k&mT03A6qFr|iQA%U^8?G{dgMfa-cR zHR%89O=rI(+zG<9J*5s|qnoFh1kK2)>34z>!BcH{_bhGFQ9fI6A?<=s%Sk&m%Mt(U z4FTSq{R>fTsd6aDBnIPDi-O_yb`s&-M(OERXO7$G7G2gFfIbD$g|S^acGp>At6-22<>O_gl~p;6`3Vg| zp*fR@q5&u~=?hbFLX+Fy(bV7H6dNDP7F*{|%00M5ADF@T&IPR=`u|bdsRh@`qon07cNl-{GvP8yd zR1sb7Gq|z~o1>1mI)VB8#A<}io5-v(IKjR|GfDX^gA?>61jvWj_A)zvnn{oypaA<} z;o-%dJ76pxPfv}<3K+riaKubLsp71nnGT?Ksk?VBSsUmGq{4ty-!@SrRIpuABx9=8 zAgAUq?84XUQnJ_FUkI?Vx$NCq2Gv7(@|-Y8LWF3#v51jcXc8*% zdDC58+1t`Q9O1+M5anhcy*c%4y~20Myf%;L|JE{m-)um)&Bz0oyPIXS11vA*F0h{6 z1GZ&2@c9_-%Y%ba{d{T~$#WX%l&RG0fOX%x$guUl^Oq2QDba%{{h)&eV|@4{)lAn< z-iq5*J}qH_2rb!i-8>!Jbc3HR-s&@b@L%WOy+fNMdv^uj$Bt% zOp)UJC0#yU5Z-tRQdDBj_9UiALQ=dN-WO)Y1G$6|$$x6*w397IoWYcCZGnaZvw>I7 zNCe9Z8$7YDwBy1VrKh#!7=ymzFWS-&a3pu}_&4vFAgQBe^hMImeGE*XvwkjkQ!erG zXE8V$$CjJ2yhmK%!&_b58bZ0{tOWOByuC1cQVY}dUj??m_Vf#?m@Q$0z2+cQP^M7L zno~Gfz#g*5BhNU))S?d#`%8oTt43uZkPAdj zyT&%}E^SxK@6y4?BUXl)Tf@87gEjC_L-2k+V&3}Eo=wxmS0XKkmSv;*nUK-dF0O8w zC+SH9#g2=Eh+7=p69R-c?$B5Bns#$@^(wirQv(U`pB5rs0TB-c&}kCcg>TQvCH?M6 zsd46E3;$qsLefXmg=#RmX#ckEAPm zNS8MWa#*3_^A&|G?wcBYE0OYWa$u;r1Qe0pYb_<6)2`ul!iufloG6@a#bcMmqvGCs@76Vldmdo}AMAywy=SCyJkhpFEbL4P@H%rbey!Ou>d z$BaRPt2h1|_b+=z>V*KfV@!`zb^D4L3@V{C#Soe5r%sKr1Ytljx1z(Gi9>kfmN$zW zDWrlYmPa{Ls@HniML8kYPyXg-*`F9S8kiB%O1rSv1g{EE=_cp_UXs0*c%;-TEi(f^ zl3ah@duJ8Wh=}mX543bmO|A5!=Il#jhu~>@{%V!v3|Yp1Uq^!9i!R@zQMzpUHd9DR zS=s8NgLUp5rF^oqIu=y5f9i$*CPImSxh?97AeUSvq5i#{)zD`(ux}XqX?;#!0{=NX zR+e_VC6uk$k7BN}gg)7>!XSF{R@@Gcgai49oWx|D=4WH`os~ufW~hbj6;RxFrFJnf zt?#igLTd(|+Br?Ohar%x(JnWETN*UfIgOo{H{!_MXjy!${?<60QBpCUWL&c_>}86L zANo2cyi7ulF%@>X#;m_PAry-^tH_&qJ}8r|`wY3FaV2iXF&~xd#Lwbw>s}wC=NKB&#K57y>sWf#sHNwS_!c5T{hxWB_{BXY<=M| zrxYKCD9rr%m7yV(;=SvkY&iiwiRN^rAxYPE_3^yST#>dnFvlcy?g{sBk7n`8 zXHQ#YDIox2>dN4U5?Bif$kEk!V;l$aPu$r%8=YPW^~3$n5`7SCg^5u4E0QFGeU?K3 z&tu;zjkFr;B=2Ej_Kj61`Vch=W|!+B&&2o!( z^uI0I&0zO}Ru&djv26I<6YHF2%!oy@AJDqkClee=ktdvHy>a~W$@v|!uQFAplq(PS zP(|eAp=y5cHtv@!#tAC=nw#mq-sH2F!&KGBTqVo!cqF>jO{M#QURWU&HPvCSvY!Cu zu@L+kZ?;}CY{DXT%!Z5vnMMIzfikpEYc@-&xH%<+#H{FhzFM08t0W{x+K4{=O;miw ztBc|rAW4y&sELW4)m5rK1pSn~+{SN{Z9Ntc2f8FflADVcTXmt87Cv)+po_I8Zx-hw zXr&kY%q}yAbL~;`xRUo}pfEAEtn6Z2_s1@sUbtlc{C7vE*!_r#-^&(@jfFdbc6k}6 zBecrLtZ3t273T|ZjS=D-r5#k(LAK)xgUV)IRu6qU~Yx-P824ldn5F)Qd8LPbeY5Kce15dQARqYnj<|uQV}b? zVk~*4<*1C{p|JfS^xv|CGbzt!k6RXEb~(VRyHp=5D!`ncI?MHndw2GBy5F>m0bL4R zU;GI?l@GcT>lU()99!&=PBShXUm7v~6B*oq;`b!3M$?N?(}7)F=}LpQ(>YcAa!TH9 z?GQG%Is}zVHm!>bkmMB(rXY?;pKA`MSz9>5p`a6h%V?h1q6W6Ml%=LZ_aVmR!9MNr2R)ZsjOwE< ze{nTHn8tEvJ-(Rwb3xI!U^rDsNL0snQ2&@?3Z6DKD2e;jmQH&^q+*J^Ng|z@9wqfHLzU%PDDiI$B*+)$faw!jSc*? zpDr3W4cMjgBW?k0Jxild5eCHhyWM)Wa>I!k^ypt(>1(}l`%=s2zV>k}*4304HY`ZdpKSjhyNoWoJAMzm*p; z6eWvT%$Acr_@PVZhjWilb*KK%_S|g0T-2+`+wZD2k&#nVV0GOF8f#jQ>tova8BNb{ zebPdRIYOAzEP_UbcC*EP>-KoR*m>zoguaod6$|UKiRaaC{38W^EOi0Gu#^xc%xH%9 z{DEqr=TVa|iwQ-}bi%7po~!ykaM8a4JO;SmP$`%r7WaxAh!F3r!xWhWT{!lMYW~K4 z9SZUO-0EF<{;4W8VJpEkmsf>$q2l0E z^?bCpQ_`OZ%R_>pmhXUUZDrBCxje}lXyEs=pPkqOj2%ND@(yD{Qu+FQ5o5!Q_b!2q z`+JyyTwjq#zWw`axAYft(wur2iYw$8PHVV4qkuzNTVW)8pwSpZ!AkBmYWGl{JVQc2 zJU=Vtc;5VP;q*Z}lCA!>JM*363RSR!YQ7;@ua+dzoG&J$cR)rDtK_4&KRT}DGL}H& zIO2_&La`4Ml|e~RdXvnozK0DRg|H~G#c2L`#O@E|ydL;P zU#I5`JwlH5XG23LRaU-=A8xc~`D7a2twXM)ic!-dB9}-YcWHRq5jsy$IcYLbZZKL55}26sgbJ58d6T19Feu^ZSN6v;SqBZTLadeBRD3m)Z8)rj^{KCH)Sq zrz=en~}eoN1*w_FQEaX>6EJn@-lL`6l3wbMsf>Bh7`eb zjkE;04a8%i=?wJM-?{#D`}N)*Pm3~`FUa~@(!wUs|J;6Da?_9COQeklvEyu_#k zwR3uc6ve4A9sbWIkG^oI1m$bND8ff;kl$o~9<=HgYz?{pdkr%Z!terGZa8Qjgrs>| z9oKYQSvsAklpZI}t7ZZu>w>%w(^bn9_o@TCC2(0e-CezlS1YWlt~q-Ef^0^E8gD{MR5;) z!U@vajG|T5D$L|Un4V+unUea9u81QE*DolC5I+3u*&lPxLZ0+w$E=TJkR$p5k|b{# zM!NSDZ?GLE;uK?Fb8-}@m*___RpI$~X;7K&w5k0sb8i9dZvtA)INJ7{r1?pP-l-8> zxTc$z4pUhI*Li&j8A?+&t3JtRZ$xS~E_%f#(B!#-e(6EU|7T2m09uxzOGH?{5WBEH zt$4;0lTKX2Yg$xXFR4A_INXwqq&cBg6Kt#l1${|E&61e7Rdj^iL}mTD7|!*Mw3r^Y z30z+x2IZn0#SXyrq2t-=^bA7tZ6<#q|hnX;OWOAY9jz{WI1 zy{r(oqx1_|A}s%f*UBr~k;4u)bF|9=>lu6g4)UuJg|_an&9We^n?L^iODY+HGt~(N z4u|%8&Oup1mnEO`d7+1SQITER3>G|HA4xv}-Ay`LCLI>$wsL=0tcIF7FZBf?A?(5X znvOzdc|r0iq?{Pwn2XS*^Xo2FX7E!((w;jd;L=jm!;-Zf8*5TgP_^nM(gn2rYj)m5 z$tZ^@)xs8YG)R@|OB^{8lgDvl8N!quI|U64{U?RO_|N=z;&r0ONa?gn1xW~#T817G zK1Qq_^d7fJs8e5OTyqbz?)f}UC$2YbWNWtm2FfL-0SfHL7_QfE z2`QZqL}Fjk*SoW?QIo^(pabWfO_bL9Ib=M&Mclt8E#Ah8oYc4DO;c6TYy{!X+5Pq> zYjR-)q;xJ@ukapQbdbyT8^lTjxiy2<3yq-`WTjpMWxCYP?Y+cE)AomV<%N;mRCj$bjuJ=sI`+CVVcyES7d6x?x|!O?;vI~wm}Z>- zi30OOp^apaMobo*x@*}5sS<=5Mms3};8IUqC-NM8M%*HCI@W>hPh%nZDooOoiiy)L z3Eb)N9k&IV|8ReGEr7AMF^<==yb>~R`lqP0&LKUX^psThaNqr^TkSMgx}0w^%8~l| zcZ}O=2X5k*+N#b{=kxiyshkP>uM3Dg1~1qFh-r*KG^eW4r?;{shZ=I;rt`kEUZX*@ z`z@ZstQXoi6iQ~y(O)1XN#}m|!Ta+Q0d?>@H5MXrBQ}vko0bxXIZoc|D}>=1bK~iQ z54Y~BK93z4;FURvwG2M`X8R03J#r|r3u7ht+Mg`fc%^>2s65x%f7lTZlDxi44wgS~ zZf1;zM=)dPq>D|;828}vqyX(bu?XMk+g)hOOdK9HT~yyh`X}gX$=!ywYi3p-ZHH`b zA@YCAjrWv4A+O3exY0&0kMUGM8M3W&RMe?qTMHh#M9>_Yhow32baMiB)MzGOn@$n) zfT)0H&Avhh{sY%hGyHI&wx|` zdLR|mb^ITEIl%$0@{rz~oNnt6i1M+&s~%gXai%^0*XY(}RMwgR7;X!Bb1eqUSc>SKmnJzCNwjBUD zc(>A@I=GU+OB7!Tzt3gX^!F-#w38>PWvdP&o&C(#uaiJ~|4+I}eCa7H^*ioel-h~u zfScYEjpfI+gFLZ=uwh?qMe5{Pso;C*z_SjAUYL`)tR6ED=!6Y)!41!H}d=fIZ?~2yfiRscIU~ zt59=U5#z+XGHixZZs#ICo138*+wZ38#sh`pOm>wUbH>cSNGUP^qm?=OU3CUBg?MLI zhw9qHQ_iVhH^NyGZ;aKE7ix<{sZy+4%}Q7VTGb(&Qoen1ON~eKw;<2Ue3@|cE^gi= zHlH6BoS8M$Pa>Pg2T`RpQ_XMAD+a5$xUEh=^=+X7v3X0X|WDN)* z{JXTNz@=?xFo>P+GySr8g6^^571~0{Dtoyk7WLTYn{$s?&PmTFKJhTAmY?Fd=e(~` zLa!PQyv&y>L1aqhBPwO&uM(-Ve!zLeP+WeAdmeQ7&Tokk;J1v&b^SL@R^ZFy;p!>o zKE5ofy^5=EN&7v$*8{V4YLv=(L|J`JQ38eMHG??`mIubj4+z?iBl7ZeTO`tgT$_fV z3Yd@kmOU_u!T$C>@EA^1AzKoDRbS5nQR%$5WMu>ta?oHCD}ys_`>5X21Uj7LpKveA zh^{sLh73T`bX30g|KpTz7^s>cbgVdJdx?LzpGW2^`DkFU$8OCvuCoR;q9$MdGj;+Q z1eZX0z@4)c_*n8XLBNd=QsRMq7xiq_*0zhg$gduJ{+sZus`ixjlLGiV?<5*v( z@Vhv6@XBQBL`E=?2L|Ieh(Q5u&eTnkk=h_~>CP>9G}_R4(=&0W3ud^UK649NTKaAt z=CN|Rk7WdZZ2WBk+CqY2K02ZH8nPKY_-3Erghtt6=nDej2`=F3MT=Pd8*Z z>)J{jZPmlQ7HyO)DW9#%?Vfx?c-qZ+PCxEe>rEE9={RwvZOd zF8gq~+GV4=Gjjm>%TQuEW7+KI+I}U~v$rq$6GR?b&Fk(5Ocmt|c zG}>pd4~|f5TI#{zLpwd5KGpTzz1$!bZr^YTFU)7=ILnDro03J1`cVFmoWn%~&UkxM z74leq4p<(A|F!$}iz#tcUhEO}trYWrckCs$1thY>xCZ@HmA*{RY z`;`(ihEF?t9gxR7-QTj*%J{)3NNSti7!nFDRYCDI@a1oya0mYGJQO=Bf?38Z7A8>N z{qaGqrY=hJqfoAc{jU1!$FJ$(;OLGbm&rR^R3%}0=GVcnzzM%(^QKxiIlF%Z0Xfod z+3aiJPs-(MG^pfXO6lAxnqg_&T$l%!0jW?@G?2qR6G(825stet=(4p8@KmCyY0@c|xLxF^x%C9szfVQ{YPlU3;kvyaD?e?FaZpKCS3_Y-o z!R1#j7-Vr!@&{`{*BCQW5SzAldm4*282U|-J&TR#HL0}(F-@o9hP0Yt@tEwk23AQ( zrRisgQFbP|(_E~QK0dc5b+-opF<$y)Ir<<(Fe6@3k6u&a=E6vpdI48c`B}PNrt4=t zIJa8T#Qf@=_?Hjrm>eQ)1yiet2QJI~X^exR$)Xp;y8!haZ|>{gVFgXKB04;)8t&L< z?DsLnGspod#R788W<{^zN#o^Sm5R{AzE(-R1gtCgc?H+SBr++$s|*yryK@0JhMG#C z@DaVIz&yysRa5m8gXTU6Rkb8Z_m=SN6wM||1h|t=$s;X( zofNfUymbp8O#I@VzHbe(-8D`KCi0p?E3LIq!P(|HP@|8+%(bmzo`n0-5w$)>ZP8 zoI_bSwWjbtG*kLw=4wEwguX(+7aJv=BKuL;DeY^YmA6wmS@jZpewBXC=C9~7>r@JK zM7A1SW2k{SlgAI$Wucp!=2F0Cs%MO0d6d+d4=#|4H+4cq2R*uqK7E+yDr7NKUkuov zQ~PvoVQnGD7t${bq1iD!95>@r9Z-)nFJv+*oXHikN9o5OI>-zNwDHMz@OHoRZ5=Nc zwM>cQmdP$F8J*sNY!yD4P)rC3%I?bHzNk3xnC?L_fJl(iuz#NB!99TOr0D-%kEK?= zZn(93(=fc^i~)K6?`30m&%4}2lRPc@Sf@;~YA<-Q?Z3M*I--KAtv^o0;FPyDWA)UY z4Ny!Exb>)hKFu9LB7$2Ty!qD1q5c=MUf5#$R=0-itC;z6I>5YvXJIyeX--5amv3Ew zf@GD6HC{bKLG$CVXKq%~|HxiUBe8JL22n@IrQFGjymM}o>K4RQ+%AkK!z2Wy*xwA| zT2)6BK;!;#5=jiBid#yC1`i+YzP4zub`O4YJFN^)M>s)UkZdsE=uqa#Pt?d)|EaU~ zOx#cjpD^_EWEE4s>agL$AO*H-vjs?n^-5G__p%G->ayh9uzAs?xxGm`1#WOLhn6*F zs;N91A*Tw9?$WiP=0StRuv)@*sE*nLHjy3wdFYxH`J_e#o6cp7O-gC$Vzh|dJnBK7 z`toN~!VKEQ7l_OY-}N1{6hv4KhAnZx9jrjOH)!kOubdB>`O2eBylR%ViB4h@y)n)7 z##8sxKx*-V{lZIm01&qRKmqVg-;cKFUt}ux-TRRJ!pA!iKD?ggC3FIy!TC~4hz7Ur0LDEiX zbBjRAfL5_(PPq$F`Hd=rpyrth@upl~J`WR%$Wer%)00$xzOzR<6y+Q;xz3+w1<;Y< zuW0t%|QrgBFgh!9g`snS*o{}*Kxa>0!lk` zfu+63h4$kvZ2i;|Sw%N|$I9QG-&0^s4l@k*?oNx#&H4;Z&Nv;nZ*HWkV+25;4LUxt z(Rt_GNK`hJ!bMSv_(*q6l(svapNo`e9`R^6JR@Sk&o~DR-8hj9`t9j%Ep04$USj;D zOuvrNV93ZIj!!cy(;lZTTZlCYAS_L|-DI8_g(@4a6Y!2dG!R2t`@x83yb%&|LU*^U}UUeK)z5lIm1p;1*2ElB71>PKBu)sIb{PW`wf)g?#Z@7vkq@KYT z4xVdk5NE4m$H?wT2OEA7yDgkG)}l^HQwX*vfHz-{=tWd$-}^&X@Os}~f_@}g@g`hs zUceUF3mV(R=9WJa?$$!`PuB;SK7mO<$8R@2{EaEEif!L>LRq7Z^3rQodP4ms#gZ!= zt{b{q2U3aS&Q6wiftmj1wGmSjs9T&FXh>62@$@9e8EA$-q6J38i*5nUvgzD8mHwtn z_)#Z~c6)+fy%dp2i%GZRnRkccB$7Y%lF-agFBF8hJf-KuHPM+&*j>NBMbR7ek9@yq z^xYtg%rbetRS;W?rZr8*0A0vf|!*bY;wpq){B$zzU|BMj6!hD98UI|3uIJJK~ z3dUa+{g)DyhHhj!Ej*YKAmH%^g+rszOxIu^xQy$D`smKGu;{Qd3=SpC?TygSC|vR6 zYebN=ruvC9@y=D9iX}+6>fM7`xOjNkAN20X{k&h$!`Rp5g4wMoGUM-EP;u^ncqdvp zUK=ow{I={{QeS@@VJ?%uj*E4oQDu4K>`wQt&76FKhq9rVN(rjaVyfgx^*03)^+)%H zMtjb2D|g|`=c4QYM)fX^%UXkrM&ia>LQ705g0O`}HPc)#KMl|7j<;|lbrHyS-qfYM z+B;*|bZ?PPgQrmKL^}jqg*}Cjf>P#@oCqUCX|5uaW9)$0l4yQgEKY~rY;NCYT3r2! zJjdcqus{FcMERV#zy@u$z7T_FumuM*3gtqUMGEfU`isNCsP>Xg{m6bv1K?{;T1)Tl zwLJ=WBYW`43Q!duKl6bPQ3_2tR4|iiy!z14HT4`18-^x?HHO4YPGP>y3Nnqm;O|<< zbMBJIZ%CYxKi`qDR$4TiY;=s(n@5K5;4mz%ii8TlAm>}PkF6m#p2+;<+q5GEmpvj9v=c$(&irSk&82s!kQ) zNzNE#bRQ4la>>STVHqPdH7~qBiNQ5|6Ccx}{|=R5B%87YhUz4|f<_^>@+=op>w6El_{biJAyMfAX)PKQCSb@@*3qgH4 zBB>t%isQR53yBuysd4~}&f1pc2w&NtQf(@l=e&d2JwiiPs#}7Wz2-@&x8guE9^(Z@ z=e!S4}LG6xucb4lTnvShz*Ze`8)?yxf@26Pl*Ap#O+4NZ&0 zhPe0sR%Zt~YVtYb$f84o8(jT5Ro|u^Q69US-%M$%QSILsmrHZmgB>{a2h7?ebFmqo z-lA51rnJ4DWd#K<=_*2t=Os2V_VK`sAPX%%9uj;qRh=~O>2}&r*nstyl!UMrD8901 zJ54mfHv0JKn_>Lqc*B}LaZlXIg z8yX3M|9~l&32I9oYQ~l}|6_nKF(B#AQN^3`%N%op%{Y|Q;pQqeIAiTc&UUm%mB9qP;}33DzkIZBQYjIhAhELs874*JDp>0C=V)HRb9}&*!-e7Zhp^@6 zaGH>LQUnH5)~96UCTorlQkYNKvo$$r7Z=d&2FHOQ3JKPOi+j~;8OqfDrh6~(I- zS7T@3{@lfbquv}v^_7TeweK8A8xIN;1iO9OS$OC^eN$8zb>vLP^20gX6O zqvi*{?qCt@zCc;JuEim^G4O}pBECvvilVcfL1uChV3+BlON_8U2cW@ygYwZGxD;-u ze8E5?fe`)N^Pg$bQg?ZyP+2u$7A1bzakIX$-L-QmFAi+MGesS2cMnVV(Ori0jUzBs z4pv)KI@H&B#h1!TFZ%b1HOcchrTmTpH~;V3kAQWI?Qv&MevwW|BlY^LKXx!nics#Y z*Ha!MU7qk=g6|yHVMH35Vj-uLwi4GLR2%Gtw0?w5v!Y=Bo_;=i2Sdo~UH`Olta9Gr zeK%Ii0`G2_efo@06GWKEn`3Djy$X110_C_teSc=Tt4n zzM^gR5g=bpSDVpY1I_pxe@U+^#eGylMlN~q&>ZleM>?L*5k%4)&@d$hdnn&6|3UEL z0#*~bJlZC}At~@Vp~l@D8>F!4(c_`qs1qx{2}!LY&@viEgRv*iCf$gx!^~fVk3x0D z>1^J}(ODV41UzjmR87|u+-Co>%qmKHT8EI> zKUtGwhcSEEi~|o95$X2?r<%7x{)h{+hYd+L@m?ikElF=*aehJsWVy)>#(K-($;o6x zo*wC_%&0&jAPd^vjkWkH`0yT<`#2j|mJtR2r>+Xinvyb}G{v}2QZnH{bX#&gymz-CZZg=nSOC>yMRQk+dyh+`VKAI0PQqU8rkE#*$zBH@{82o z9g1lR@q??3KP6Crx!zR4d>wXk9ZbSfU25vBRaYwJbdUlV$CSYHUcL;pVyW6c^>qu) zynTvh*qU@`my9}WtnuN#XM0@3?P%5BAE(_-a1fGDcnou1`20Ut#aIKa`p&otPEQK+4h^iegBZr-B$Ug+8Ktf3yu zE)iQKn*?3CS7;R)k2D-ydM60SWt)96Tfvc|I^9&EyKmhFe$T2ZdG3b$yI!U}oW!YE zldpW3-ZH(8L8=oK)i*!s&faV?lqf7_xfOvkzl>NKk{d^^G~}^HJJjh759FoYHxntf zBax4JsGHLs&wJq&P}07cjges84BI|XBc-SfcU6-7na$v!DjFRsfDMU`+?VdjuKN}G zA)*hJ_a)qQWU^7>k+)Xn%TKwXTaCc}!EjWsG5ix2z-ydc3IN4ki3s+e2RTS)UhUdQZ-vlYj1ipCetWe4IM$*has7$;ew9LkQ zMbbiHZL$*E$>lc-rKo`8pqb&*c%E-QJfSg;$929zs;wY$-v&0Sm#5phxQ9i*$hR!U4BQn!5pU{SC!qyh@;cLkVdL{+4rZX$D zQal^_1$K4AYr1k*c{@g&P1#tU$zQUJ%_HJ=Hi_Jo!42O+4@23Q?!u_2tXnfL0+F*Q zP>E(C&(K^hB<)CAT&IkAB+)*R!3+~`Wasj+vy~kwQ6@LmsXAaXUM<1&r;ux&8K!(_ z?20dvi)%@L=X>8HqbhywF*q`ki=QCg ze7AfS)XG`aSpU*JTIw$h5{fQWDT;pyy(^+*LNya{_sS>g0?DIlx1j8uGAEx(CqSq$ zdJJ9fe6&-!Hf}%|8QThPGf^!H4cG%@f{_Ph9u~|sQ2JwR?LLe@wUZF?{ZI|7Xk|mJ zpRC=v1tKyEf$nJ{(eWCxa;ZN!P@zPn>%00EL9f_bMl%8Zac)bnMbV-<%3K^R@=RLj z{BmoO*W~ZBdl^Dz_3<}UsI3_FoIVA>nNBm}J4{j>!*al^Y$=)ndlA-+s z14b?Bs?ZB-GL953FeOrNrLC%&n(vC_`s0xM#5rCubp26FZp+!n?bDy$2K*lFJk(+* z$0*eIDN#H!py^Bap%x$vfRSF0JQnsFiCvLcRlD>(@q>|UhJY+8Q1Mdge!u+`Y4~t1 zP^nw9PCM{@cjlNh$Mr>Co8s6T@^Ly_@My07t`;FNG7ScS+=c=kH*1%QsWgwJ_ zO$bQ_qEvriF=+fROSQtQ-$9qSdQve12nWFY5Il{wYHH&ALsh7BkJ&rywHDK)HjOCj zh@2UanQyNHmz?pp!W~bqSMoqv&uzv1@3#l6?*oPCerrZxBQyRnPso#-**d3}#{y}= z%9l?1(C3Mu4{l+_BoGm>sUP}}BG$oD4rX|u&d1W|Oxkd)e0+<9@)k{fctmD6iG3W@ z!SaAFZO|rNvbHvr>sF5FuprtUK`3`U)0ODPTZY9)w)!_VB~-Wm`}y%9iSbn85JcYK zT=(Wmx`*uiPO;u%D9yt{rdo5m-uxh+h_G1K7#>{iA@~yCe4r$u$cSQ&8eFG5*(fpG zv@vRiy8|8!SADZTGCLdSlQp~=;$eKv_^N#f3jpjPv#d<#6G-M_Cr4|C6)rQ4^7)GC zalzM9Y{u(PSn%$x(s^70N$C9P@s!v^+d+1pyi><0m1XeJuMn=C7^%zxgyp}vGk@WB zP8f}HyG`ICbH&UgUTvCp6o3B0#p2#G+P!oT0VJYs&+HNri%BzX*_9apl`)>mB`!Oi zT?-lQ&7J8$<_EJs@B3n7FL|tbgMmdQ5{nE5{)pB^a3rLFLBN2yG7;87@_^ zrC78)Re(emzz*2q-2t@(kQ}9wn^hL$V@~%_eNOA(lD_+eJu`)%QPUJva;=nxmxyd_ z!E=8?CW>J#04-+`E>ca}*Q{QKE@!4r!W8X^Kyx>YKzCqov?@})TOX>dW}1e{Yn$uBo*f|n@iARz?zue~Mp!zo zzWcUSq>-&(fdZ!ePh^?{nwKZGu=%edq;|@LCW}iRzw8u<)vxZY{hgQb_?y$2zae+& zG3itn{cG{LL~7T6wKcfW;g8|~?WdhF(&<&7W2t0<$;C=8+$n%9gn;Etm3R6U_f8?{O*@1vJBmSW4!ya}odF1MK0s=_c-JkoRV z4VV`rW%N=OiE`oDNPp7T+V@(H11kAC_D8y*@nZnlbx-`ULsu^=Rf*BbVMV-wYh*E} zYjVK&E7IXkQxjfaikj_6aJmmyig10}!Q7l$^U5gClkh=>c`f8IuwqA2I9u102&Q^Ur-6S6lW6LRmzej`@r#*}@eNB(r2rua| z>?|T{GBE4jBeP4?@mk;s+v7kD?o;*sY?8ueDBo=v>Ex=<{uY$EE>Mxz4pij*{xbMp z>Tf^c#aI%}&e{O#)Sn8Lzfn=dLc@q1lwtecsMCy6S@{niCES*!f_?8e7^Y}(4uyn+ zeIMG2FU|&sUzDO^IG9pEk0q&&76b&eu068o334trQBZS;uZPHVbly-&sHJNN)4@`; z$W}uw1@y;2p8M%69I!a}?lkHh!%Ao)ub%(W z(;a3h{$OpkSuixEEQr(^pndj-I9i}mw=SPAb^TPTR($>AkjO?L+7zW%;0&2}h-+^H z4jb%k^fwUEgGlqfm54;w&t&>jdB7Ik9XxiS7BuF?u~7yMn(y5wivk5I?Yo5w$D{I< zPudFL{SXMcD@jW=Tgc>k4W!+DM*Uz8vcWfKUdpGyVE)Tc;f4WjG`qYy8Hrj-xJ=?E zI29Kzz4diNF-3muEnWn)8?rN%q&Q*X*15)ninm`>8;M@fUO<=AOCJ^XFXFp3t=$p_ zVs<)uadJh==ujIEj%D&|pAetBCFqt2m+DmF+@hx)`gKdGkT2g>-kV|pS91BjpC(*x#}ssJ#q5=&c9ln~n2gbi=b-VN{HM;NI#;ubS=|*^d%@Y! zHd401<8MWOy|1O*k7!R+hICP)Ch_&g3TDE5LLM>T-&7+_jCg zb4+nFZ5`cpqqnM(65VQt(V4i`i~8A?)I7)G=nJ^R1=z?f5U^bnU}4Z3C4}rj&;-%N~G=OC1dsg&$hKF$8k7 zv?C3%gS~ZV)}l$@%3`(+YczJ7sMBjSzs*y2hji~D!CVCDP4mPUe!p2%Ee;SS%YKwx zqekM-yBcY{6Nk7?kz6lZisf8ZPfRGEN3vT`6nRCVE*}-xjLM8pcnqr09 zaACmWvIbSaVo+;ayBvs}NLzKLSbVW!+F)4PlkR39e{}ivo0T`Mkk#S);i2noQ+gGL z#oX9pS^|o4Id~{TDdU2E?#=18@m`X__S<-G`!T;xnT1vR!;RoRqSCAPuEGs)7>@k` z!o7Hogk_ii;qQ}|4W=6B3<{{zWzSyUo_38^vk@?_a}TeD(A{q^Y4kD=O`}@u2;0JrMSEg@83;&KkC+*eAzq&(7SoL!+!_~x%X>{n$%ABI}#0A zch-UIS-t;wxbe3x*+*fvQoY7k!RrqUB;AUzdclGZhGzWMH|(6E1ZciaK%e|=-6yw+ zA!h_q^$-M02nfLJgAxX<;Ha}GuIJxGaZBY02G|M_taKQ3>Ht!Th7<(DyNKk*);VmE zvC`>;=Au&Aw@%+hYl2VTqN2{fSqwKhP~IeA#2T}evN>!e`mxYE6t^jEUO`fBypFN) z88j@e_mH>?LFcj3$tza9SN0(r9B5LN#r(jl7Z4eiVkUa}CJvd)0`t53BO(&iLUmyT zGf#>zObk#reGbBEe+YuxZMAd}zFL-= zc)qUs<^R<4u9lT|_}dD)#18UQjuy(a540hB|F;z}(Vbn01dW$~jSHi>0jJt-O#28J zwf+fG5Im*fXCG1;%tC1s>67wyVi5;-^yTTeR^5wq&>I(>&(E#T2<)ce)ZKtm;NiwY zaFW^(uM;MXyXrDs6FwFj8LRi$xCTW+y~sE^41)w&R#aq&7o*8w8H~%52<$irE~vtQ z&YWT~;>~OYrLU*wf4A0y|IFoD$q?@Y)n$oB|9+a7gj9OE)pSSPn#;9PyA??}yvDeZDjLBHMe0(0-U@Ix;4NJ2KXP z%P*q@>whO@+~7+#Bh)h`1{|%n0?dVJI#8-9UWX$%ZZrotWxuU;M)dg=&pU4;)_AJ- z-`Xu(H#<;srT*nKy+n=o5TSvmg7Ht4@Cyme_4@LrRILgV>_#WNwFnIwFby>*t_fn6 zvKmrU5gK2}=$yLGksqbNrMp(5$Fv)ytumSr^%@zQ&~UR~^VHun9AD(It9>3kum0~q0_@(jU%)XIPMMW@&3n(~WgA!G` zH;JhdUip8&?LUp16RMm@rsLK^h43fov)g3Lbi&(3TZ;w3s`u)dZ3eA_1H+xV2y}jI zmg8tl$d_w@#5}NH8XHqahD{2Zt)Cv=G}%#->T!ASe6ISN z{LnKZtx|r8ytfJw#jdbc-8e)jrzvN7>mQn)!G^Bc_aOW&>yUe&8Y7+0CVu7%*Dc33 znNX5W=VN+VS=RYx#hO;DqFs^+pR$G&lS1{|dZhH#RT2tqKY}d?G2Qpx#IEMUJ|fxZ zXb>?zj{J&RI-sH`GRD8Imrbf)@m*VV@yU?iWiORXIW?GuC#JQeS*d;P{gh<;B2Pz= z{pwSMHADt#6kWDx6sKaIpPIg0%>C@6<`j~zYP+MNw;Vcn?|m5s%qWwSvh{tC@Hkc4 zdzaOJvj6TE=0tl7c;x?h`s%2t|L1E`Lg`Ye1*A)mmRP#G8|iLPx}-t6ySp1{q@}yN zyQQD^^8NgtKi9K(4#R8e&Ye53R~r!-1;+>cwaAFA|Lf>8`jh~nGwchI*WTszPYDM- z3X0TM)?PPs`Iqh%1hYLK*~!d!J)i=kZTN0$;QBlqw3^aUyyLsWyne-f}1 z&)=mHC4HfrElvHk19fanT7~J9sh$K>iRf@DsK9_g1@$nw)NJFJ?5bavkkxvzS9Cw_ zl&4;7?;HcG-P4EY?vT8?0@=Uz?Cxa6|Xhr?-aW{jJTr1SG= z2GDH5;N3tI-yu`}rde{LWKln#+Y=UJ)glaU<&1;%}yyTx?o+S`=Xr z!@N^hv!Vbx&^Y{U8!8i8mO1EuZLZ%fZ#@jr-7n1T#Gj6`y1#IsEZwS7Yz7#>irq); zPXuaY)-V4qPjgKadSzSj>*b-N`=@K>0xPD$f$3QS+B&x~DzRxiGJ`*=Bam8i8W4H% zulD@?BF0K2Ri0$MP754ua~4IW7Ve~$cz{GjwZJMCsKY7skl^|D@u&%5|FD8F`4{ig zZN+%!aNf&RfY${b&pDvDR#4A3!g=*9WWP7PfD;eYhQ8o!#Ho9<+(9=AlUG~>Y{=Hz z6G5!%(!>&$eA?*uXf&6qr{IBFpT<32E}R(0+NTeN4m8{ z?^&7lr~4!fwlXg5bCWWqtK;m}=Zdc>8|`vPP4KNA)%Bn#)CLd)tYaOvI}b)_+#m1W zxKzdmw_2x9F;2m+OKr`=V%SddtE*hsQvV(ihLNv8t>u!vL4xpGZnVpn?BgGPEUB7^ z%xx@f5c$`Yk>37$J~F3o;~TPC<%oDoSuy;+_}`2Z+m|Nd{POq-&Jp{=sLfaGuTl`; zlz;tcd6V%NNV&(@-Y&GuN}O5YaY*a9xGzflb9_Wa|PvR zy_4B!({{~-`bk7O7~do}M-x{jDlU0N)_0Q<97Bmz%#$OB+xgyWPGx#^#oAG9*;>$( zKGKyewZX!j!R)JJw`)a)GCx3?>A-n2_|f3247&dZSa=WzQXxVboEU5*f<+@kj+VR3 zU?k8}1D7@0hLQ-|lNV!3y?OXP=HRa!olBE4c%+>|(pl zJy7H^74e|<(|bL~mef;=t8Ca{A*&liW|->gFKa<9$zm3@k|8`$BQ0U+`;8 zP?x(H^(sBjFl6Q5%R*`_bhTz~Iw-zYz~`WkHg45$}$kI&Hv@)1i4!oJU_XTZsC12mMYpH!^8QZLVbWLFmzHXkCbUmioRHcZ|Ix5NDPeu7kj z?XIymrJ)mlk}}3;Uk>2)KPm~c?~c0dUs~$Y{11jCBw6br7IT7YcZ48^@gE@8r`F;i zj>GLl!KZ3zJ^PwnU*K58hv)1`Upmq~QL_#rPKs&k9Fe2GRpZ$-<4$!{`Bh{F7fHta zl}*Hq;}JaE);q#$x`6YBztWp)HMOKt9;*ilyYbcV1T1DWF<8JW9IpXx2nwQ7B%*8(iyn7ok!pue|Bsr z)#mXw=CKO?r?F?sv-E2BRRn-AK|eVI!*&43>exj5@q`fF2h1HHlvHLiJ+@x{PS{0h zdawZhxIVtz?$ZwYPXb2`y)FW*-D`qMmcL6aMX|ELdhSE{y*u{nF2oP<76uZ;Qe2pA zPtT{cGzmLoNzu9e8P~AOZln(sHyY|?`Dj}yelYWgGqIJcQW0T=O#OdVa5!(emS#oJ zBCS522OvF5kRg5rr=JBTi`pQ(m$W4;eFqo3my22m`>ijydckQXBd%U{#DV}4C0sC| z3(WwgMD~b;bc2U@_&yKn41VxU`}1^Vyjul zXN{%&cuKkIci>aV1B$!Ty&gWh&q+}g4%e$;1TP<+hR~kdlA!Xe334jDw$)uX?e}Bo{4!jVQ9bTJPKTjDH4G`;51@Qp?|qaI5(JweQ&wdW zpfnkhk(Ph_ckXVL*kQ9`bNVN;%`+|9WMpd;R(|?^JOcB=o>gKCGt~wuKHzb1cy!Sj z|0iM)Mr3|R67tcKrEEMboDU6|+{`ZCAII;vq)n>be^`1sBem$sq<(});FIPb3D4u= z-NaTFUD>a#!-VxnxD*|V@f2b@Y1`Lv^>Ch9f41`;@R&1E`B=HDsNx}YwjU=L1EOmD zm6EzRDo#jm`G9Z%#aQ)Jauvcd<6^wJ-4f;-kB0SUMTkyVWc~)6D_Dl`bwmO-1T1{! zz+;E+OU!w5Q(huPsAl%C#SQ%0g=nu+LPCS93p}FiQ<^@M0?sRnJ%3T+ELBlFTF-xD zv{zf6(zCn8OtfD1Y{FGl7|$j+Il?$@LD|c&EOVzVd{s!iFTHSi(bUQ!xA8nIb5(Rp2FCa`OsGOrk5vYDzwR_N3b#9a9-G(k>yH!cG=s zkuMBdq6xSdFzCCs+UZc}w;WdlyIe0n0`bGwos^+Nw*RVwP@tJt;E+iF{(tn6bpFg0FObWQ zfS4dqr0A)mf5zX;G){8c40lgUoU(qBeW7l*zIv0ZysN!s1gQ~wIhV2#oadxTACuW&l>)v-|99a{7wCP@t58U3gT@woDwm!fAUrYmj9FYelI3%I_>WG+^zagKpdB3Xt z8ClrtT-kNqsXpfDt5~4!qe1eILzMf1Q;&pSjMSHMX}1@<%I~66|GRZl`4gP;2#$UW zVMT`rL)Ne#dKg0}d~!1W{mdiWdepR$x3*?L`xI2zf3ke%-7;QB>wpFKu zg45rB=iZZp4{+XSKCqoGih8Q$NyLUjm3|S;$8)gdpEkhb?fw0A(4}!Mx+VgNv(!Rf zT;0QpidKMUyt0wS0?c+cVHs8;Dz;(C?(945s&Y$czfxwTk9I4@y5Tp@+5Fl0@S#kF zLhN4qX<8n^+-MMT0q_6|$S1|N+KPC(d4bOx@G(*ixa=^1r2@ zLL<13`v?m3x(H^FO+h*|7!`x1M;lMUrXSq8b^yFxIB@(J;L9!nf3e~QuNkDldw~H+ zHQ-vs#OcFj{`?D6HCw>>3>*Ym)DkUYsegBFZah|4YD{nJH$upu7A1s3n3_ytE2LL5 zr%Ch6dO2&Eyoi&py79slF4Mld-nY>V*c7*OG+zVUUF@Ys`37Z`aC9--75c3^U*%OT zW&_8d9IHxHOOt7|!Zx@VT!&B>1-emydJ5M=bi|YOKHBtki_29A9u7Z8&^ z63hL4#7;3v5`89Br=GxRX`Y6VBc-1zr42uo63wNZ24!m{Gyrz+9_>?BOtl^-q5||5 z(MX&r0o>q+%>$&k4{fX9qwp&Fd}Z&WmEYydbvTq$wWqqQBin)Z{Jo*9<0*$sur;t;qh(psxA*g=UEt2S=hA$tu?^L2yg8jcX9<+u7 z_wgDbTD3f)7IM&fi3H&DkjtdX9Wa$aNU+#@hm$Iy@s~F3+AP7Vk6CC@?V4?Zcs@$K z64suc$@yA7FeQck#A#d8al%F!RGg8(69l>yen6x7kvJs@%+P;uqJ)tEG;^sw&w_214ZE02>XE3v z`qUag8AQ^-mJ?Vp*ebyFJnxG(#xxT(@)@*^y$@{@<3hXOpLBnBa0T91O0U=c@|E_H^8zk@6QBUmPM%@_-W5SC zft;f$#!6e7FFu=TiSQ7F@_{?iaDiC2bMIz6DRpd=4lZdg!&H^4(7s)wRx#sW;E z6o`tcbTu{ediq^_!Rm;HCdSqto^N{*a|9xZG0{-Gm%b>%;-{H344bEZ;Ypx0-%S0E z>fGh;lj_jV(?IaY;2Y1-9WN(~&_1o|U@^?>rxpVQpS2h&VrZ%$y&;!L5phFRd(BUo zbWh+h%{Vtt2#+x_!?`Zf!il_R^_Mg zg?6&`4DE@qDcXE7!O5%)0H*{3I&4CkiXjW$t5Ml;#Z`O_y1Y|)*X=z6Y$x^n)c>|t zCikuN6JLP30aX2QQ=$7v@4OSiB~if74|}1RwY|KRpQsGjB395;9@?YiQ?F&9 z9SQ~WA|!Texr1)?a%TS=PTwf?Qh(?o0_esMI9=|sxqXW{Fq8e@6= zNo;6pk7IWOpPzx(bAEf&ua5Y_`A(fad0^X=%k$9ZW62Ibb*;ZcNZn-<=Cz-93RAhK z9MuVu*y$HCre-!LTD)3kp`hSnLRfj>>L%q8pRsNpH$t}GW^O6kQ#@lIvdY|vefNM1 z^l(1C!1#hEVfOAHA3#2J_fm^v{@2u=)9uyPXB2D?Ao^=bQsZ#?wMu8??0oSCzw= z%Irp~G@uSRp#bsLcQI~BNY10{!Kx)^!Z|dQpQiFaIYTHVb|dw46hym8Q(p$(1`#;W zsFL^FsNl^gt}S@aeIeBmOktA;*2`o|uq~c6;$lM4egen9-i;Uig&D4g!Lox$586;~U=!RZrFo;SGvpGEcE8$ks0a<+++)15y65QIcB*FIE;Ypr|H-nU zzg|e3uL?BnGFsVbCRK?wISE9M6CZ zgAxX$`-JV_8-U2YGtMu=z12I3K(T{mDP7<{_{FJ@5Qy8V7(UhZN$RyhOpm&J>8obEvkdqmq>e6`#S+PRw_B z$o~ohr(NA<>wec0(b4IyRG`9G_cczNT@Ox&Jgl{rd|@%jGDP{863coFwK&<8KVucv z#}P=eT2ndCN{Ur?@%>8FtWvYz2?Y)4_OC-;sgagPQy8v$p`yyvS#IqD6+E{O43e>v z|HYnz572i$N~5Z(_YlnrAfW|cl-I=p$vp~lEHV^{GpQEwf07)v%IY(SFp06UHRg(_TnTBfwL~m`ae$E=o$I8&04DPh~4M zdKg5sY11wZYAS`fqb75^iL7XvKlprlWN>W=WIA8?8eY8t{FNrfZSJYlnCk;FsJHx) zaAZ=LVZ-?Z+oPcc)hwJD`9*iwc{L6F9k?n8PIYh0P-5^N*q!B6L$|JrpK&ysFiV(v z%d{+13n&mf0e;8c#J?6RSW^D>K~5z5(K27uTY4p5&^G12=bmQXNL8CvSCZN5#{Oo| z|Cq`*=J^48C1||Dp&wh19rxn!%-SDOokELK8DBkXnH1t#Hxm+lz>D*S=$m}@;khl* z-L~`1(>mEOxYO+_w4|!J{#1BXE^SvXfe@lPwfqs4%HGBbVHe#fdsNymQHk%n zgUWOTBjw-X`Bryg?!Kz%(l7f;z-1i0@iqK zkue}oDMD5G{u5xXk1);#T1UHlv#5}O%q!2Vp8n&MXD}>cHzM?Cg+3&l`y-J@&Nhc% zHX7&1yM8{8(MLkUgJuK!_LYm^{Rf&u+EB2wxjEA+QIK(cdu>R*994!5nmOmsWeyYN z^!c`y z!1=RMDA;rOrj1cA3h7XT9lB?w=V_I6$&=TX)?1(F5NQ_qj+?7rO2{~IOwxQYT2QPU4N@y|#w z;o<)YHV7Xi&O~^|ezwzme`(XIY#1>M5Z;)xG!Y~FR{g*}3doG;wDp}>+JneZacz zs-9(_&2v_JT%%V$Ff_Q*Uy2Mj>Vm7azi0mN*FFZCHaMe_ z6etX@gZp>kRVW4OSLdy>qko9vt;L0ExL(QXrLU~oKX?DW6J?orcE~2Fy#H@I;C!zX zotIM@s2+hi8wucb+}{UsJAvL;?hWv)mbmRj>`qwelTVvNACG}TTccOUt5vLX8i2wv zD5@ZJNDEEy0FN5!f`7Gup#oZbs)$OE^X`x*f5$uMVIti4)DW>R{gSz9_?x3N7d*~Z ztL0N}L(IH(Pes51jVjSMR!G)!;Po<1dWR>ofZnevs z>!!b($qiHY(5{j-s)oV9v;xEQ+9chRTGu~+TvJDW{dwnbXy)|bAzj<%AWv9m6_W=f z^&fA6CQeJIVsq8S7pZmP=ZH)wj=(6j0l5DAiZ(%S^xnjn1-S^AeLK6pL@xU^^M9T~B_J*C6q9>9)ZI=O6 z{52+k`+bQrGyYn9{iV^4%)h~EQpHFe7Lm>tpF)lBYH^*K>$^dGoZHTy^qD1K-||@B z-iDF(c4-G|axgZ}4eqFIsHq~0NzywRXX|!*fP-JYAmZ0fW;0&0dfhHXW+{)CgUt4I z4NXDZ;k+iiQ>HRuHAHzO9sy#Q4X%sBoU1O2-NNX=0L3D<`@b*e}71~1y@A8Cgmzy8CC`Pk3CSkCq=@C#(OR6maRdmim zOLYE|`7I9EPrUV8e)Jjgg<9^guyDVHkoYsT;J~>>qolOAEDB{oW3+T*yJTBUumkT> z)Hbe*;WT|HqAbewj{YVLIf081dUSZ;pYZ@4Th@yC_nC;pfC8LGb^5&yng>5G6FPDw zRLh^iR!3aN43{;P`LSt%-?Jj~$u(&(o(){&m(7L|JTT6y+eea-WToid=4hO!dO&5Q z_6_x>mdfI<>0FvGYc~J}eA594@}>Ogl2hUL^;dNh6y=I1Tu;-Hz~9vw(&9Q-gx5;F zIuw5+km z8E>0o$e8v`$LvC~>Xi=^Fs~dG21iLr9Z7qfLG$+%V7pTIv%te(>-D57M5+uBF%R86 zWA?N5IUT~%bRx!R4(Y!XRapAZo_j$X=F7|Qvyj&sz4d3a(pXm!cap*I#zeyPrW7^C zuF{Jsj`o$>u{tr!Tb!vIXQTM|X*NMIx8!^3^7p2L>8Uw#lD?JsDD^?x5uO~Vtl3qJ zEa(xpU6sy{1_Ef#sd9)Pr)TFeb9qW*tx%g45k6iELU>Q$Yls={6D5NG!_a)asUezA z*dOO1lLjYmAp8c3s~29?dUK)C@X#xb6khJuDI)`dhUOxJft^*jY~YiTs3=l~bcrc)AWl-)`AC@p zus1`%`}^C-;jZqRL)nt&vMJuJS;2H3y-c*ZlYlv2tPri>1z|mgq^y`(AM{$|inSZYI3({c(p486^9xH6X|hpbjgR?*#rT^TykoE?zN88;+4 zll7g}%&?q5_J_wu5ffY^6|YR=x^SQztn={5b^6Z$P63d}QS+8&8KD3AkU}EIJ1pjY zggp48ebR>2@-mw0iZK;btXh(hI6ylWo75Z0qtIE;KQS$ddP%wNR*t)fzyl=8p_}m& zlu07TGE%jKxS4#eP25Qo)5pSHxW+csjq&4OXOPqux2Mm_N>7WYwl>XZ#^SyC zwmYo=mKEGLWMxC!V-1)n8u{OdQh)RI{!D-1a{D4O$!7S*6(js#lBL?;hS^z)S!d1) z%klROsW{^E$k6DE-Imf1oqGhGl*Le$-I+62MK8!daY07w9iFDH> zWT>qkL`6Z|05U0XF88m6oN0yh4A79UfMOe!7wQX!1y*Bwfv#$ejRUH?|9^EI7NoArm{oQq z2mB-yqR#TxQXV2L<^0uQ^qZtPO1Oaoba8qa`Jz-BJEd<(% zOg7~|NV^`NbP@`6fmg)TfYkPb1ctJx%LUMnjR|z@RC45OPI=9%`BS5 z=3Ji0UOjGdLca?JRAwyr)3X(&Q@_+~m;ctnDols%_d^Nb+TWNXNHdfK(1@?bH;e(unI&b=y8){ipb3^M8%FcLOBKuC#dqYmH#^N|BBM0A;=#4Mh(2 zyokATdTN__I3bgA2PmY|0>GAe0UhSRpBZG_bbp$0`$J{Ue{=a*xk#~UnAd^cF?QvZ zv;U;{#Z7WQ_3XmA2rd6|02TAAnM6*Gg8H<+xt$TANx(H(=jmKFvgYN72>s%zfl8Wx zryzUeFbpbgIyR%g8)2^co_u+%ou1m@SR=g2&rvH3Gc}E=^ixC;8W#F3e*>;RE5aBv zTj3Iu^@kKv;V&>X!C|B~)_*@y4HR?zHbuS1yF6xUn#Hu=A@bJpZ2!$H%~UQ)+*px0 z6KdN8+4ceSKY^zEg6oeAVOC(8i&Os9-DDxn6SvEJ?l|z(HFRKGZE2~( zQ<-Ib38>nrw}C}n9mjH4j06=jW&Nlbq$c(%C0Dsx*Czj>*)^!yPFFFEhzzlqg5h zpUQ4!B<2S28NJ8+od`IJd{~6bEvND66}dqHD{=$xXUDwD9t@IGWdx5D|Ywzs%z9kyXmH+nCe-Hznxby_KjJd(g9wADoZh_f%1NYyYtr^c z4XxnK>>EJxhO;JKKsbT>`>(%SBE0p1N;75uQk6P!zjWuOD^xNKY=4S%q61VMPh94? zaC6-cHiRW~f2&McZDClpZK9?ZM2RPo>T%aH_cZmav@;9h_3fJSs!OQ(T|q$?o;QKc zxzy_dRbvNu=zTpi6plNiYqUZI%EDZ=n*kIWCr0BC@5roAU+ScaoHAaG{cYjZ$=uw& zS{eJuHc11K{XHiNmBDSP1s+a@V#gK-e+N0F!GifLB1+^H^h-yFZmR|-v7yL>(-9qL`1F3F-;t$ zWfo?umj%lUkVH08Ewm%-1Y_}6anK7k!U8^}|p(mag(0 z4O+OYlERVTaeq#OE9F^j=PElPq3qjyzg4`%I+lOLo0d-22Ptlh0N+#nU@d9Vvqy#H zDvF)O4$#29NR~1PrhZ^l(LmRT2N-2fy-Hi0o-=sX<-gBTrhb$fC?F9 zVDYH9o}Twvrk|#!lrZ=b7Te5oTc2s@o}X6~xb{2O=gOQoAP)2m`TmpdZSi{ zpgCge-TD>(b1`c#E6A~A#R%O_4hU*tSQi`nu<jR4 z3%^2qtO$)abLz~t?G)Igr>ZrJ8Dxb2%0=Jx)mbhQhZKl>su=ylBMQmEJcY9S*>nCC zb#ckQ{N3G;R#w;x^~1IqmRjn-f8!vd8LK*SZUWbIYUvl_2d_3>YRQ=tYhS_)yZ>&Q zsGnzxi4_?=2qHISm_7cSyxLpeXh(5fjfEvF4Icok2!{efueX5WkeM$%ETD=sLV@%% z9hbTuJvCMGOK0CElg-M~qP`i%++P)c&~;d0gzcE@@B2lnHTH#)>Ahhi);@poJzp5@|MqC&>dRP=@tm%N<&IT7MKg?W)C()!ovw#*~S6I{d1 z%GA4w@9N*8Tge^yB>GNFmMutmh$Jlyt$i89O}j@d*AxZhYp+vUt56ltUJM-X7@i0T zLy?85+OB(@=xX9X1mJ_tXe^gbWY`08;Gmx>T5*d6Ol}W=OVIG?lJCwQa1OEdPMdoj zHfhi1Z#c$_HwftCKlyVwN!rlHEIfjuB%vtgcCa{ak>jc~qCl76gX;$2!UlSw%I8<6 z<}D=IVRp|gGL8v)T^G}kJDw)&)$J15s%QWIvBfAP8o9PLPp|`T3kXKvs^8z`)FM_+ zgTz9bbYGHj=gQ?m<0IUEW~xO4!&(%dzjJE5yE;uCissbyMLiy505%TRmO~ zf>O=RyaNP}J83B~l35}#c3sI(&+qDoAY3L9lY#=tk?zD&F{1>hSnL)Ue6WJ=l%IY5 z=dE-ap&ZZE?&wPo3PNOuW3yI&{i2v@2?Gal-|C{JxrN!{{wVv=lIcxV{jiehwpoMU zJDlxXZmDRD@l+m(h#&CbZ~Ensa4=s3}Ke(z&k!unzQ4jV!Sn*uQ<*eM7@AV zq+Yb;{;%Iv*LhEY2hjs=$(3`c#3(KcCj=V=9)>VP4Sml)!TK!>im!JJ6Kc#KNU|dH zC6FHez9L?w`$*c3Vv~Kldb%J}UIhOD zt;iFM#<$B0a0+7stUqeP32*@LXFg)d$wcYi&urNW^Xjhb8vkGnl|%o3?iGC!5q3I# zLvN4!KK~khKKtV??hqww!>DO{BeJ|JLHLdJC<*95vDKF2mHP3WQEJBn%8hfht09;b z0SK@MY@}`fpGC&Ww=Y~$R`=%=QxcmmH_U{afji*MJk!XNhbvEW$vi8`^l*gzFE86> z3#&G6g#@o79H5kDrXe;2eV2)R(E*FyeQh!)zmM>&bq1DkK5MePz6>~s!Yd-eBf?9S!4<|t%Jt7%L6JvRj^2|*vtIiu!HF}Un#*<#U5yP)9|r;HK!4OBh?Xbu6X=i^t| zu`hh@oqyC`cB4KI(_URI%kNV5NB!5dri%dY$mRY*9Kz1+cmpkJKp>kB!T$<#jVZ45 z{PX=4j+dPh>S-kTGuJW3cGKzL;9RC2`}2Ak=MW_57-4?(Hf>wMU_|5qHletyERUd2 zN%mLk`JnY%rM;xoiAo%hB2@^W2Vbun{g#N#0eTO_VjhperJt4-p%2I$5>v!5GIW6O z6v~4Dy69Z%U=hZqF}#b2L!#sy3!K5`g0lKseNRp-Elq zCezp_8DQCn+gQc?*5WckKzk_8oV8aW(hA6Hph%nh4il2UE_ll{`g&6%q%W^&EhN3Qm1Sz8l=ngemwmTlwoZB&DxIy|N?p5*3jF)m z91EEbolNeyPPpZ~L%1y5&iLPu^LNChRPl)-jC#lVe*AeX6s9J;ELK1j9M~oI)<2!P z-XO@QI{g)%W_i2Mv$2SRYhMmp!+m`R?|-|e{z@xi%fbVe;#NfcNXHz0;B0+>zNvtFvwRS)&VBr*20;kE@_t6KtMCw~7lKuh>%k=)j zi1C3T%k3c+Wm3f5|D{^YBmZGvuE-Mj-Bs21 z8Af5&-R_w47_{_!eLlSL117wK0be?bn>2IKv&p`Y%q24^={4)lS)Rs8S`A`q2RI0tFuE+Z0GH%-u7mef` zI9OgoFR-5Z^>=sIP26Q$eqW4$%X7rD{+ zJ^mEA#onEMYqLm!mOgdgqm_TtlhpXt&M6?4SymMx2r1GP^r)Z8_g5NRRa>|eD%Wv3 za#ES<{Nq~~Z2_NssRJAfGyYF!Ze{cJQpO_okNJS=h!K|EuITRG#+;VC9dz6GcUETV zoeg;n{>>VH;%g8;tDBiZi17a|3QYfDFWM5h1sdmAP!r%6jCJU6okcyd%+dQv^;8c2 z59XZWgcxUpvC>f%-P9Hi5dDF~_+c8%8q=oT^bm@~;lY?=UoaU6DvmaYXKwc6Ji`Ig znJ_?)4(4fT5o_6ds8Kk44H*&2Jm#fFU&YDDwV%01unPK%t^tu(g7$%JD&4^6Pq9NY z0{~Oi-1H|W9cQ?`>izHE)b@*3<(F8lI2j_=>{l)ciIM-jbwyGcE6q?I;xrh$x6-lf z{~*hvQ_2aEB+T0fCiFIL_hv^81!|m9ERL{+v9Q_Q zE#7DAV0nE#P6u@EVj(MaMxAwzXWQ(1Nqrf4n-sgKo(E=JSKEG5R@J&}uj+vyL>2~! z9qcMvue8uj;UIPx#QY`BQxoL5ft6lk@#Qeo5?JJf^?@HLh;Os=V}A6F%hU!{XxIiX z`Gv@K5kMDgrn(@}wgiedgynN==BYQ56jYZQN~ZE^8>W>`Z=N10ams&F-rxT0h7N!G z)-pTltxEPeI@G@1#sSOld|?u}AI0%!+(tP%d8Cg)Rqo&_J6lS2>W8n5j+jbP7Lhg) zLmCV{(Yw8k0^seZYLItJG<&2$v~H4R)pDuIH-yEW6YW)*VWTY{ZWoV$a#`|PQp*In zvt!Lwet_o-$d$4%1C33b+jT+2Bo-Q*di*q#f=s}gqd4Fc5Vn+g5~d| zp$*mtZ0FEpGTobOOc^{1E5_kLWp6&qfP8gx@O{3VF?Z5ji=76K(!esX$0Sl06xsT| zvd%xw?AwTH8L?b*!1tp<4#q5%Uv#a3P-2Z)DGrVksuMhr7I` z3rMB&V^}!7Xe(^jnfy=5q*6hvM8KJ7%S-jLvy1nt^zU*B9N>D5V;s|hTT@DxCK2dN z0PchGFCO4Z`t@xhIy=qK(GSa2)-e(M=1&ntI3m>*Z4msw^e`n`HNz!RhbnrjcAI;-jm^vhh3Ec24l`rRk|kn570Z|3(u zY+ceKgzId>!*81P<0pUX`)X27l4{w5jKdpe)e7)Y`V!;9OR+5L!_%e6&OY+9wc6Ue z*|*fght(u>)PT(){IL*jiFqYs%ypcG#Em6dbzS-C;9IL$2q|^6aP`X4saIikvGua+ zx$^DGy%&F8@d?lEii79wL89`@y_c@Bxdg7~lZB>M;USL48ULckk{HaVN@SS(yf1LU zS{gFBSaf*O8kB!4x⪼#Yu%8-T<+>!_-N268aL10!tyCAVnb0Es|vN>Tu$j9Q2}y z7sKLjd@BME^OBud&FlYcQ#ej-BdScVRP@{axlObm1;SAJ*T=o?RDMgxSiTI*?n=}?y9rGoAA{vq2+2u^McC3X2<(1 z2~Nx#?qfO>ABgpl9t`zq%?xI`+-|;!GwFr#r6*oEvwd~yQ}yyd_$M%og&>sKd*w)P zO*Rz3{TcD3v&N#Kas(nYmzB4BRfpQlXPY!e)GO-Iok$Mi?5F3ihZ_IYT5DzgUbJqQ zkJna<{8yw{@3eb?=4(n2KqjZ{X8m?*TJWRHZ?CVw{Sc(%g`TN#>y#msrCF*b3gv0!hc1x6o-ZkqLApf+5vbKKvmO!yCAYrCaqi^J<4#T_T>S(Vt zY_HV}WyvMwO6O;2t*myDZ9(}b(1G@ZMqGk?#e_Xf&@6&72TOLN5%FrYcLI{!SjjhM zO0Q=tmjir09WDVy^R_%{*3i0U+KY=QlkL{8PCUdf_nH^eeIc6Dw(4x;(3l`-%rkUo zPw>T--4<*{WODtzo(RLx zB{{@>ZPR%;+r&o9{!#xXH7v>x0sckjeYi9f>Tmo8Jf$T`F&f3^J}l?lNSVvX848Q( zT{9;des2DdF7pw1`3h0uZ#cY1QZvxfC1K5mck4Z@3|{W;tv7HWt&9&zIEe0fFy*bh zPEj}Ia;5>2r#XjTU?@vj>%R*dnL3pGJF>R7FleKMMnlicRPFwh{^MBPECy_lhzCN8zK-pnF_%?dQSz_j4;K3H_;1?!b6{) zRzufJ8sdXG?y_`Gn1QFqmJVfpw0&@#b)%C94$%s7vsGh-M{dV1cP!Psovj{eG7FoZ zpC?zZB3&f%rAHdhn6=W!d{ z9+onG^4|KA0{U^_3(@4gLBl39Q$pnfR^e6$iPF)&RaEB*xzBqq9_bPC@VB;F7Rhl~ z3KHp8Bd9?nZtM;8Z#{LiH)-tFo~JR?N-+nD!JtTG#I7ZjFg|e1NOIywoR9 zq3NPqc+{ld%WLL_(bksSAo}yx<8->vD9r&MwviR9yPJF$pOkSyjjYz7Pa#D75H;mi zgheE+RhGAEo)&YZM$~t)Ve!P_LL|3R*or480Y2*m_pjIN!s1)DOKAfva5y)|F@;iW zjp7Yv^J+QUeEv?RI8)HQTT_3r0;0T)BNs`7(q}F4j=b-yDrMgYF5L2E_9QsY5~s1i zu7B}qG!{AcFGf*GTy%9cpYw}#SEnAH{`QCEe(~pf$I^9cjMK)dOz#KRBIWI?gHn^i zxW{uh_|^WZvNe-3=5#<&w$;-7SbnSo`g024IFVpjbYR07jPluofE4%y4^vla_mdCuok=zftaO-M*7)1>00$+_q4S0B>j8;k?Tt z$j%O@>`1}%Ubzz4^rOsQ4_0gGAiw;P^qIw)0NtMT{^uuOR}bru9z**giY#&``X55X z?sAa0W`8JtCaY(ug=9!?w5HycpYBgAE1mCU%d$mCj60H4pxd0 z@?vCx7sKFrk(+C?Ok8*`yGf#BP5wJ=p0cK1_nFo)i=5m+g$JLc!Oe7 zlSO7}>;9Ol@7fcz+=N|42fxMp|f~&z@mj`-k^=pyYyW=HS4oNo_swa(v(ssdF4X>;(AAS1@ zk=?|Gn@nRixa0fhX4Wmv$&CsN)Lol@7oSpTMuR`VD2kz#Y!I1?YrqOz@H|^#K;H<&bA#!S7cFIO27bC__U@1^N87B_NC7=1`0_@5U|%s`3|}{ z73<56jfw+xJqhr5zW4~^7)WWe;M^V&XwIDQFI{$eSj7CQ88}Ud%-3-A+fyClGBH}q zyH$6Z>5&Blq*iG0&~F63eveOE{JWL=XEc>sMzx4ivtz@Z(pqA0@Bvs8{ z;*p&JS$@=LL=fSdRew3S@O>L6r7C4Yssq4Q(l-7iM|H5hP;V|V?DMM-RA%`4t=R=EbW zuG`d^b6Om9RQ3jcqXr!^J|nB58$c;mh62oA5imc1cV*5|YB_0Ai@Q2WZhjue6ZsVq ze!Std#JzQ4n(PMcHuU zH7KZw8uWuy+R77&eFcwJ&6%^z zsHXV8fXar7is{F%m50O)QQr87kmMdeBREE@8Cnt0Rz-~z34|8!uZU-opznXN+{A%8 zkQowLilQ*YQ+YIPv)1D2F;^NY^zc`KZ#DwNN>5MmB}E?_CZdX_OY|G*Cl+b>y+4qc ztN${aCrh)F*V{*4cIayC+Pp;`$@>LRUNM@KNp?)%9mPw7Wf(bIX{GS67?&xqmNSVH zXDl-_zl0?Kpj(?mm0_E{*-v_+Pz(haIO}q>XsnkiA8l#*mkwu?e%d)nr77)VkEAi~ zZD;&ePg6wKkV^?eEpTUcZ^eYcs>)4mVcx0wBZ|I$q_Dke}3hBan8q?>JclYj8sR$+>M`=3BH*rV%Sc@e~-uH)W417UQTh9%r`Y{Y%1>w zf0R|ssc3CAZO3A#OXVO*T5NdRj5~Jk8zmTsTz`&&G$jB<-fi83DbmuIw-Ka`Qe{4Z zH?iQBGK~VizIEd+!P~-8ysKfq7susEE+ARtVCS}p30|0;WH%o6(E8;Y-xXsm{jyMS zYieVmwpLw2p&wj}>}Gdq123itWk?E5V7n zJY9_>vn&?U6CgT(pd%orAxe=$4FvMFH<;c+OGS}u_+|D*!`6MP1NxHOs#By5_~scL z^yX3*`&hj9UP8-{@oJ}itIUeg#%d4@CppAPCU#w~VOh5@ySqu}Hy9O2O!;f+Rb^3c zg)au=@@(ZGP(JZaZ2Q`q@3JwqrhiXXFbj{C<{scmTT-;Zu>u4^^H!-}n?k zv4i>HgM8maSo0|jeCqekFs>41#({riIFoJyD*S0Yi1fCP%Cxmg2MD+9xX}NPthWxT z^83Dkr36$OL=liiTIufYMo9&wuC#QAf^-NdEz;dwIwhs!5|{3aboYC%pYLzxednFI ze=wIBhI5{M_Fj9fwa+u&`Ycrgwx!$-mFbV5JbQu;y^Smj^;#)aSI2n~{mY!tpHwW*V_ zmBqy&brS-gUu?hxYOc&557s~@Co7$<)>gRl^-tue*U;OqPoLe8;Z9(LcqDj|pYdq^ z;go;dgw1NHuabobvag6{H9F!=-Zt4U^uv@MyVlZy@(+?;OJYsMX$AaOcuq|q||1N(VsC_dQQn467s*wL+D2=bf(itWC8JzSfxaLLx~^VDEi zx?hoM`K&@{h+CS9}9ivKvTHV`?bOm2o+% z(f0o8WcI2~(CP>+Q^>+koj;?U(pvco4;y13dWx)HK-!pj(9OSaC*0=-YhB&iT3eLQ zSi-iCfSeon-IISifnMPJo=1j;P@0X$+4UkRSa zZJE;@qCe$4(e*qcg3MOqAI7y4T$Vbui|c$$|JozkveTZo6&t8{Okdl0si1DF+*63o zU5`ydsQ+%74$9&RGiBUdyF?+?l5^ z`v!YsK5M>|ce){)jZnSTIJjQ1un_Y3iqf`8x}Kl@lh1Q1#f7m228m*xUMiGaWb3k~ z+&S39(J|8D=yv6CSMgqR{_Y}A_;AXf*|Wg6`EWyR+NRk{OTtusWU52@j9&v&8GXCDrwc(s2tM zKYvpDdk*kw|4{<-=?-`_Wju@LVQ|kJfGOG@3{p$w2KS%%(Hr|rt|nr-OTPzyaD}M`FGvBI7Hh+Y8*yG z&y9%>7NmKfYnuv(*KA<8v+ACQqvt6Oh5D%l7u`YHe}u}ijiMD3Bv4hUKt%Vw;Xjzs zI$XvxScBL#Gp8H#X>c&uwVVev`YbEBZ|p_(898~zr@rSxVofTPZX%HS{+9>dl7QVP zMy139?e7bQ43n47Rll&o``Qnv= zXM{<+FEz@a;R{o_NKa5WE6KEJS_w!YCWZ3aH{hU&GG8o$uY|BCO004!(ML z_H?(_8dY^-7BTf~;)+7GRkQl4###1*oe9gflrCDl&15{FMwk!MZf}nc< zMCh&kP{Yx6e;+@Pqt;)WeiwS}W;ko-t3U64^z?y;PNvzvovT)mjI7VTb z^GqK^6803{@}L(%$PJZOm_Jd?QI8T!UcVqAC>C+Cgf!#}-G7De-1k?LO!A2YnJV<^ z30;{cDt_A1cmuDFp#h2Nu#|zI?rK5*#I96?0;DR>(pz22ljb)#_Xru#hsCcZl6%DU z7h^sbV&=Fxh~tFbx1C)|e;!xrwE|_eP>(8*+A|V7PIz~OfrL(OA$})lz&zgd^B<0~ zk62Lw=cbGrUHhIwTXilfeo%(u2r(8GqF}ndvFb4~`g317x$Lp;H-;Mp?N!UN--phB zaMk4NQV-JLSSV~{`_v^jdQE2?SGn9f6L-7w@n0EIK#B2K>cH!F!49D8qJ-BJe-zrK z^RK2-w~YvN!j_!N%dzG5B>TU+0EAif#O%r%-kcV^4Nmf6v{UX6sy{6v&^ah=`2|&F zn4ykmH1g6l^)d;)XZSO>nldf5(zYrb zQoc}RpeQhwHZz)BEcc^E&Cg-=u9#dW3E$MoW&2`G4(p$cCStTpY_c^)!efPX^e@&;|Nx~DBrlbxPE#m>Qbn~foKj->6@2YYAEK%cnE z*dA@3cFpp7JU>*=v0$vsw0pW$2T4FJ=Z6!Vb&c2YJ>yVyoh8G~i_16K_mWBV=-@NU zO!Ay)JN}~c%T$U!TG?XlTc}4If~NYup>uGJ^LNjY`qEKP_=fzB72{i1=|IQyG(N)* z)bqZwrL3emtpA^rBNq*#2rl+rWui0CQsTAVn{Cu z2gj)_4Lt!;k?%BAlBQn``x1w@g-d-4yyFjWR|NI^%#0SYN=yj4VH`y`E#yyM}BCsJDK3Sh%OIUpf^?w1c#PyFaad7%t<&_sO=T-5#?BS(%MV$z1Q}MexA5V!ci?F%M?8`6Nu6k-= zf5$P$o+V^utW$=^X}sL z>hs%O5dnv4ehP~=`pm$?904zL(L zsD>+Wv0!o(Y;HP~n`I6z9(pE~i63>&g;N9B>dFNjo_q0c?nV=PQ&UrMz80hfc9H+A zF=ld@EU{}&c>HyT8N@C+g+t*vh~dDDr|^p3 zF-8`-aJjc^w+YXZ6?%TeJnelCd6ASDjK~o@r;$jnl6&x(0L#BAX{M}2gl6tqk|*kk zNdnD1y*W8VfmDPDgzAQ2)SiaIqF94{fOU7ExhCYefF(Y%Nx!$kn+Nn-I#T%wyg#x! zkM&GmsZ`ee<%G4INwFD?7Wj%Ew(wQAzBfQV^?geJ>T|zU5oU4%(5vf#18~%*>_|>G z+=^cDW@SohhZlNQRGxvV@%GGi>+f#O?(!85)m!V8R1ub~gM*|JbLmo>Svsy_p2qQF z3&sccKdE+Hojp6K$%(U5HyfV}OBZFc-+4njJVyJDgq>QLOCHqMNrauicwa+?b9c0{ z6Mg%9(Ii}|PdW=xMP#^Gff)0acb1nMw>F1gb+_wa`ahK{=h1IRsWUNh&V#*%bRORd z=UbU?Bw+Y0a~)eIP2b|G@D)l{&3PMoq1Q%>e?TQZX67<|_}>91e9eUlIYF@+5bPuZ zr#iZo48(cumzVC$;JDWl`h8FIv(Jibx^BgDOU~5T(p+LJbLYbN=EeW)T(H=-uk+#v z)xUJ62iwImiaQ~vIdg3>N4+PjT-sYy?#m=9_m-TT?7#SyZ`<12d@<9FL#NK>Uwvz! zij%|n(~8?}u=9g(0)7a~#Qm8_)$WLA9Qv~MZKBZA``U08Sjo(GMJgXQkWfCke45mK zJ3l>FwCo@~LsNb80ySS`DC#$QWRoL`>(-=-#`G*qzvSszjJOW+(SH6KfovAR=dBG^ z(FtZ&^%lvHBob6Zr2HW88T-{Y;Fl>*GB?Da)xXS_ z%HRTZr3Zjdf;0+jg#5>zAwWwiMm6DJ*~pDNvsf_xd33N|W4f{@QOPql^03!bn`=0a zou{swng~G$8g=P`OA>Hc|Mwy>e;XDNHe{Re6I{44&?uu)PA2BAS>fa)GoXAULUQLd zFd%c4QiftBwZe?}z`z(*kJiRnWf65gI~#WDfQJ2zR(-E!jbUQI715=vF~G%tgKwnY zk7cTy&7Bs#EMy=l`+d4-3wJ5nG+I2eHQT_+QA4XeAxu}LyRMpxdG=Vt20rQOq@3!9 z|8oa%x+Hvl^wt%m_u=4^lFnCV2y==F!EewHds+t^((mf^uW`mA1B^SAc`*OSs-mNw z-1@De-~WpS4yY?=5|4J_j_<+JX~4_LJ`kS3#&155d(daJVwf9x;-9_9`<7AlDw%qm zelV4*`si;-$aoS8iK#|9uI-;pb=Zg3pUW2~i)9*8DyW@zlIYlti8UNX$>ck}dJ;%h z0tT@@c~2oD#EUc zv&U=Ts*~oY#ba)=zs<(mSxA$U0v+v@8l(fNC#D1WBRq+>%*V>o^--&zu8q8!{Ly2XyBK1OE0w|2pX_-c z*ASV#k!+PMO{YGitc#EFGBfY20FKkmiPerA?JmwEd7{1FI&Ui{F*JMBKY~m?_ptfH{o+Ka1RmiuNP$X&0xFI0 z%dh09p#Ob?da(`9oHXtak5aP!sLWYw7p86hwYAuyv#D9s>cL^yYDEU@odr)O={k3@ z6WJz$nQ(8>1>&{dQ=%*OPrV%2M7P}*p$G_Gzh5XfTat0i$P_vic?Xm0N=<0T z<6OhYN29g7&xh|4e&v}(I8dOT47^qtDI49&^k`Z3u^SVN3GYG@-{l+Wzy9NIrrx5e zUinqEb!@DG93-sj2TAE>{N6zeTG=-z47`RvFX@V1`ye_8hoTw%#;Pix7QqbhsJ z8!7H#Dmj{DOw?|aFJJhO2$e0U>DsTK4Uqb60Uur7wT0s`Ns~?}=rc!Kb9)Vmpjyxb zqC29eT-L(N9#E$%|JkU2v)`x%iE*wbzLiIiVk^$kF%c=Uod8{rw5B~4YL z`}H65zLRe5CisPV$_kr03d$hCEKrN|LM3jnPQmsy^?29PRd6skpNe%v4q!tKFniY z?Knn>AnaRO9@vNtgf;FDPrMUqwWvQ+^LzH$?Zudh%)kDBIk>g=c{C#Ab0Pyk4p^Yq zqWmF`8wj{sI)8mw9g>KMSiBz?R%+OKf&nA$6afus9k^h!3;m^9uTo<8J#!JBb=+$F zBgi(jw>8i_qz#u#g4}-8J9LDP2#Pl1+0HU7{iJR%f=|9hw>DbgB~ufuw3LoKm>%67 z)ASD594(Q=k`@XHJkZY3){2|NXJ^e>X8oG?&LyL3UZL0@)72=y)qA3Jcd+?1q_s^? zrPV)JFh+g_`_<IFW%^ZhPX%bvbk8@O2~bFdKzx$)EnqH-2c?{5NQ^XffqV;Mua% zwDJtf#QiQodI~~XttaaM^N_{OmaA}*S3T4BnIqHWK|w3w@VAuk2wJ~OCv1|_BHNnP zc$VeB#hC>TfmvKbn~|$MQs9tT+v$qPJdUp@|K6#VTHzci3Ct>j?>qZPEfy(DiCzzo z)y903%~?4-=qbwBomNEMBCG}6uzp9?q)M1ld)LW^mfk|z02}Aj@8d5l@BU_+aZbxf z%mA3Sh6+My-r$D$?@2)`=7&@daE9{*qYL%n{LVx`b*>NYW0_~EW3HfYc>T+(BF!q;z+crJdY+bmE@NPSdRxVNwz8uhseT-OIJ3z zosz$DAC@MnUOK>@G+snk!bCs}(uAgI#s)}`26%?+K+)0a&`44V|FRcPQ|zb^gmS(45bQwzKt zw$-Fh(<7ZEA^BK@k~@(BUTAexklfehm{ezqM~vYdi5Zmiv8t{>~VRRoi07;QSX1WTNnqkpwnr;sEq}S z-acq@#macRGNml}+~G$=Za;332w}9;tRP)MWc>uXbZ1nF%4|;PZ}$#~^y6xoEVVI* z<)lY;1Q{8%eHX$vHydj#Vo!`kl`OA*IUXySL@#)|$tMuLWZhf-KfI66;VZs;jPx|z z0|*fftlyZij9@#3;Eif}!k?X48Gi5LV#3K8kGzGhsVAuT2ZS3#O27hSh#$$DRYa`P z!o=+Hc|0}Py*Dby{&j%2H-kv-x!&1tn_G9-wlm_=nM=0eh<1mCJS4BYdtcN);`Itb zgp}w5Z6x-b1L~KzXN9YbHn2T4sD%3WqC8`#la9%RrZBRMmI;ph#s7c^Vxr zUw^D!qL6O;(PD;Ceb^pwQW50$r(#BqvUx=9{06#CVb3@cBp*GQf;E+s4B z^<+zJwFz}Y8P!1?BYm=o(91pU=Eo!gyKpCYwElete;k7qL^$5A5OiM=+rBHz8?1N1FAzLkf5hb(+sH)g1Un7C>!xr@r))2El~Z`fj5n0~y0vnZL%TJjsmLTO zvGX#5VBsgUZ{czJuIyYqA4cuWEzHB?IG=@K8@m6b5c*SDjS2dM1h~f}1+G{6xS&5q zHJZ(3h=+e3MTmYt-M3%71JK^j=)4{v;4@j`jvRehb!(pCOL{R+WpjmbCca45Bw&=h z1Qm$hp_H~y-~7W8Z>wrZcdp%^zT(%JmR0gi*ul9*L1>~{u0yuz&IYm=9S-BiS_k$t z=A~+jPsRfpU2)+4liNo(U4$U+zciYe<*qT>-NZNE*6z)wJ73Wrw%=WcdtGWtNm>n2 z64WAt-4BM%J%dSCI>dGHL>#qb6YC^4M|Bf=99<$JKG%q4B6& zxK}*YH1OAM1D1xUFguPX2Tzs_sz;{DW3OtepT$6D%&4g5xp{5~9X&;vT=ZrumhqOO7=G*+Ep2SQyH*9WcEUq`q9w`q z&~$MT7}R4lu*XpfBk>i9WDcn&NduwgnKop~4w0o|<=NojMeU6EX~aIG^C;-q!|Jia z+Ktnr=__<9)L%X;$|Ps6Bk%9V2O7*^oRC3q#t($J1kJW*AiDk+qAG3EWVquV`Zc9o zKpWl`M)|cdpV)HI4_n(YnVOg;dZXBVF~mb*0TVn6%KZ;?+oSr+-heLg6xk)VUJ?P4 z<2KwK1El;*Li=_>i=YIdW#jeJoj!3dQS3akKOvq*mve#57DW{PtJz9Q)wpcALBol4 zw0|$yoN)tZYZTlpdmMwD7BbDLf||HHMZ)}kY*(wLejSkt4mvq;l!jmY4dN-8U!@A5 za;COUA1LrFO$xDM9?Y-%Mu6so%lbWiF$iJBMr``2@>2mn8qCbdv)UTyt-hIPv05S zbKug}eJRilT|EQPGHMFujBi@rst-W;C8U_O?^oAQcBG=G)O1ZGFEGzZm~dfl?bm#;aYVw$;-D>B&%Xl7PTl1t~5?ww5oEtMYQJydKdZ?;I%o~=X#ddD8wttg1jLLlYcgQgEF zosCtk8FhfS@FMXojvTnqNcB3{b**$>n1ONkdb7_1QPL6BKf)o*lrCDNXlzW!7`(

DGkca;b1KTVNACM2z?hP@`5)U~ioXbw;~%9xf)jR=$6EXfEyH*_ zaHc#FOulD^HYJamx?|J5DzxR)O*SwQyvxm|&|tsqN&eu>&uiGRI zl7DFE8;_ca6C}c4A&D|6UfkIaxdI2^df)dGYJ;^WA~#hrGfvtb*!n zI>xn|mYav}H=WU58_(okY?7cX-~X2-#E@Cyj@%JRA7%r<#4_;36GTpaBbsz0Dw6kZpuVa+?0qeSYQN(zG^*V`kf4e3C&+Q|s|U!0oeOhKE~ImdTx~H} zwZ^KAe~d(-HpxNNC6pZ$=!Q*Q0*}fGOuMv0>Wo-B&$WjaD(htGt86Jp-69KSIgF_z z80q3vZSXec*K1zN5C;#OdAM4bvNKu8SzuJ}Gh^%)>hBSahXs`dC&k3?{=VMsknpgC z1XmUAgB!b%0IBz)6Qb4|CRTMJ1wAVx_uhSaF}EN{Ra^}NuU9Gkzg|EKdmk-U%i_xo z4X_M71dP*U0L>5xg2nf!#&0&LnCS;o2%tShOJTAY)pOTIMw3QfEsCfL&KpZHKayg{ zt077jS{isX)>_h9+amjZg+{S?E71KmOd01B$s}X$DsVr;*1>)R)nYu4E$wR^&j^F^ zpp^Pov|GwQ14+6&bez*esqN?IWXaS>v}_BYiP{_5b$(P+g_*{_a$s1Df0G4oOH|jrJge@MpMDdc-v2x zS3~`JKK8Y`^TTFp{Uc)M8;)*_cl&HA5y;1h1jE4Zy)q~wr-~YZBxh*uh-rHFhV8LOF|a9dHu@DfzdKY>V5IoviPrO&GR(@}v_|JK;N+If&)yJ7arnElPkIN3(Vbm0Es$ca_)FTIq>my33> zf%;Lbj8H14oviwDs+sU126RcqI&lw~tT#clg|uX>uy0qw()V0{6Ymm{_&cO$sG8M5 zb6ZqutU~`xbV;)^<;t0NswxMCeIkPUyK4G!l5AL8%|2I?7)n!`Fi`WodqZ+;>bP1* zx_Tyhly_XK>;2-{zt#tvn+gQEb*sWgv_ghIsDzM=-gR|_3<+#Ehg2!Sp7ZYK{iX%y zVe4>isn-Ezm_M;qIlI6J%ml>`BuW}cUY}0E$xO@135rg7=qneDj(I-;v0e89$9nzL z=FR!O6dT#=O-k&&S;jUt1ILb)N;L3?Bb*4=k$~8E%zg&LP#b^kkhTy3Ug|*aqz}O} zrJ7F+vmCY?^grT;FiXp>;6G_tnF)mIF`wd9JtZ~DznQR=+iBvWt(28#b^T*blB5B{ zV={dTkpoT8O!>ziuHOu$J)2Wmo$HBTo?CCnwuuBPbInA%qG754xQ7FlTkwT&77%gJ zc+mOP4w7FXzh^@!Epfs>B4kFi@#r#9aZ11+ew=4jVU~QQD@)~bSw(QX7#);nE&01K zx_-)wjSYj*MsvgX{hg0q_DW|H@!jUH0Eb1Kt^_Bl^{_-4oVuUv=#BMV6By=S!z5F# zfR;h9rO3@R6Hc6*$|iBJ%{A(vS_suMo*{aw?!TYb%sV;5lDV~mWB)1AYDO2!%icqO z1(bT)iZ`{Tt0LCBsblp%@o<0ppSHGvZz&Q6*M}9^f14cw<)c5aJT_6!=eEA_nlwp~ z%0s;QwA3W}C-ZJEi`Y#~Wcge6dJ0B0pj|G^_UH{<% z-;3*a-a6zRcc(J$w<;fWWrY6?0lc({(#bF-0?9BDSrrnMi5rmKTpExZbb}%=0aXnR z@q@txu$1zJ2FtB;=!fT;Sa)^C(rg}Ji|+^QW5_+Dl-K*Ze|G%D!uTB|2IvV4Jh{-$ zVoXe$pnlDFyU(*ocXrq&f@b-?gTDjC>3VbO2z zSGHnlsOrCkpySR#fO36tU5^Z6c9-LXONbF z2vP$eOhBW=e}Ps?|Bh8e)OJ+DJST@)?b`!o*%S>JW!fAKzYgV;VD0d?Z}KXDZwzW4 zQdUdGG>ij-R$5vdEu`|kWCCvLUd6lTC3HNTG+!$%j)K*X$yA5-o6Z!)KP$_6V{`YB z>6!Gomf~VgDjGezG2QMnt12u|-wl;Q!LBkl|yDrzY za}Fwd_TMWecS;usvzxlw^$T_`@;i*_S&cH!3l&pAYCO>c3<2O8KQgfGA_XOuZjl*G zC9M{0nOYznT}akZ_U%Vi@Vy{v1ay#%Ax&Y7Dz9}rOnE4YfbC7^lms~juicDb}9 z@1bz%ecF^XyuD3B(nRvnHr1|J&H^hjjWIkcaTW~2tQ*8kpc5XG;L~j2F<=?UDG+h} zoll0|kU40G<$TRMl zOf+@Lf=!vHYQ>YE|1K990OW!+kgz=2;Xv-#KQsMtul7O$e@y|pJucPUXjN1gYk8!%FIARfbj{9 zWj4f74B5CtKO;}uhny)jaN6SWLE}njEer^1;1`Du&ZQOuQNbZzBE^4Gn+fFS{$*n= zI?a4{somgbgghGwTK4N2t>B`y1JXhj=77(qe`CN*fqQZ49jB0(T~O2NT0chW=MF9) zA<;9*JQUpX=QCVM5&MdNOcl9^^0QQ%HE(6_uvh^5dy*$L?e3aTdXm&__NQR|A=bW6 z!Pzf8tgpTcuB#fS=UXY)CAsE#VkT}_quP$YQtAHcNxCHfA|nX@#NGxg?AvKV2$-k( zwDJ1Xci_?7Pg+r_~|wya$9HIKWxFL8Vox!JrqAz_$GZ>i6z-r;;* z16$*3T6UA+N+Q<12Oi7;xAGJozkQ=-2v&KKcolfv!SG`zw zzwMM8ZF2?&y3a|Tm-s3qZe%YoW$SFD~x*>@GUH4 zvdo0HP^ffZc@Pq{K1%WBH)7L?l;E_6&>sv$uKwxym~CEjMZIaWXU#h(GJBr~yb)$m z*ir6#P2r8Dh|cg{916)PFh*kqHOu0H`KkdQWn;0!phhEsLg{!5Z)xM3UcL`KW=xEG z4_px9*Ef4T&wSl7{N!$L8SlloU;Zb}UKBD1O7z+pu(D zCbz+;x4tb)@%0Y0zLoAc)T~9B#^Pg6^-M1xj}!dC!-^Zg6JwR1?VI8U)sZ*yMBf;@ zeeS$yl2yz9y(zm!)v@GxgJ^XI&v-(~OyH+b=E&ETPbC?)v>A!XHIl1Uem!J_2*{}l z!g!iU2O~?A$2<5JlYmcn4k`vSHLN_KhcN|hIhJS{vSiwhV%9jz7s`Ay4)cMokrN+V zC*^-9_q@awC=uf~@P5>*cQ?Rtc&-}tRWI(}1Rv|AMZ;Ip`D-D8il%7Y<_taP#$dx{ zhVW6Tacr&_k7YyhGo*E*bpZVwrFWpRyBRr_1*EMKLh4<>8rch>lsHWcQH|P5!led8 zvNl*r>{DfMDTz&-obnlP8YrxIH+(OY-YC;OcoO8YOYG~}0LHJ%Ra_s8a8$XLQc>g@ zpyu-xZ}E92CGkAaQ2VUd)rCC1uTo$~%-N%4?QNL3U{XL+-He0muy=4bAvUrxThN+$ zH~&{@1CJryZSlqvx7|yEmppsBS-(@%siE59uN&+j4Xtx^2^zi5Nez?p&AL1oJnIWM z#K(@V5;{W)?sp5#?0ZI}*fc6xqN;cMMiLkzox^5wtK!|GkcK-o`iXgR#J8KMYqN{) zbTYyy1$V(!mct#|p}wd+{wGpV-YP!FCu*cW|L4qhiZvP8UBij;y1=@Fq^3-Z3ECv}fO{|~;aeye+iv9o8L9XqGwF(hLPW%mBv0M$9|FG~sM#YhFz@TS zpx`}^*Kt8kP2!&&(iR06Wz@n#JbvWoUmLCSAc$p8_eit&oR#PX(-X&?Z${ZTsLnHU zC}o<2Uu>VpLg0e!#U1%d**rm;eA&zM;ghenHOg(ZoZL0;18d1tpi`;ltl*=#L_!xAm$9hJ^l1Us9{^{)<#G{(OS)`X{#`EB*ibv*?97 zy=A3PXm946`g5Z>jS`y%BR4GN!!rplhj$X1&wXBmZMAb~2cE&rzJHLFr7OnegA9ng zw!Su~ReY=N%W5-FTuVS<(#E5itA!18#9voK}k8I5~2r4TPD%Y=ZVlw5r}KIkE(wWbIt`+UTP+l zL6Zuvl?oeAbgM-;Y;Y;EbyVmTl;rz0um9+e0hbA=|lGhNsYpUCK*O zugQsHsQa3vKN;CuiTW_2>4ayK%$;hb4%z0B`E?O2cvM~gQd2OJ)%xZ7=h9-8fMDG6 zc~eTFW}wGoi$8fvnVy)8@T#~UR39x`F~g8QSfrg(0fmi`#d;?v!-^7;s@1&qgi#Y2 z9HQFBcQ=0Oz!^1I?n6m_}_o6hVjW;R+jeW;|d!4%1Doq5<&DZyxO8Z#S zVV|D;lkk9%0u=ZjX~!pETWWxQHEp_t9OuU)SQM;1jr%%d@8JCY18XGfc6_+h!{zz) z0aQ|xU-zZiX%SnAe=q#WoN`Li4kc8YfZbol`D}PTcfkUqt-NJn+IegIE5Gk@(0dEe zY*-=g%i?b0wJ;$_?B5gu95fl4bu@(b4n6bFs-e|8^k3pT6;{R7eA&BsuW3NPN8Mm5 z$DPM>A~{Ni-E%sa_sGV!xQ}AZOYrYIdeo;Ro6{2(e2QbH(k} zY+LvXLi@iZo3I(at~wxo;k>rP%QU_|wlZjA&roi^I(^#4@-x%e!?Ydu=k#;+?q@+w zeuCH16ke(i#~&GiDVbb@+rzGAi7`t(76dGHw zt1K0n#fh!}L3ECYA*%<|(r@13!Tgo%ojg1F&)~ZZ*%^8#sb(CTskgV4%%Vp5m#mXt z1l|qT&-Lyxs*xv(xgC5bc=>bTMC>%cYhzokpzwK~THSn-Q;eP{5N9ogyT;DK8Y`ckY;7B>zg*j~<`9jl2mrP}8!%U-g(;dbG3b)^cWf zvtJA=Uy%Cm=W5FIG1FJ^`h+K}XQ-ONg5@o$D|!%LDhGpzfzF4Wf(-=i z)qIXZw#lb236Fbk{dwzr4T5uw9?en=+ECKHEDdHP^Z zKvK*yAPBn#EzD&h!gGyQl=1^_*u!6B?{bHD-l`<`@tll{Vx@mQ+Q2|f=Ls;Vc{0M1 zEdS(SNI!0HhH^_;MNnxwQm~~PK6H1OSdq8V6E$37L^xAU>q}%(8VjD64(f61lKk5c z?v!6+4z#h~l&r7__KBR&vbj#J@c3$jSLbhC1gff~sE%JXs@*$zOkFUi-sUQqzOxtJ zKprhpXE2wFhJbHdJuI$Yr`Y{nJ`D}ux)I8*zWs}u|IYOj-|UX#Z(ihu30i*A!u_Lhh5+SZ^EHr`Mphsl2y@bfpi0%%|7FBooo}EmRMP67My(3**Cb z?5DxsQ*>0Bs`NNlm8N zF`q6bfUD87mP*8oR{9X3qhJhuE2N#3`)9+i{u4trQ>O?-upijB8!e)C+!1vI-m)qp zh0h2|B%u$V7BYhMpFDcD^C+(nQ)BNq;;8@+CmV^69W@>#qDd~e{&y+Qz>^4Y_Yi;g zv1ncXZrv<>ijx2tl#A-#-Y6!y7la^>0NVkN>BIBsi8aJkRKUDGoItoc6st2w?t>#M zL;0Ur$>*Ui3U{YIR@u?DG-<*i;7m{;pEbo%r!ioti^4&;#yhNNfQq+E-ReB}#tGvc zBctMU-I!w&QlDQ1FY_D}DV5`W9CzLu*A-zwQE0OL=*xY~hrEIBu3;^_CEYp0M%|K@ z8>(#`Rxzom@fSpl+-ACIN?I)k5x`=HU=l2DvE9Z4RPey}%FAbJAGD{E$(Z@Rk)o6p0d>7y2Rt5YkuNrlkY^GP#zqd0^E(~}E7vH&n7*%`pRHaw z{W{#jX+FasCrbe@j$@M11b^xSYF0a<2@k+rv*

%FG=&y#3k)}&~z&V)442b5LVzIud(^?Q@Fm?Ysne{5nfJ7?piLj>%iJWHl4 z%-G7Ev4?v;&PGMfr!FToJ(DT~^<@RCnC+osjlq_aj%hlJ?|I*S^ zdmMs|nN=#18C7;%<1WVIIIvIl*U!nU($Tqs{{y6Tfey@iZEc6h*FNxyAR|65NO1?% zDZuo7-%*b~eEoubnaB znReCT`}dWx!{3rz^5tbHY%fkQD<3|Lt@qH8Y;aM~8rED;q_D@A4D|L6@bFT_8dncb z7tk6e`IAp@ayT0Nn0qlf7Hn0#bO!}Qd=X5Q-L@=Y*YQ)vX`A;N6;3;T$g9=KbVX!I zR87Ml$J|Died6USv8=ogHS!KMKp=#j&GbiIcZs&&E{@L@E!(w(dQ#x%hQ$P=o!Ej~ zD*F}yw!7M3q^tU}r60%4{rqNL2*5gaRr)d~E+qTs775rtcUwgPDnRE5gOqppcAp;D znHaI{Q=K-d$P#DrwPI6~S%mJT=OjJao85R)UhvTZW^VzUcnT?EEnc$woSE}!BAU!R zOf{IUe_uMECEyi}J%rqiL;(L@(sPd>Y!7b3kwWL zgIRoE0n$0>b@$BK|MLz@4@I)8_$3E=#hM!;F03zmP##k3l1?Ei~O4Hy15x&!+se2V~U52YRAdn zkp7_o@cvt(&Dh{*JrzfBCM6zP>hj&riJ9rIZ zwZ`uf;kPvfj2GMQx}S*t%z*KqiOT(Nn&cjmi}zD_OA7wW$p{d~&QkqEAer$8-Gd1P zD|a&2mw)e-mxYvO+s%JFUd^If%Q6BN$$ura)ybM3#YIeRpDLn7kpvCxM*x=_k?pbR}{?Bc}C*n z2RT3Nz`uG-vL@$N_A8&)#{SaRH(hz-5{ENTR$pg&GICsoc?FZZgoZ` zUuUf@Tx3D{|BMho2LYW~fcOLy*RScKMyrw?ZT`1DU;oarXfm9<*CBOKptbi4EZ1gb zAdGEvlzF`3&_M^t%ecws(yb#;>h_vH#FUN;Ogc3f-7Qgu&->na7*7&ytdnhgwL0#k zGS?pV+`DFrvvv@TVS1wFG{qrQpF~d#Wf_&q+OopwpBxPN#2frz<|x7yyHo2a$=P^a zZsgGGOfQu#^3P~!JDg=!TP<(uY-~MpGHP`zQoaK3$0&l_!z`L?Po ze|zz~i7x86SclQ=pG6DY4go4CUG5P674RvRk%1GhD;3oZAOX}L1R&p^(Y`C_cSQv- zZALHhO5+nDtu_TeRdY>ErnfO1|8A4k0Jq;vXIt4CT-wJGFD@RQM~cg_qswS`y#MZ? zww8l$;s4?5tD~a&qP781KvYUpR7y%3hVD>AT9J@eq`PB=6hSHJK^hSRq@;7`9!k2q zhmaULzBBlH*ZS7`$Get)%)pX+&)xex``ORlXW!NPW#^hw{HcxlKz~cev+noexru4= zSZr`bGx#_qrcB01g~@_xkav0z>CJDn2AJJ)wM+E1O%-18^WhOry1#65SMg53)!l0T z#p!vd=c#;M3?D|fKB+KSsj~5+usBoZV83ki9~HLbQtCiTz$K3E&)n;-(Rch;U$wLB zZrj1a00a%TD=Ap6YtJJXrW#EN5PitrkQMy=kQ8vb>B^jpm8>Rsg`E_A^?u9FZsAMr z$`7C2zv_x8Cnn1yJ!GI-I395m~t zGB`hfQbBAR5v~P6(9y5>t3wWW_#>8A&kqcJp}@lhKS=2 zF9VkUnFY}C-hHRI7a2&Nyz(!dQk1gwKXQ9;RnozLdZkV0=z9R_K#LE}!M=wXGgkrP zrjVxcM38V2I6ciQxMOwOz%mCk8}qI)(|q_b%eC!z z`0g$F{RTV~+{=;shrvaPAT2Q^GQjH(_39RXw)))cUd>yb8#hKOAa)fw`M9qPY>$=` zb(0bew(wNhq$d-GWf@_blR7r3oX`nrZAVUv3#}gqREaQ~g70t%@mdbBPaiNXhez_z zmKzc{rkn{pn9>9&^h8| zD%qTVk`!I%1rp1PM%BHhUc?j5bE3}~Lx{uP-HKyS-~*VIDhzN}jgqMhbm7=B0XNu6 z6ga?iY(sItvcPJ@=-SV_Nbs(CWC7@ zJcP`Z{G~Jkrm@X&lgydUr=b&sk&5>TVRNaygOkAlXQZ!bS3p<7+7}L?Lx;Aj9@P`+ zL6oJd?YU?dDd@JE%8_$FRY-{$>19t^{3l*flL|R1UaZB2C4{PYZ_Dm>)mEeTBUh&3 zycjEYvBUQRryJe*!qi;}r5TKgU|spD@4nB7DUiV=$1{Y(1^+ByZtbDvQ?PkF@H zU)~SGn}o$Q&itVTBdu_in_durArO#(Eo!F6FmR+Z)U3M%%zB|&ct7Dxe)`I`mjeW- z90vN$c&Ov&;nx#+MCmI=;XVnV>q2M9s%3HXeoFX)rhTLoNL2-zqnoNv@;wfMXUNau z4v$7IRclY)dN-(h9iV$V%e@NsWoI>K&P3cjU=21`MJZ6QNDqEf1P- z37&I*QlW(Y`Ap>yA_xcZ%o&R(D#|$X79ZAYLSjDbN3`HrWFs5QHY6*8-$5iln_PW# zfDa!%z@gG5ccL7Ma1*XRd-#LsBq8Lt0B9Nj#qDSl=PmA+_3W6YLW`e<4!YM7ABgwU z!a5&q*UUi_gdVK*u(YeXouF z`R3+}K{86e5kJes5z`9$R=kMquJ&B}oeaLAdA>Y^03w_Nr;qdiX}ht(TZ-0h^i4Yl zlLnOOz(@pjo=B!u^i@aX3vK(_MFR4Decq4ytA(+PvIgEIvnC;!Dw!3PV}o=zj#vEB00GKiLAcal7X`{T8qm5h|C_BT#X8GMADoqy$-iU^Fa zlmtPuuA4b;9S?a@AhyLPnrccSEE6#Uz_76ghpGj^%W0g~lz#aUZL6bLgOba_H#RL} z@_<&j{pID;Sx@Xbd>nxa%rp#jr8mi`u_+F3c*$1=;)5I?GkHIsKI#yNO@z7T$AAH# zC$hHf3Mmx2>YQ#|7?=+Cfnk;hTMiNfC5o&hKnBO-cJMJl3+OK^`N!JZ(~bTC`;jgr zk+TtqQUIWI#Gc9S50{TP=`)!^uFntok_xK79!zn&|omUx4 z?VC&$_*nF*K1UU11a9l`xB~7^wJyxC18_v7G9AZ&?X|8f&*S}$ulXi{7B`g#$5EC< zD7q(J)P$SvYx;JlZ!u1KW6yHcf6-sSn_hNn5X@faO^%H9u8RJA8o^n|GIKULRT3|8 z+WKZUFNJfnSfQix7st-Kf1y_v!!%@7h(s_mxw^M#CHRC-^$ysSX%2j z@be3-#1EmzI6|Ka3WnLl%v3;PNe^EHrR!YML(#(uyc2_u&Z)V(V*Vta? z{W#o85{5#UXFN}s-AB@=*qkHgof0#&9Yp?lrvSz~1(qXzfVKPvnpICSA?B=$+h<_D z?XD$g2)&p%2k4`^Zm3boWy7m9wVHKeza(4}mt3+TUcTCT#W8-b~QKC7N0r0 z7{0q5ciKg2_On%=6R4Kb{hP0Cx#QSUiTmz;C;0;P@@{Y`ubX?gazJ5pX~~eP5IH;= z+;N=X2o9#0Q|)zBO9-10oEpDzd?}pZcRgDm0$yw|V1Fm8;`7KY($S}w^(jE1Z@mr( zomb~(tWn|MgpPaNlZT*wadIB3K3*Iwbv&L>(3x2-@S^Iv2+kz1l_UMUz<8O~ICxSDr~A98n^Jb}QV({aG?eBRMn-{h zwG&Epa-aP;SLVr5RA#;WJ`j;yjUL_}EX$@#-HRKfHdq>lKRt z%Pk`K;5rg5$r2S4mfwxvT%*fI&*K22&FDcylbrn4^M<`swUM5*48?8MZ$u`&U#nD_ z5Ucr7T)(6_`f(e>+ki&1(5wMWh57fJ5#(#;N?g12;M*N=rnKifS(6PA&T=WhX0r?^ znp6HXZlA3p9AR zKO`d`F<~+Odb9V_%m}?6yHpe$DE*z_&7v=<9_u>L#9Fp_(!atq{5d#Pgk5n^knn#4 z#5|AtRq|J$$G!$QA!H#uN&!eZI3wz8Lz&7y${YcO2#I=>|J0p6iqI#WkEuh5+2$M? zFsiRA>Q@=vhzA^vS;4Us9UggC5gZUE4Tvi2@jdyH74-!gIBa$kSCRUULHUh;4Y&v@ zTtk-GP^C6wD@Izv?CN={^{w~Ri5>&%)5vL(!*GYdk{?hey zX#)qkUiB@A{ZBK&Bg_urC+6n_$GU#cft$7#bkGOGGT-?DjcDTCEEVFhMQ2NIB1yV^ z38COYcn}$p;NU}AaO9dTQIz?epYSIzC-S+P=ri1tlUu?6N+wMtf?!&6q#&44nXjK; zH|KeZ%lvHW9_WAK|FE(Bg2cy8fWMf2>wAwr$369_1g*EEhY&6Gldb0pf;3a>?ZH`= zoZccXwy2O!vGeI{MBF2u6oCLt40fP8KSu5D>NNF_>z)Q0?$I72ypJP2pd!I*L&{;Y zS5a34(~&Q-5{dwa=s`>7NX5EfAvq=*V>GYrNuk1(4pvQi_Z`Erd@%Zvp~5&AGyiv@ zhfpNKh3ttI)Jg4?0Vg)U&}%T(mcUF*tYUw5*ikw)?8UbswZvhwpy%|z%%wf8w@&(# zEfbv?kCSmh+ip=pyuw5K?PV+J{1HO1WL@3KXEse#AhzNtjYB(+w`q+;a4q^yObgL9^`Xk`MV{%X~%g2!UbIB?gcd1@7VZT(i zt55*_n2hDF_LN5+%PQLWc}N9bM3@u?z1@it!NF?seMU_WIGy*&*P6dvV8+{1?9=gWjgPD%H#3v$Kk_4ZTUq}qKQ|iP|uA~ zpt#>Od~1@qHMU)$cqi6|o)BR=7Xuc_G=ylFxFt_6bpI^|@)4Q_+H zb>$2Uq%78d6I;EGt3-D=XZSU5iyiPC{~3`$G>FY&CXIl9>v8}p*5y)0z|MMW3%qYQ zfvXoYI}&_eSr@w&>U<8W*z`S#5nWx1f9exHN)hB_f!Q1!<0~1r!C?@3K#1hz;%hwI z&CQ6>E}Nv_Rfb1tuLEhwv;8cFj7xq}S)jhRCiBg*Jg1bz_fWo-Z?Bw4e$dg48*byM zrU(0=Eo;k|4EIkDf-V%M-9l7ym&xKl21i)Bzx#BxzNzdk>lLX=FgD}ixg2ZU`TOD~ z^pSWax6nlf)8c4l1|d+#!xlR{r!QoN0_c{nWAf(u28?wYqMGtCF(w{>g*x3L0a)r| zWso*EF|`Lzy&2I|r8Gd^;X^(Eug7c6zNc0muSp357@|0?gr5Lnkrv}ST!c~reX27$ zJcyT9u%f15nlqfA4;*!o`);wR@J7(;`Acxh!&!4`2AtzRz5Dwb6(bfm(foAFj?nSn z@qGvF9v_1NTMOZCpq_p=p~5j1D0k&oc)H4CIGY>f>*9NWne&TGTG$x3ODG36`k0x|`k=*b zC|I;0A+&`a9M4GA(8-o$>6xwf`C);KS+~rah>GtdZA_M{3yg+mi>?HD?QOn!&zXxx z$9wMyP%>EkY-?ixClsyqn!^w7uRZG)I4s4{$~*v`K)|M=fO8KA=>AKSqq#u#&#XH*}d ze&jz%hYFY`n`+Qq2?WqkfCx4}z$8O}b?7HxQm_7^`_yA!FhH@4Z`|Q@C&cONOF4?k zDn9RGlmQ)@QPpn#k)0@AX$D{T$6|EKIge>2I#Mp`<3K)R8mK!xIh5&Iwx63ylzRz@Vt-f*LO$_Enahjo);%FzFSW1NTKrHNa7$aJ((@Q1b#xKI z+0if9Ps+0)X%cI-wYp#h=q^WlV-M}0O@TQQb0L}(q4Rkj|N;Z+qJ{+-o(}Nv_ z`6vuNZna}SYyYUj&LgB%=54njQ__j~)iapVw=*3Wc z*Tthy#s!k9=c^2{zKW2_oAxFTUI^G@O}u+}ZPPYn!ob>9Q(Y6SW9h0{Ev~E%J|_vU z4BE;i=@`H6Ll*#t2HsgNCGKdMU%iG`E`Qv;zNs z(2WoOr2nSl2D-)=#QFF4>^=6Gad1I#6kxrkF7$%4h{Qge8t*90X zH-BqZ7{i*e?do0rH+;Jw(7u+=R2pB6-fmr5{(w@1bBtw)FB78Wu5!Agl))Lht{eHK zBZ$HN@B_}fY_u7H3Ua^NkVXp{bVy6%lUm-cG=7SxUYeuU;Iw~bAH;Xq?pVDYa}jjk z4hIKgpR^aiK3SVjQNCD!5fLxkH2?b$hxp4A?0Mb0u6){-@qaEHvIVB?#w;^fd3;%G zZS>aOA5KG>p&EI+qW9r`Q3bUuv7jv^W})kJa%h4zusb26tut)e?wMU@n8l0kLEmf2 zpSn*i>ONHA!L`iB_&2!>bw#pxm~dIhxEi)ff2=Ik9E@2ut5rwwXvYtnti*+Dnpwsk zcK#evXu++w;7>}5h+4_i73$+dMjA>Cj}TcBVdElX9BkG49#x_B-8VS5BEDaToZefb zYNEvgW}$h9>n3?~G+_1)@G~`>=8B*5izdJ@Simqi70eZjax{(`-_lF&8k^Vg_Xe-r zi64!9Kn2g|kM+!5UXWh-d9WSZfq*fHf+RI6gti)W#2p z^y& z2w2Cf2{RyvZ6XpR#GgF#TU=r%6}wvKr${WKm)|G(69cfo0V2te9Fn`Szz@GONG1|) z4m+nWR0iKSJuNk#Dbvo=;TeyN@3{BqL6-B&*?gYYoSv)U>7WZCF4^Tm>xQA>!i&T4 zPssF}v71|(D~TOT%@D$3)84A`MLr_an-ow5oisqy0Twi%}u_c6CH8hJ}PSdb)vD*kv*ax)pfe9@InSL=}%bvqpF&r z%%k#jt#bZm?DdhUnG1=Ea!B^@H7?kN$DeiRaBjrna9-_!7=0_bHMT7cu`mu}Bch;j zD$wzb!?NMH@e(N!FnmM z4Rt9&O} zm&m3gtq2=tzig6-w&|X>%SOM*+7Z2gQBzwsK@cELWI(Drx&LmZFpp z$)4Aj{|Sk`E`%Hufibh2au}-_p(32)WnxvjdSa1@*BUGNOC9*TB(ES((nLbtq)s@r09qzHy9B;U{*BbfQ<#JX?>{&I<9|3y0@@ck| z^Ye)%I0?Jvtovn&=xNO6?ta5qRJrJh>+WctrC7lt&6VLlC4db%H!V@~84LFp8BMGD zN|P3Vqchwuj&n25G+xC?D#JFFC zq7ua2Re!1^v1rAu8|_r=U$$L7?LZZ9ima?)?+IkUxI9ms#!99XV&%7$1WI{7L_W|A zNV-P+<*{!u%XDb11no+RivIVwzSuwd9wWCnA}j&$8*0zF7mTc+sTQ=y->`bZ$4X3O z5>{h5x3yfPZsX<3rVs>Wq#53RMh7GKsQ*Jpgqx-MVwYs>eAkWA^+9Cy#TjkoVOa#^ z{dRLNRV?TE5|wK~1Lp<^^rEV5o|Sj60!gDZ2qeEZ?s|cp8%j*m`riilhEKfGSfX<@ z{?vEBdOPS`tvDYj;GhSBp4X9$%|vWnakRKJ;|?Y1pO6Yw1+#mTMZKQNRixA2kp@uD zoN3dq)UkuBSsJ@liE<0e{o+0y-3bg{L+b2t@ef8wb0_cO_|pIF!MnfImmTbUT&B&l zV)M36ah|1Q$YL1Ti$)LR)|!*wdQ|GwO*2{M5_fCAB?{_E}o;UrW_foZL zShOZ@cR=;xcI~Cl-R0Q~q7C?_!PFARBULF|rjPn0kZFvgf4PZG6`ocUm3s|``0o?R zkiE1XhVo%4yAPK2I2cj&QQHcmn4VSEX{$0h^q$@%@7h`&6=M&%uz{BcxO zF{t@;&`|w;$|rZd;F5@%En&Oj0IlF2z0RB6d)5KXI3@pE=hCe@RsuC|i0FX^rfP0` zrJPk-UCu|PO>G6S70#JdqI!BeKY#w5KGS1yS+nnNKX!RS!jL{&CV@pgqQC2aDuHB`NcgsY*z{wQRU()?K0zk7XD|)=jLBU$F{?%5Tj>xm$;%gW(|8xsJ<#?E}Xo5|z5B!$+%L8EJ zCuQH+@NkHq0voe7Har40{s?SLGN}ev`Kz^Kl1^M+uZpTIh4CwX;kgt0YmI?RZ7 zC@DryRp*pzp4im9u8L)66}i89Z9K3%}bVl3D-$K{FyLb^@(EhSipJK z$CP4lt5$r)pd3!97ecad?^#$O@fQwkRzGts57}O*=}uhM@{nflS3U0V=ydp+ZV2Uo zJJI@?{*oYGETfUTe=QURM|np*fwz24)of!j?=_fW54$wVcR6w6 zxYP@~OW-EMky|O7JmFaY-)z2$zBECAK?Kd`7cqhbsrWpIWoobmpMGJs>6F&6x&U^b zpNZH(|29HXTn(wt7!W{TX#Zn)!AhUGY&S68n_i5c@&3hHic#y28nd%_OQSLBGhe41 zvoYo3TJP*Xe|FjA*l)*=mdKGl;^*C<;?95XbnBC(Eb-C1Ck&@ydf|#?2W;Y}1@%D; z1eG8flO5K4s?(lTGM_<=geAv1k{6+Cw%#vE=CNhP;DrX!t`5~ik?rn_xpo$3TGgj| zEP&~SJR0o9*b|pTM4cnG1($Q|rF`YcHGB1it^Dcvn=&=MRwPJKE zR=)pNxr({LeQ$FK^Xi<5^M7EF4t zG&#mO3n1TciqkgThU2POuJvpl_a|8fEFI|B!Xv^iZ5@!ZpHaO>IYZw0epenUNen!c zc*2JacxW(Kpf)ai0_;#80axF?PEY z+Te^aA`P(vV2b`8*X*frh_mE<9%zyiG0|fA;uF*K$h;%dl1Aby0x2|GU?!S^2s_tw zh(%7{8{uRwQN^Wo&_yA1*+>{E=2_Kct<&4D;;mi9XIYSBBCc(Vh;wo;Q|uitjhrl! zQGA=%^2NUN)%-)uet4&Py>wxvlc!{Fg-Lb5VO^T#vTT04)=hCZ`**pQj6wJLfrIwR zar;raqNTS4XK^izxto!#G$CJmtJ51!MTCUmBD7su5C&9}7ku{qkkhSjaM&pP-n3O0 zBk!~Ap2}N@?|>O38Bm#Tya@StWy(Gb*f{9~GyzjmV!)<;UKQL+G}w`t^yMI;9%RbR z830+0i(ME<^Y0p2Ep-ASES?%?cmHz9z{p`+pX40JeL7cjwsb^(X8R()xuDA8!cIiL z3$Vme@49alnihKFdj-AnDI7W)&|e#3-1)Z%@Bq-ska9I_E*>)reQ%r@Q;561ZK4I! zDbOuj-TgK&Mlt5Pp{r%yciYd?A!%A7Hy~AWuScnU>vStx@3VD%_=cNJW(e;n%I0jz zwqq)+cGl!YUyl2=3Svy6LXTm+f!0PO;PZ8mW!`)zcngHD01y`;Ivvv5iZq@_ztd;j zWuLeFR^{1Yt#o&UA=Tl+>P@Fzqu-Fjteu}wTkz)A(ELn&5CIL-j77RTZM7+SAX|*$ zpq6|};;Gm1#XhFp?lBIr*$v-p#bE*%d`L4-_h(GoWSLD|u9k*3XP>G>n3;K>fQs%n z2~iK3I^E)5h`6D>9^St=QUxYvU=D-Kb%bB>wHI43d6%;eyY3&H25!=|ur|=;5mhX^ zb+pX0+sE{%8(r<8sShGNSd1WMVP8EP6+kA#4Hni~!F>~l7@r70i`&6Xl?fFZ*PS#) z#6{I2<4P?qt6g?=feO^NO0FuFgI)09S?mBPjIUhoP&2r0O&Xgj4Gt(GM(cf=1+2m= z;FVUHzhkSN@$Apk;(jAj%-h03_ijb$->>hg|Sy#Pw2&8Dfhpy{MDad<=aQV0l3N9?_VFS zX232Fq}-42f~#dcc^vqz2s&;cAm~!#w>Cx6X^K`pYE_0L?`oE zjziJi&s)z~Id$`#6cLDJxub*WA&>{yEwwE@n!MnabXqNGHUN zO74DWzqm)Q1$FI`44(Txd5we#P|s$8Z%b0CO+cCwKD$=GOWTJHaD(!92V0>ruA&;m zzT^2%RTPBV3N<_yQq~`Z?U^FvHJQic2o89b-d(9_Ss>M^)m6+Y=}+rX8`Xh8o=j=) z_S^E1I9ptLbtH?Sgh~mZVn7%{0&|~W~+cIn$XwlooY7hT*gh+A}?8VLI zy2hv)pwNK7*G@XCklJp;P6#4gG#2;QFl=BZXJDqRZ7$TFpAW(NwLh=pI!us1QLkS! zyH7bA##z7TLiQ<83ok;5l(>)8y5#*Ra+Q)%oTPH!gom{KteA19Xpp`Q}O@6II=5Q=W__dGnlU2S7 ziVqSnZK^Y*sY20~MTOQ(_ipoyD5HRZ5bMbh*GGkaq)Hn1i1ev+LWe3?2Lylug#Iyx zg}m?)ykB_RSjd_#JRvbU+w+uOfcy3GGfmq9)&_GeoA+EJbgx>9YP!=^IUe-{!cNBH z4hTz%5-{@FjI6kWkRzu=d*+N#cYOlLgSapB`MJxf&p`owfDKUrUkb_Y{Q}c35xjwo zUlQ+w9)_K-x_1~ks%Nfmtw#=>6I4357o1ve|F8fG(wNp}@Zlcyh3oOQ#6?6%@-MF+ z4JexkiHrV}PRf+W_tI z7M`$*QdQ7(3`OlQ(jFP|yUu+yDk+#QfzKqy)#@_ZXv6T7sf8eQyks4u3H%+AVP0yA z6;{DZ4u)Eh1KV}mkeh^_-|p|r7vX=%(GcS9KiQ()A}3t{IMio>v$mG_SWJYOsYeM= z2zL|LwX?!4j!HwV{yd#I;v@P4dHx|q@n7v{UB{TXW-9-dSqsY~;&1Vc!oZCN+ zCwgu*)li=S9~O@CK@ah~-v;qiF1xQhoB>)@I+Gj((}oW~w`CeY%jECiTC>v zr>}Iey5LP9d`SYR#o`SB$>jGZfW8g6%vpWGe=C6))Ug$!&F!+@M8OA>ZFbNor1JIS zdPPP$3i93l?V5$>#pd0!tR>B*Bb`MPHiU|;2{ChzN5tBbg&7ob_PKba`U9bxom_06 z+ATq>q9b^#d^o0HPJXDmd*RO<*8?|okNvn7+?H5T{@yO|Ti<<+XMKdIo;iUl*aY&a z0gk`JgdLE(vm&s#^IyEu1&;O!4gz?I&gTVMTCO}p)%9+H;7*NYy|CMNs-~fvJr>B* zHz-@AM*>LbR6pO5I{>fA3_$1VFkSOL`rMB&lKZpcg6L?gSOQqe@SM-lmNALLF;k~S zlnkvn*@Q7$NkV-#A+u0^9P9u_JHa)|G@@5&^&N==qmttMt>gFMA2F1{ImSzm85hCE zY+_{yRl+Zq>T-Z>Na{LI1u(7(k+?TzfsFWYLLV!=D&6ZYFRMMVzt8kQ#4s z2Bs4FmAGK@oz97Bn@z~r?;_4`gjo%&xQK@|_5@eYPBK*sw}vV_-r05wgVd>0fYohI zV=n{YOIr!3oED9f)HtyOMrzOHL%-^azxvBk>yr1@MaSxR_v4QSZ}anYjJ$oB-;S~Jz(zav* z*sx^Zhi)eb2Z{|w$L7rMyE7^E9``&Nab*xDUim0xMscW!{Z>#?uGS}xgv@~?W=y`NHn z&aVD0q4?16Q^JqIBLR@fMVfWsbGH>e%Y*qQ4a_P15EB*BUIGAZ(KA+hPxCGg3NO^` z26dIlWHhS93vb%QBvH_1XXZl5=)__9%U*Sk0@Sub3O)_ZaWdx=k+A;$Kp?84D+tPf zlM^GkdD{2+%qgZ4<6=(qphEI>(&gU2hqC$Pci%PD>N7)7gTun0~ z@b&g;Kik(#?~GY8?>r_(Vea5RT|D^xkjF144%kTvAgh}yrX#KeZ)vZU&u{?r)_gd< zzfjsN$h2QU+b`2R}c`dfF)H>DO&mHKbK+g)usynHSH6H z@o*ePp9lA6yBqj`_b>ydqUjUF-dy58Z@`0iu1B9{JJGS$fgr+7-hyMR-MKpt z5;{z^DJ>2r^AoWK_c&W9TKqswwj)K8!`B-3O#sNnns+rry?bLc<#k)cSc8N95n4xl znpM8fbgqE)VV=(5^VDIy^mvV8hZf(1cLEpFEO_0l2Y*g`PS#zCc){)hOFrTNK z=h6$8iJLbkbn1HZJDMSWRZE-T1p5t4IYnb8-YfBt-PYH9doN8=p6M~-C zG|=-9P2FZR@Yds~-H-fYLJQZ%B%Gra_8RF{4z1IMhPq%EAFF1?G$We(!s+>~Z_2b9 zF}q?&BQZV>a8Q~J9C6H+^^t5Ne%p0TwN26x+=8STV0zNk&VqMRURCb@=`;lQ+~NwjNNps+S&3Abcm0&HLfDo z>u_pJHH)F=GxLX{X6I>)#AhY~u3ct}jj2(9%Q2Cd4PR4b;{K2azPMqkHN~24n4kry z&Bz0R7gF`EIO8guAeSSHp^s&aug%GnjbvFz=W44viDua{dL1jojaR!$9kT6N#~qC6 zC>B(iv{iKd`4I_4v8&AFIc1>*|2aUa3l2WCw0K_r3aEVQ(+GG^vCaS7vA>4-ffA_T zSw2y;xem4^Mq3S^`1po6>*ZChWqvG=LTgw6b%Q>8%$hVfCi&*%>Hg?9#k1Z^W}$A6 z9FsymOQTt$%inYQ&Us(#ZHNvwqb4&HjPu(xa_usnHHC9)EsKJ57&w*F;ExH+Xm26@~Sn^0~K6d)J5h9b3o^JrCB&8#`@Qo3L4#Etc2@KHuq3l)GUFc7N4I z)8cJ`FM;qEcplB5ih+@ZGZ*l`g&Td0Bv6Ryg0wZSP(mOt#PTs=;ee+^r+t!gF-qWWErrv zet8ZDkl*`A%92U;p;k9dcdp=JRsdUqD*Q~JY!CBX+CedCN$&3>5NKFHs;cG+cXob= z&3gW=tSDy8YAAz=-zprCq#NQNIKd#tW==2KVM~>p!*}bJAC9OLU}PhkiDd{$4*O{D zgIFOiU6Ak%SQ1s8p6Znu>GCjEueWpMmhtysF7*YoGoNleu>{5ek*bgQ?;bWY?<+e{ z6i6IXiOUEIpq+`p|0y2sDRL@QY~)#Xf?LCV!S(Z zsRxu+rb-WQvCZ$Xqa_{2HO>sAHk3eRWZ`Jqeh`}w9~ljo>P{BX{F4b}0S@umI`1D8yWuTe9SGbKsb2I8|e^aXDJw+cOm@8UIb7)HbEd>;Mxm zdaK+~YZ0TnOQZ&M`f!hVvi_+N0q;)z5}sBqxY2TZL}%K1VkW#Wwj@Ljw7_gq+5(I8 zfToTSiqkHZf4vSgxZ}q@cZqQ;KsbN?4Q$}X1Y|$h+Oj@^ZFtx?NmBLCe}nc7Vx${u zDF=BACblP+S|$l=*d56d2Iw0=YZ3#p zqF#8{S^2aNrcOPaOyH3*oY9yb2)!T6?wF~Oud4->)0s*5y>c)+SqYJ-nzs+M9i_1+ zQ|ChwU$Jvzfa|ZP^@c(A050oGS05|sJ3;ywKuG*ckoi3SHi^;C=z*WolwZ%JnI*(V z$(m}}@K7PpHz{9gGq>jyaERXhHZq)Pvs+&0ED_leeax5l(P(!d1s>z)XS_1*_0FW# z`0>vf&yg5X^lsb9HSIE^UUJPZF)vy$F#bFgfck$=9BhtMg1-!}Qp@pHz{+JvXZ#{Sj*S&)6h;i7NxB$uGSm^fB2@~cFHV@DN0;Dhd^*Aw4?Vh?LL#?oSx$aLW zst4f>Dqj7?5~&0xWo0hfHipumH|9PWQ%)Sp(F}1%v*6y^R=x`}xDLph0>C|(mEDy6 z=a)AzN%qa^_J`meK!x-_855LH0erbcI!nIW!OhJC`*VOvrL*LMgAYkud||`LcD;Y_ zGB8#@5-17Jc~85$aK(yir}ZP=b_GHKVgz-50s1h~ZYI4;#+ci8B z_w9V$tF0(m*0qN9!;Gn1oY}cP4q$xZBVeJN6)->3D_kX(!to%u+n{7DN9&FM*znmReb5;gF{04RIpdx|wFW6D?-3|Sm6Y84aNp~IC+;Eu}wpe5)6^=Nr_(FRlbK|X|?T6a7a(=KBpYXAkiLQe{7 zV=8j$-@7p@25wRukA)YND{dj?6-;K#T@p~QS0bFv#-Q-hm6H+kdnq#}mR#?917U>G z3%oPAz3(0NOdtnm(@&Ryi{Fz0jd8D!gq{9Yz8*UlP(fZEMj;?ufi$$`-p2&T617}U zVlMWQ#Lt36FYbr6vu1YMatS(wZMecT<1USn?PD>Cq&5EKnGo= zv-9Dh0$}BZAp)Gm;xPBQ0?N3+O2YfgJclN#%$)b9xOHR;2=c7kIdWI;GGXpOjTSK9 z>vuA12oyIwwYNNuw6>%CWo4-%S6nAwbF7DMM^tZn)qH#)=;~KHVZ7pK5c~Zh&-u;F zC5(LROG5_aJDTk~wZI0!43Z%_Y*MX&%t|o`?)b!r44vFov{0%R6t7+5(^|{FLNuK4(Ot9jArHz$4))miO&SE9t zb3^A4@e_sPt)`hsgk$E7y5G-|k9S`-yuGT1<4gFSUF(-W50=4XbdrOB9jBH3$i>vg z!G>XFXoLX_e(2k^vk*x|855U_j<2+Wm%<-VxqKX5`myP~M82SiTMU7lvomRz+#yHi zb{Ut$$u{K~5iLa@8M+S(-pqBK>>MX&WKjeRu&ifTNyry74fRrO=8WVZ?l7bx?hwAh zBrU7&z|NtpIS%CzJKrMQ-RFdNAPj0+iZ!QMXDSV-j(2ji1k%$cd!%1)E%q9p-cN}h zOS@Ly-jgEE_{{(7-K07#m)av-EvUbT8_0-1CHstAQ(e8^f`jpiE)ts7o!4NCrC}mB zn$pCR*i76v(WE4!1lJT~FhvQyrUiNWo8AZ7aRN_<3@1UizoPl@cjKBEZAG4wT$R); zJ0Z}Lv$j?>-KIKeqk@Gci6!@3N)68GN)f_HTGptTs)#uLshGmDea$FCAg^3M>;Qkm z;u&?lMs6$&gwH=ud{Xb{o!@G<=*M$K9u#cEqchSsmPf;=BTnn~f<#>RQnsU+Y*-`r zCU?YUYILZ)&C5h)u6du=Ogd9`@8c8}3WDIz>n~Y~m;O_+UJ0|R5{#e~`Zo?}TYvqr z?0fEaDdPC9lJr@XfhHVzsNyA-zCmof@kWc1Jt@MWB6L(`N>Bj|iwq z#f53B4j9j9!4pgxw0aRQx{8h?HEz7|FV%>PnNvid;jSj%cgvkC&bjOhqzmdbj$1u3 z(60toqZxRs?GfXvr>ik0tLJA46H6VjCVP7kq zF#ioVR1y#>sXYpB%f=$gAfoYZ8CkL%}Syr#4{!wKKi=+HHnCqE#4 zByf_E9b}7t9npFKZPn!)iD4Wm8^e(>!=>#6}4GlLn_$oW_}$6b=%{=U)H|`=^v+tKc*X zsjxl%goV3K^Uia%Kb`_EWS_R4mG9=kuh89Te`17gt=RwmEK=N|SwyFx-jr;~Fy7rv z%YHbl7q>yXyYt<_wA&A-!^08b^eq&m>IO2k#36Br?K_Yb27X$^Vv5y1k_rSgtEG2s z@uodI!X`Zr7a%%ZZx+9AU#e}5hOcnZR;%|-Ea4(($95)_DRz!*cRt;Ox;|N5`o4on zC?5DisX@n!2OJ1_&lAC|&p+zg1!(u{Jfr?f+oQtai3?E#O#?z+HNWbIK4@7qHPuFY zS}o2vFusa^DUgTCg8Q3()CU5jW{>coYC1DHeqOq1oH;?)BB<7SG@ZqU7{~H1_~bPm z(CILID1ePYMizQMy})3K&kVq_Ge)YlG=OR1*$68HNPZ@v>2V$nDAvV4dS3sDi|kPG z)ov##N}e&pb)szS!ijy~ypX#GvaLv5tXM;_`CZeZbiWmuEGD7@AN=3}az^1h8Hd&f zFxHl};qS1>J(jRv2%MyPH}p_--e6GB@UM2s&AXgO!1G_S}8aAd$O{{N3(uzYouf3~&K!}haQ3=K8)7{tbPIB&tl zToixKxVH@q*|5_+9LaqaNbYGb=$(huA1q223RA2cJwf*`d>BJcg1*t^&2kyhPJ0(1 z#))Ywm$1(Ld1L0qhw1D2_~PACXN;6%wuv|KzQv0c{}_U-SBJlY++ll~w~%DLq6`8= z%QGw90yL|h?>}#x?Y_LYfe+oIcLVV8zit%#H5y_W91u;7PPzqJAT6DWGQUUT`ADnh zZ?5(4hDnvhb;xzp>;!bVp}Phk@lz)mRe2dYNc$iYM2z-u(RoREQdXaq88JiQK)D zap8L7&uq)9UEaEgUPgzwonb4S)Z2_*4C(b;ekYacO_AXy#6;#{lDAd_QN!-7Nf;<$ zOUB~1*|}AD4J^S5@S}IzMAK5BO)q!f1e_9tXde_tI&*408UDbTFVWpjYN;NgU};-Z zVnU@+gvpT9QcF_a$}NY)&?QagXyG!XC8No~YbSU6JMDh*>GbBXS$IqdkDz|54!_SR z{g)hy;kNhXe7-kwkL=qhXV}ah-x$vbkIJIS*vUqa)|MJ-@rtyl*Z0MS5*7sS^c|%MA#Nz)NeON$W zh&oo&dk}SvaetOBe&{ShL*jlpe#?q|6@fe%^Nu^)3>F#`Eb+|Ih3=In1YVTffx z4HbEN)#=G31u942cs<7$v!s$*s8_tPk}|;4vSd{rZ`gkoe6bb~)PWoYsM5&Y5K6bG zDA-~Hr#Q!t`*G{tXn9R2S$KHE}HT7+K zql%~?Dr%%yC^mYLBE1PB2mzGdQ6Qm7?}Q>s5di^}KV$IInv1*3MR{ ztGo{`BCDEvG{`Zf6q0`)iD$6p1SX+5T5jKgf!9PqNxkG~WV8 zkqX=*5z9&)4pI@2xXZs&8ZRruC`78>(VifD2Su2O%7rhxM|$&{R(F&3aU8bvF>dP|#{+C1{#}bAW##$y#+lA_Tp*0bj;L~^sDQ_$@x!h?xXw?^ zt2=&eF$+7pyuBt<$R&P@X5;DF+6w}kGuJ(anspV}uXa!5nBU@{gh%C?I6+{POJ#o+ z@hf2SfcJ2wd%Epte{3hW_Tf?@p(9F8VYyY0c%VO-e$1XyEqn4)9I)tPz@qn;uS)=L zcoVSbfK0Fzh&Ms`+#zmoh!X+u%Ibqg-GxIHdse#;Pr(`k9xhP{u4_~yaq?L@o{=4o z3b%JR6H*dFgR*{@;XIiRb>^S3uUJfG1i3NQP{pu^xle^Uud?2hJkmXg@B5G`AlI2L zokE_!nva(A*7PtpLYO%O`Xqznpj1c(64&w=d3c zLtl=vY+xn zsX{Vvw{Q?>`;Jn_{mDEC{mnd>v-yrT1!JZeii=E9&d%k$A6JX5?xh=RYx%2weE7~@ zQ~6urcrFyKxi?Ft3&mQ+d@=Jn9s9xs{Tarm$%@m#ifMW{D(vm!48K`wBKfksC=r@@ z+0JA`K&0rPz$m^Elq6G3q?Nn{Vp>I!v`()Fsor+|7kK&0ejA-X{ngczXia*^d>O?V zA52P`5FI>q5X0s?4s-;ZdKIJ+|J02yGbQ0(Wc5BP2&sNIIL0Y%H7KvIsHPjB4cdE} zEhg%oP_-#w-!-eBP_%@{!!~rvyHM)ccC6EA>oLbPAwB@;ix-UOkF5KKZ-<_KCTa!~ zv*N*1&cT5HGQz-Zl&78LszVImfx3__&lSMFNd|N3A zKUSg?tKj@(x&CxiZ`3p2ZjV`EOvj_n8OKT3LwE`nUIZ2C%*+|c<$$BNM){P3d9Y$c zPZ}$hJ1fDowP_xZ2Geo5_i^+5v@SSKX(DqJp*T(-`w*{H7{5@;f0YXi1VkePI!F4; zlQNJ6<9K(%-saghEdZZwgJf(Shgx^L=HP98XN&SS#a)wo!e`Mn!*VKCaSBasZ4-x@ zg|po>7rq?6Vv?thG2ly0lYXo}D!T2m0B+xIb>k*MPHoD#7V>Eb#If+p<{B|07 zLH?smxyQ+{8!p^>nk&}j^dO&g5_rv*US8q)lK^xg134$Btq+kvH%tRIoQ4XK0EaRd zR5En;+AJA+SV=h$oF)fz8!b7bCJ7CVjeZE>BoY*?RtFwS?)8udD-^fiX?s_2c2?S3 zCkPrfke*^h=u1n8(i@!k1mjEZPnfN~sEbShdDFphCv#!}X{bOOF>HX8ADL-)ykq@% z(Plh*+eIve$HBqDI{SN2;5{!iih7P?f`yNmC|Fmr=e?EghUKK&`j_5YgvAMkn7Arl$ftX zBh=ybmHpV|0x16)(s#$1C#gDOB>E6APYIU8h}fa6R&VH! z9Bk2DGmzB@GIG{1Xea|!M=~aGgwK~L{^I@~5lQt(5D5dTd=KDBlq5hH{sm8ZBV~5w ziz*VQmSO7Yr0&2*yQ#&ZV&RnAVd{X_oYyJN&iexGPy})ATRF{mx*XZs(p9yEWcxKj;DFp)?+A0 zmFu_|^Lb9vg8;#Y7$BH*LjOwYPen!vQXl}IK$S41sxtQiQS~E7fK-kZRFEC9zQ=Wp-YU62);F8Rq1%1C#7`)JK@hW*US@{bk8yWBpNE)M1v zecp^v<6&tP_^9yY@z4vDbxFE^2k&C;P{P6Y>x!M)&@6LgF-Q67j_+j%3wISs#YknV z<}}z<u7^PFtGl_T`RAD~>ANg_Q1MJj`9jzF;FFMlk`{?y z=^w)RYF=USlCqrE9|b`lG3u2=$A4w2#1=)^zE4K^2b(eaeRf@HT#n9z3c47geHz6wWC2m%d8!JI5SI9W! zbMqnhZ#};^$ArFgkAy;;QPv_a7ijG{FF zb{@dmTV2pv21yOlH&WuD7=s6I?4s#<$*!$SD1`M{p)5`=_X?PZmqJHD42X0t4c9rN z7q-=c`4E>@O{(;WPdVQ;5jne22wE61D7&`LLl!>oQJERj0NZS<|BXT zc@po-U#`@u*;d_}mkE5=Xug;F8aOQJP9Ut52w|>IeB2Ka?!6+Mcf*r7O3K0=AJqEJ|;t7%&tHMM}08PRHvbU#k z26v~b6Kx+{Prr$q{SA#1)*>JtUz$OZSZ&w}J%Py;hipUVuzHUb&+5WW#Nj9(E{Yy) zi)$UonB~YI)&%Lipn{kzvugPV5c}E2%Oo@b%TjzexL{JO3dZ!{YMj5W3aC@o{hljG%sDCK!^2NfujBrlhrW-3KRm( zr%$Q=pa}yiOX?Tc+wIyWj!PtTDgg1a%5d@oF)Y!go8q{`>HIrskGJ-^JS5ly3|rc} zQac=7lE`N-Eh`>XE+|p++`W!#X_ZRtSvPNVF24mQ%6l`nmv+nR*B$35$&HwXM=cv8 zwut!bz351j#p=~&+2BxTm7A+4x$uq?5(R6KFYd1kdd>CZMrTNLoAP38taP;4HDbSi zNzTpq963{br5c&6JDkdU-pU3UM&{9ZyUpuZW1S#*aLIi0l7YQ7v;`5wf z))Xm;G{_c*ht^#Hr*@BY|DFB%!Q8k{ZT5*5MhnaWwl;0LdhTlMYQlL|eD>Uk<dxmm+GXKBRhy?_Af z3XZF@p`jypIKK`f`jw1vCf+FWuY)T+jXc~KXlGwSAd=1umrSwsIkqwxW*MVxpuwU3 z(B?5ZvDX1L&>_(+%&tR3)t%@xvNDd3OjoiQTk!5?7+REoY%d-$xX?o$_Drb}bu(ba z-x05jDCNOOzbxY3JAiKMO#N{hDC%b*Kz(b&fd#7Lrmst5nLAHoqc|l`lHQ(4c}RXZ za)6JgQNbam%uMGA1q$|Mx~aO)`?)gNz)J~;on_}7W=|(QAt)eNpi>%Zk)D8eEt!jL z%YBuKijLgPeemKPa;$zSXZa1eyZ@f0@i@RY7a6mDOBXW5C9%<0sG^Y<7G6a1-ZDT9 z5ysbPpE=0S-scg?A)wiQMV^No#5r3a<0Jb&c@D;pDS|4dMoi;-p0B!*y#|n23?teYsb(Eph;y^Hv0S?8nlX zgdr~yZPvJQV^Pr?pJOJi70t##!gEt;RorUAF-WZ~>OWXFW?^OdS(2(ParV*sg?-=K=`@4E6EKv6P7fd&##)(1E- zzmHOvjP;l6{c(No>7}url$=x?mQ;zaDr?D3V=dAZqPkx0SpiKmCZr*kAp$V?LO znhAm85eT}w_`=2Bi5hQK?_7pqX?XSi%<0BQ#>rSKNp#8w z*k$fr!guCRJ@~+;v99J=7fxy>4>uJwvZ>we5H88SRd=8&`D417yQGP9l)0 zdB}JNq2p7_cyRQEdg6`Uh1Z6cTuw6lallN-NM}xFnY_h31@1T~83{>R@X>&b$weUH zE>F#r!BuXOhr#xPwN?sPxxr!Xd`)Gh^Y@DG8td~Nyf#G|L}?UsZa(hMWn<;c(#gOu z#o)vtF(-?oB}|d?QDrkRB4%iBcg-QtoGaB&DA~^!{l|~oxvc5iO5Z9r@J2LC zD4539!SV{1P!{Z*^1^qIMzJWRtlJ6X?pwp4YP&o#>+wuirw4!z-^y92SB`Jy=t;eF zs*ff2k6G1HY);>-bHarUau?oh7~Bjfa){YAK^HWGy3~WN_uy2Cvh7O&(Na^V0e1>Sl0f~UFt2@-CC3XkkP&#UrN z)n6W~pDXt(d!}|s7~*1rT++^{GaVWcx?yBKPZ(#%L(Ho;^uy}vDJTqMe~4_3OdyvE zR^Mkm*M=k0GD(ar+HfJu7+7(P5`(1SC;xd*jgx&H5@+*kQxIA|eW1DgTroRCnbV5x zy4+$AQqELrtBWA4p0WGI^>^PfWTdMnvzS`SL4)oqsS6|?W0dQ3ExI`R) zjZrgR0> z1I6q^%?q!Duh*+;MMXb1oxauy!t$8Rp|lo9wj@oq_&MGig0_a*mmFL*;+0omX|&e0 z&>uX$nV?yF;mSLxc?U&o^NU^q=C|bzDNNCwFPmDa~U&Hx4njYQ?h~2L)lSnukX0QDmzdDiCFLYxLyv;R1h_4;pTa@9NU}-2gS~?q;}EF)jeTw&=}j;Q zvVcbcp!iLNN1v8pri!z&lqo@8GdQD1eqH7hj13v$t%GT6}L3=}aP zR=@E|eOde%1fve{)j3^(7_jASpx)|h19Jg|GNDNj49OrK#o zf*>FI#>4#Kxgk2^9GI@H%$^DaB5makgHCu*s1lvnTp@!2PIW0#C{ZKJI4vj*>3c0; zvA=$Ey@H5ODz=|wJ3h2mQfg#QKrO3D*+T%Yf@WR&zq5uwmLu+8S&lnBJUq&KNDvm@ zORa7eQ&LpXrH;YQ^-a9!d|3z;U|w)H#kuEK)<49~uy>5+*y)S~D)ARXCE01NKUi3@mB;HgDgFrC8h4NxgJ_xz#&nN3JVIGbS_H&K01 zHmqB=DU)frx7BbWSF6_++m7wEppUf&d2ioErwv9zMSe1u82jVD!tdRzR(LsFc8zli zRq14bd`Rat3oXL9L$5kbMR9XGo0Jd|kue;6RGN7&O=&UPAya8uhW7P(xC(`fw0E!_ znDfurqb#QtsynuE^e7Z<{6Js2JD3$QxRmB)_;JW!w$Z%OMFI2d2B&>YZK+W$MmJ@^ z!?eOXoawVk0?2oX6#$UlvG(Y>P7=TM>f7~qqf|hS*uVy#x}K>8iV_Y�SB53BaR& zEuRE2iDNg)Oi6%AaGEkfn>4=jt$xlO{U!Zo#BIE>s7=d=s%<*1Y=#ul`Qx4YTdSRM zKlh)Rt=64eG4u>kU|0jQ1XVn{+eez!3iWVon(F%N`H-zBKHuI#2CF3#GaL-epGl-s zyDvv;D6*`(RTLx4V{7^d;D=$4b#zu_@C{mRi!s17&?@o~P&cn%VIQ*Cn{SU^z~?Ua zf8LtIoEOJPMF|ab!xnmOwVBWNRF!iy4CKUrw|b44Gb4}vF9>X9PpP%b+-e{WvnICh zte?3LYD_&2L|t(QP68bJP*M@$W*tgi>_rD1%lVDhmCs2+V9QN;6A9%==(@_f`N_)KF>L1txWxNmPIELa~`A0u;i%Gj{bdd3&-R8%@4*rV?k|rkB`TB zcdmD*pNFa{Bv^+yM9TyXkZGN8ShkTr{5Fc*yWs2B`i2M9C5uvei9rPh6|SAU_&er0 zerX4!6f3sZVz?9s_w(4Uw4>b5FCOqPQT7%luEB)!e!ckA(O3?Ul#RQ^ z5Be9qk=3(>o0e4t~V!l=}O_9Q2_&2;>njH%~A@341n$z;?5uJ z6XXHF_x$r_^ZIEk);8=%sAn&R{MxEeETgH?DKHPNne~L;Lm!Yw>zWuWooEJLYtF4X zf9F{ux*hCB`U#k8@zmyqGB6bnfY&=f_6`f!z2^!5@VelMt?-$?AjLrYfjBM=rW|K? z+h|p1#Z~!xe{QvhAKQxPX}q}t-{v{R+k;c_LCTuCeT7x$I=6M1j3$Sz43N4%h1n@% zdSCK$KPPCVrMEa1atSn zK!`s$7AIOD?Sa-pSbwRrVE4{H(lLM=E`f{FoeABVs<$$rrdeXSiy=YW?w1=k&#+hC zE<2l>YpSq!LHDr^=ZwduMeWzBGSuK2a!W1e+WH1!#r>Tqle{zK`Le}|dX54cs?4>N z>>wF`0nj*wZ8AE@{{0k(Psqvt0Oo?Qvz@gB<~Cc0yifXP=NY}37&;7ZRLW!=RzH^A z9|c~|w|JO#mPx6jKcuHh2{h9|t(p@zEsDAWVGXz#1~paA-ZziVDLX>0Io5T}Cf)$Sm`|V-HL+JKSb8)*6KQOzj7M!~Dxkp#R%X zFe(k`0_l(`84w>niU*o~L9}C+u?GiCQt?tPwokR-E6gI2jHP(&#TFYrapn;>=aJSE z(yUo;Z+)xR5iq<)2TA|=LV8Y7i`SoEIgv5sMuU8L>TYb+`Mb=-1)7Y8BS zS989!#Lx-W@No7DC*KpW>bzg%RZ!z0uB$Mx^em=jj)Y^4vLVWAoNXUQV&^WUg2TetQ8MlDzz0-jhmkn2z$kE7|^z1G~e1#pBi^ zqt#Y){qsY&=A3t#Uu_bTh_7Cu!3du49eVP4kic9LdweE*)}|Cx&_3+Xk(xBgm7 zSvET;@c;_ii`71|bKQB0AsFkfVV*wcD`0n?3&$#8Cs@*lHu3sQttc|h=qxzSthvsE zUw6K%3|5pSZ;o7P8p@kGr}%DWMQ_Q~^T4BYB{IM5ri2)~gl0ujrQYQ5+51LYm_FDH z24K)S2G=q-qx0GdX*u;S=7a%+yjN8jz+@5wqAx5!)H%;FyaDn3E3nDao^R~HFbZw{ zlar$%PrblY}NK*M>Wd-;Dk~mhBtbUfhz~09UTuhP63Ut zGRX9xSDN1auo+ZzMoQvl6<&*{d(6iMvY4P;_05^OOQS-LhpKJYrouu3i{7YWSQ+!q z%ru)!C=kSO$m*HA++3)@TsZhG{1VLb@V9RHP4ma1DG@E2EkhSzZ3@tm!g=DjN-+nR zS-RGrgXsNB1GMXDWqDgI#8G#uaWrg^E+{)6S$bSBZ=ni$3xWSkFQ~CfQ+cVX2&+Ii)t2y;u zuz`r2vcJfb^ahnAD_!X{2Q3MmET~q5E|qX(ffTRe%=dx-nyXs&ZH2qQ zum4&|nP(dZOP=mj(9+eB$9`YqgY@u@q!%^9leyg!bvH+L4`Ax8i-R9xnHF)woN7I! zwL1GqAbtYHDT`wZEVI1}x~^o6Z|DG*2k3r3f3T((IM#gt1icQzNGreV z08HY0AGpH)7Nx&|hnyJ&ILpxZYt8s>hmMgDB%DpB6qcOz-4u3Pv6FXK|45vZM<=Iz z+=XpYC#cn*BVETrd|0IuOzExA1#Abx7;&tIF6tS(mrmZN>DS&C)G=esM#hD|J=m>> z`Gn>g#n|I@ENzxz(#+!Welef%^#=>&eDrqxuS#aR0#tI){c<9VLDUdssw>&RcJB$rfdCVe{1yw%Gi9cC zy425=5rhE~%}M?m7i)2uvXVC-3FG{G2IF+>U;Iu4Bs}CZdkhSPB*-)!Y4bsVp`Zuu zfszcyk%MD#bqR{DSJRf5PD-)da5{AG?rIK+d zn+AU*JD(*q_nSEdHiTNKJy!m*R8R0XmqOY`vsIar##-8SE3QQ8rel!jYjtPx zT|$G*$f?%#yX!1z1XknnctGzb1{KkMCto^Yv!j9W3oQt@gOghTW`$_;q~eK#Zy~f% zKuv%t86m_e864nfPJqPssUBJYrU4yRJY4*G)3K?1s18qCVXVkHFC;71^D`b(>RHa- zGVe^+0>q&SG?MCx$t(kbA>KF>1y1}y>Ld|u2FCl@6UY03LdgOc#F0ZmLj#_6i`Y+u z3)orAj|__&bUZ~x#c&{*i#OIQW4h`9pOJYdS7r$>sMW$fFZU8 zx2#Eq-v(is5>O7-B;7^eDmU@!b2vzHogldY)?-CWcZ~7}e{K@J7H@b6&@rILm-bJO z@A06i^1p+o&Vthx+9Kx$cCibDhC}6u?)E=mo(q6PmZzN3f&6=dMXz6Y03k++U@KM- zw{(AS6=;R^(|jL^8#j*z=C)yume?prqyv%jH~CD6(Gy_zvfqnT2_VJ_CC1Usq0hhp z2!YIVeSr#bx}_5rNa1yjA&70!;LFxT7X8yS{o}?-<2c()6v*Y7L%`9**70!yh#&>H z${mdY-H)%N8UV4bKW>pae(Wo$1LCiiIp;qSaH zN20VYk7Ix%N8G|Gz?H)%;#tA=C&21FWjY^$2gCxz+%Rc^1-NQNy!y4{E>ZtnX9C2! zFLLHMas($#9G-O0K?}g$eu02<#1Q@&;L9f9ltS%It^zWE{BoJyB81rL6HlDg;7CY_ zJodk&Zh#SB-_FcI0V%dY6ZGs2OC}(a!;gSSGW~{vSY;cStXT>;6S1HOh9!_z2lVp% zO<6pZ1dCoUYbF8`#Q-1t#IcKkqqzPL%>X8@js{#cy3co9_X{BAmqXtB{#Cxa13cGIksOWCdTQ1*c>(N=vMl0Kem3S)ti0pxt`3+HCsx%ROg+cT#*(L=BLl z22>Mw0%C%|LInVG6qAef6R(0b@4QAmA=)8+BIuDg^$~0y{P|4M zOz|oT0?eWG14Vt@y~A_dy#p9A=>;Ixg;W#9_g}aFFTzJulmB*|Kq&A)KNKhM@cl2J`TL~*B3b|QJptZD1qlCU z2|h%fhj7yUx2#hIpP`fl??9BNp>%o}u{aEN_iKUNj-QX#kB?#~!;L7&b+gghrf;}I_5f42hUc9&+)T=x3lqK%5Uu`T z|ICnRAwjMwW|ax%lWN6se4l0Ib@dTSo=XB3>MW@ zx`;7ThI~3yyu*p!Z}_;@N+7t6nmk?ha0(Q&!-uyB6CK)1<`;Z>ecYZ-4QIB-AbypP z5fm)GvBf{|+NN^f=cbR)QjScxeC=kroQs$}`n<+|Ukt6ba_AkfCPi{n0`^VfQH=Q~ z$cj%aRY$_0RcW`Op53>-=`*3I3GOhI3HJ)Jg<d&^?^xKlPw_Lpn*Z8K5C%;V|(zP-XZJ_qsI={u8z$2zg z@BP;y?qasXb3aGu!)-k`xw_4|HolG(9>`q<;&3`{}l(tx#gNY`>g9tyEakr-ChO(Vuc59eP#KHlMajG zUU{=_R0mG4GISk|Sig8^iyo~#c%j0R-!V{A`Kz2k{OR4Uc(?h=wKUtq%*DR?Q$c#Q zx4I>FQS~y!AySM_`FyJnU4NQFSbc-4 z9SHH1T0Y}WCN{{71Rv=D#lvu?ziq^dD+@c`zr$Qw`HVQJH(qa7y-S)c_qzEnGxzvM zVNz7MUd``}LRdMW>|6OK&+RVB$Ov}sBYesR19hp7bKs~W{>z40%XE~an`+JGRMk_V zyP^prtT6EYCN+ED_7JB{HyaM$Q#o={Zw_0I>}}BWv+1Jl=!p#}{QPn4hnX850!LMAKI+-P&o6 zlDK1q=;z&Co50@j*-UjeqTWb#6BsA5cr^2uBiofB$@>F~Vx5hZ`0hh(iB-`CUehD$ z8zbyKM?R9Qh#5ZJGt&hOVs}dQg(cNZpV?d5A6?}5{TkGrPJs8DJbk$0O|`*s)_r@h z@>iH7f&AL|XBbvva%69k%YE%Ex+6?!bSqlyXtuPYwv@)dJ5EOA5YvEt*EKuwxsS$l zKG{(dj7(4L#BIaB>TH48PN(Mv(zbT{)98-~U)A~ifAyGgciZkb zcGg$s2~pVo9iF{~=9H_cP;=RTwz{K0m=*$x-PeO`@u17aeY@qfw4wKJ>DS|JiP$Y} z31Nc&#-HY=XP?+ad@zfit3fFo;>OSE`D=k&gS^ti{kjBC^N{{oe!z#=DA{u2RAcP@ zv8R}vzwNzdirLH(JI?Nhv86Pj;;Vh7{D>8QoXH)dsKjL!2_q*SFvkS6fH2UZzkyP@~> z_wpMd_SG{X`*UcQPI#)D*d?lQ)5Vss)`ML;m<#6cSv};Q&!^`t1W&c2`#;lgl2ErF z=)|bX{8+@R+h?xRgI3qy{y-ZYv~|Nc=!S%%KJlRssuy?LUZS)5xJ$94tgVLE`k+(s z_fXBSA)1?RKYN$f@}iU;LtBS@epiheMpI4Yi{6^3m{MG;|6F}7BExX>R)h2Yi|ESJ zN5n4O=O;;0CBG%COvL7)>@bHBbCA zR?UYuYE1e(M^d9A(BxVqpxu48rVy)C{)0x;|FxmPHIH4}vhMlXpQ9X+O%?S*9xJY3 zhH42FL3b;Xf|v}BxO;yWOhtb)k%+&MEk4E&y)s`@CZs`IyKw0G{O%JBaJG{;N&EJS z8+V3g4jDD}uB~t_o9VO64MZl>{Fv1MgTFlcqKSG4U~8p;K4W$mGFl8**~o~OkJ6T4 zd83sdnf!2t8-94SwJcPWkMDwPQ%V;*YrUj(mM-R`HhAoo#p{!)XSW{M#xU;p?QJHl z70-Z>lWFfWXhEmQ<*Xso&>^?6ly8d0pwciba^eJ&E^!vX6ty0w1q@2}h%N-u*U9i0 zdq(Ekfm#&jYgXP$mJyu`ICqS-Ah->C~@ z59rNVGM=;|vOk8KAxh0pG5m%(3z3jgpDvVKe0jGgnC^gQEstAnhcatuEJHVC31i)R zxWgZ)7+S*3yI$S6bx2z)7Cz&lv(r8%_x>}(uu^o@mA307qzji?M~Bj?H!{wiJwr`@ zGczYXdqv{Qdq^ScNfJ^A65L+JcZu-j@?A%QKCWAo@@80a?aR5xL>nc7!_vHA zKBul_NO(`jgw|<~avzfMON>&lPWXnBoBF)XDxWTSPrFUYoO%>A+M!zB=8Tbam?cCU zkTCUNN8IFI)iK{8ZkK$cSv5&egkdgkTmn`r1skat7@X~9Rg2;mooL-o`>p3{*eXgw zD!>(P?IUn?F3%zJJ@eVgUy2945f`?2#rKRuOZX8C&Ml4 zL6`jNr1|6CR8|yL41~j>a~sPOT}W_SMkz+7iSG;zwi+{my1^zpo~LoK?}}|MI*31S zR-=s84Rb|1KTo{ODD_;11jT*NYM+cQg0=MVcce95q~Fe&rbg$Q17D@#jk08l&-YJ~ zIG-~eNpzMe`t}BPH2#ytE+Z-tGcDoG(!Cj%wSLoD8Bnn-cE&_fJ3dU@e$iuIHO`Z5 zJ>0@zN!^R!n|~3UkATdN1Ae1D+=A!QWyEA3qNPu;e?N!cohS6YGiPn#U?p>(x==<` zdVSkCx4;NN!`Cp6!ki9#k?ax+%hL+cYo$kADXDiZ6zp)TY8{kkV6bV?hn?UBnBB7` z4&H~A5Th3~95-+`8ls#It}G(* z${u9focH491+AG+3W(NX6$(UdPJH_)H?`*%b_7G&)6+iWml*A8Nj^$STy2od>Y%LH zCzOmzDE9NLeswBx{){M>v{jNx%RrPPrlSvx)a=*S2vftq`b_jH4WX10VroI87(y^f zbzG+4@hSdzLEY+lw4(GeoFQLX+HhkgsWse%5|iY3N9xBz3gYG#rEDkU^*w43hkixA zl)Duo^e0IuNN`(b2U4~#a)y1(Y~mFgaAUci+uBAUVHY$4tSZ77+VOdcOV@Q3U)3QY z@-N2i&aG232+FU!87i&2m2d_E(IW2Y!UiwF7n?IFPCUQc_uXMa0o>dr4!wl29G;Cx zsyzK<1LdkhN#$xi^3CA{x}Y4nn4`UHdJliDJn28HKO|MC6=Oius-a35_tcH~RK6g5 z%q-bSNa-*7c2M%;Nj=JM`PzQI<%?OD)8J{Zr4LTHle)fAs3Kr_is8KvXV>ex#FRSt z8IOoFQ&rzwlyH8p(yj{f}l)LLtk1p#AUzOw5O5mcI z`zxJSXNrf0UjW8rT_~r_)u6)zS$X>C`DEx@c|^4pcc+jB09E27V?8Hzi04<4(HCayfyKYOboZLfVI3HPa7GjSoT z(-@l?nZYDoZPSG>bji9e8@OK2L6}eUDkFlUQM4J zd8bKuUDw$Bm*s}@ko$^y4J6Rxy=DMQ*P*~r;~(`&`&WH-Qk8vd-jvX#8xj?~yi+|d zv|9XC9#i;vD4*YbrH$$%p*hgv_WG%TpbppbO`$`3eNazBu=(w~r{A6R=wC^Ye_@bD zHG-PCA*2>>%cxfwbagjAJHT58J@K}NZa@=yBN|o+eN}hr>i2Izj!nl(#O>#I3!3)I zW4Q^9<&-n@9YW}ODwjag;a2h+T}q~3 z5=J-~*&Ai!yYI2#l{P4@Ej;csT`r^-?|Kg@ z?)hLnSZ#Hbz$X4lFF}Y}P7Z%!zsL-+pNqpvb{nW;hVsAJ9MT^r~5tuuHypcm)^;C0|^dP=Sxz z;frmgbylR+7zBOzL)&R!_kzvNdsP;}EhC%9Lx;8RmX{s~$R{R_h-!P4v8C{ZW;?%l zp`KTSh9A_h_2_vgS2F_zdXnVyX@!q8CM$N+Pg=W}_fiP+=;kRSdC2NGdlUL_uX}QI zx;;#2y>cWXV8BycG8ew}B&nPi@jfo-khwBtlM=IfIDoMS?;MR|D`2=}4E*dbKaVx|(o1gItlTi!5Rp@ibj_#lMZQ#Lfg$Q-&zj4I3r`602&bjiuCE`48xE^^1Oz3=P2zh?(SkL@ zn{GvEE?+ikeW+Hdyt!<;D2sKnj-FokDC6Gy>{dcBWb0e)_$hQax@>;r#F}n%z@c2_ z;$?4MRkQNGx4N?2v4WIcsk~o8hy4qV{%IUw-@i>{Pd{T78VvQJDTBf_36HZn4 z*4!tx`(tvkR(;oRTYY)$)E$T-qQ+-goqQ zw;dF%WwW|ovQfQZxr`vXBk=^^;DJJ-CD$M=?EjvtdbhM<3Ae#GAF=S}v+T;retOMV zY}vJ1^tla(DA2S@RP|p@`u3@ZRP$Vy^dW3zOTt|00hm zIo5KvH;=+(dJoEBV+Yh${hmY~2&QQvIp%>fAKyMXKAyc7tO|}Y0%=;%`&K z^74F-W3ZGpZ3jDDzHB!Q34W0W3&`*7~HtT3P-PD71 zx^bgeU6?<3-N{PUxUOCrVt$GiHkzg)k=*kct^nFOqA_^dzLi#j5PEdAjtoCC-ab3 zQfQv#_X_{xC&079!DlXg{118lJ$w9zJpbXIV>9vJr0hS!^&j2y?{zPD6~}*6^S>7w zBEkOulV|hXXfVqJd-qBj_^GK*JNVRpcw0AR++aZKvL56ghw(h^m6UB-(1U;4VYltm z%Suf_)q%#mr?ra>^YWH@S82lJv|L^HM>1UGT2hM@9yl1VHeXy0?X8Ryak}aDfXfTR zu9e)k2<yuaUEb|r+y0T~JKxRzfye`NXiHs`uA^)fh^_yRYaw;#G^t1E zH`kZ{qyfJ|(kJQMYQ>E7%+xfH9 zN?(lc_~F&LPR(waq@i$%g`|JbF!vT?kKU;kxqn=`t+&QSjk|Dh1k?pt$2>W;; zSqo87=e(tcpW5x_s~p-XKRmPrEzCQZEps2Iezq9#5ZFJC@z4((txr9T$^dXY|Id-z zO_0c*s&;xcf?f=RtZ1J7?3v5m+!AnmA~5gjN81BNyb(m*Y2SyeD~tJtq$LeaS19pG*r%NL7$+7uDV`5 zknkpQ(=}zk(*Gg9n$WhkT#=851v*Xg(`3$BxykQpbQUny{8~?b?_J6M_lG@HX5LP` zB35uq=eXH1!cxl`irY;pe1V0uOg7JpQy`wG0RbzomAEQsMQX3; z-`8h?n5++bpLf1}S*fLb_RP?P#8S#ME~3o-Gs3>q)mw~K&WBh0NJ4aF%v4uW-=J2z ztXW!bcw%7ZAZ=&+V*1YZau<~@%&kkL8^bSr9TC`K`OUakqjIuOlsR>(#)CP(Lp^+FvN;ZY(fk z6F)95R9Gfy9l0aD<4LOT6rZXtp&RR6Md703a<6N7iBQ&Dr>W_U>@ECeDp?WdHpsr{Tdpm}`N??UjqBtdw^7JEmH39`S&xDE4B-vlTVpYf zbCGMXmVQqJDp?#a(Or(oygaug;>LS%WrWI_LdFWIX4_QTwV~;mD|x|IB%Ja#h9CLQ z74ib+;dIQ3XZa`d@RF2Eq4^BGW~H4t8OB#rMeUb+dPnV|Pocx)j`sDP`Rr>zqVI68 zT|zHG_?n>MXryr6|I^;JI3<;Z@iHsR#@e)XOML9+CYj1u_D~Z^-P+R1GDX8jYKg9; zsVNAU!#b&vTI~k-)*kjUEY}B$B9)?+f|}1n!LU_KKn+akfqSZ{ZZrJ{+nxDl?wq-E zzjN;QeZTK@?wluLm+Yj8u7@zvExIrV5a}Ad*ty}+)Jzb1-S3!w=ff;C<*A6d6EmW) zcNC%unHJYtWcFv0t0xiYI9>iGLknX`Y*TahMF~I7^NttX(FTi68>m__s7(&2dm@A+ zQTNVhY7#J#AbU@U*=t!Weg3eVCUJP_M2g2`uS6g--e<*|0z%{kQ;vn!%7hpQz7o3gxI#gB1f_qL9k4M~Ti`8N6{AxlumyeBWLf3F$ zetCwVMfWPy?-=L(lrAZJf0QsbUkZ`4w3Iz_^jn&r#YbiU4H>oz&qa5PJ?5}c!5=LK2nJrGz~cjYNYY|It&2&MQnb*gU)aWTE-omOBtM`&K%NZ`K4J zIH9$hR%t9+gHT z{ndBzh5FVPzy|TQWr{3E{u;6{Bo}L!i9#UcANztIeUO1JK)zPju&>y|-m~8w_*(Yt zC(?;P6JDy2ZpD3e!!8=x$+T)58Vf%+&MM&Ot$kyD>_atrvOfYpZZyY!UQp zfeuH_TB&o$31b9*x( z)UBBldra*wdOF)(quUWZ>Et`R6WcH9C;PKUZPCvLs*yd$!@&y<#Avqjs;tgAK_e-= zH$b%IE!0y+kY%jsOGT~ck(szaomx^GGhMn4S!U~k#2f9FKqY$Iy>R=gdWV!N8;^u6ZE5uI_9|=fCcmTI81A3p zH*zr*!R!pP6wqf+=qL?x;YGV8OzwNDWE3=+LI8AsYfQo2z$nq^>H}(7 zg+$fE-LvpxkWj2_Z}F$gZLmYl;#@K{{awN55Pu$-0S8D(K@ZwO!c)|c?h1IKjjo4B z=X#^?y>rxqZB;ah6a;g-(5CSl&ih+&TT{xcbCT;V5`9%w(`B-bQnrJvNR1AQvkOtz z!7MGqA_a%9%Gv~1Vtr8FN_cD@wj&9?3yS-oriVxhy!d4*pV9f#4LE2`OPMXB++6-? v@wBY*w}2!Z7y literal 0 HcmV?d00001 diff --git a/resources/summary_table.png b/resources/summary_table.png new file mode 100644 index 0000000000000000000000000000000000000000..cde1143d4161ba0c16e5a15d946a742da3a579d4 GIT binary patch literal 163376 zcmeFZcQl;uw>PYXAR-7tf(b$N=)oun(My!*El~!eM6aVnln^C)9f=xkh~A~^hQW+3 ziEc2Wckk_c&U4OL>s^Q6-_P^2mNDjT*LCfE?fu!Gz4yF%s;NXl#z=;Thex5Jte}I3 zN0N_+N2qv}82H3^u$|X&v&=TzV5GB=`uySE%vtHpMzA0W-hHCq3W&7CkPZ9q z2=~{y>Ud8jA}xZR6~2t3yj#Zmm`tI;H!2a*0F9!77)mnHP%VUQ_~UI@iN2e^?}X z?tC(sAYn4W($8m7dIH5+l(9w)pEk#(0 zoz*X;dS5#lVw6S4{E&W@eJlFj^Qw$Qg|;eb+sLyj0U0&AoOJ5n0uyZh2r>9WMSa55 z#Wl7qa#kC`uj*PxfzSOSdEu$+oLkY=Uv1ol-}Q)ziz|4^6t4!y8xc=`CLy}ZB6$_R z?laXWp8pLpISv=kg<;|r{i~SB{VuL_501@OJ{~E-RuVbRP^WKrmMhZz$5Xg<&356) z@SH8ucgLF3ovmf?Ep`XIf!C8%o?o+&zaHRi3gU?@yu6oN#=zpYLQWVd$9$jA^L@-D zCyiyu@FJdRFo}*U-c@2M5FIb!op=JF;HzZ>*v}mClw@D7SCS-!kUgb{4W9jV&yJw{ z7i$B7b1?Hu5-^_5gKOrmv^Vh8{k5kIl?QCoN>~ZY?a=>Vb)q`RsZ2eK_z}0QK!)tk#LS@&WUlc28dxO(og6`l8 zgeCq?ekqnk;u5O%n|uG(+ys2>Pj z(%u%ob|vqPV8=r%!?auKLbkLVEV{3Xzhr$e{WRau*$sjK z{x+hZn?cMo5kcWOp!+wjk@ml~BuK3cugrcKIqi8}Lo-J)pT5~MS3R#br`0u+6jUJh z^nuQXjwO%d)B6SwOCP*{P^kQ@M*Et6?^9kKaEXt`-$rW9F6AzzH>F8MdgUG}_K{J! zE4r;8@2uFa++DF*sT9&5GfXeYDlz>SVA^QntM^33CPX!<+acL4*_~U5G0IlKY7k{V zVb5uQQiCipE>V95U(p}&8<81tt@U+ab^zBB)DqW9IpmBiugI*}uSkt#4zt+57wr{! zEUIsRXSkv4uLFD&oa&q9du2jnT2Z~ zvP)V`j#_pjuRrV1h^VMGS$x$`-b9wIqE(cNl3L1Z%4j-mqMlNna-JfUwrW*wHEkts zRXS9Fg$E{_I-hu*XcIDpJ|V_lTe-G=oBA3M z+ZYB}kq>DNnPnoyLXA#QqBd!T>C6w-1Vj5)`*eD{`q;g5y# z@^rqAy2;%-rXT$n=RC9Osmv=2H=HbScw#&u%?6FKe+Tw{`3?Jktulmk(>u~Cq|2qBz#-s{)~r^vf30s`%Sj7) zOEWAffECsqz!TD&K)_b?lQI;^szMh zl?bW^X+P~@_0j&EYZlGSFJ{VXIC=BhE2A&XuUNuvMU-7TV83~rk=mH~P^6c`(aaF? zP&B}Ie{h463Qje_#;lN`pvpRtH<$M(&mr$;UTa=-UV)&#AlAzHyTkWQtIXM#uG+4m zu2yORDXT_8cU)L@g}WaV)U z`g6Y{x;k|$0sCdDkLh>gW|S{7!89={5zg7nfm3Bxan<5d@%^#)C-v`4{$Y`Rer(Z| zA|}mD^*BwJ&d-p0)>*XoNl`>hJT(So=7T&U^b6z#JlO{8MiSg)H%B7x{?&1HFBC%U zd#I@2n^7UIo~-JwmO(@rdpgwqarm-=5VeKYA$(KTGEat#w~hP9cRic1V&%6@k){@n z_~Y>nA7FW>KU-qHNd!tLiBX9cI30>&B5ZYHR@^|k90l%oO zEVpebe|q8S^>+aAq?yrs$eVsOupM#$hq9Baa_>^_sqU((g{o%mF|1B}!l@alj%B+c zH^Wadj_TK0WIsy}cn{24!ou{QJpZxCav(chzFq2ACRD;*{8JzDOji1)=f^G1pIWt| zjG|$p7L?@I)#6?=Er0YZE0-?u_3&phGktI0cZ`!!!`5Kv*dV(n$#u;N#{ zld)A>jbXrKIzODWTdl%LZk3)?K$@7EZo5cMJFdH~*e{!n`nMrlaew%5CI-&c&NB_w z`r;z+C|qk}j%U!HNB#1>-(D$^#i=qwWe|sb+x5i7q1%)1_bf4q z8=REk59I}d=+91V9^$y>?Yo4tA+<=Soch@P*zFd>%@_Lx8}r{wk7aM3jh>Cq?JUbm zpRO{-FfawO`3WD?EoC1zf5XwYxUi5j_#fY${r27Gi_%VLKYXE z1qlZyX9fpnI~w$3n&kc3H}xDD_Ao0vpDZiM!z(+>Sp;V#L3mDc#8Y=p(aivoC4H%E zT;g$=)t(@WrNJUp$k8#@g*#GyFoZbI(TEGMa&W{KP z@;?yxuX_WRg3mvdd}{Aw<7lX0?_}fb4m?9fP(oA;{LcmdzeE51$p3Mv(SKk1Q262h zyz+k>`OhoC0_QXMA2a%o<@)DSV7+9>zyklZ_A+F>S9<`l;oY%U(9#3`5}eBhkX#<{ za{oX60`Ku@qC2t$Gx6}`@Kh8Y>G|NVPWet!%%AQ5tzWfvVq+as<$5Qb`-9p>pvK{y zUZ-Xxotph!wQ+^lH(6^09@}WVv*seRe|I%`{ur?r5acf7-k+ZC-Ve)hpIJm>{lFr^ z7|%XY3>eZs#e!=@@R)qQclT~E9>G=6#V_%eA&x}(G`yST_F+@1-1HO#nNT0>Uhrr!f4;hxNUzFFhXQW6u8ZA&6o5DB;FpcPZZXa?W>mw zyIeQ~>74Og_{*YDOxH$7PKs74j3Y!2q~V>zrsQQmzNE?keqWzu)})s){_Ea_+x0)T z!yKu#o!sH*C#%iv29?e4X|8VDOP^j(K3kt`EHKzZxM`(I-Gjv5A+=9bywm{T6QKm+ zpW`pjcEt6pd3&dZMbBsiRhSt!tZWi*qVhlG;yX}ZzLDh?$gK_KnvlUHHr?ClDy_3> z*x@7ti$KlIxvs=v?7+i+;T9et*GQGy56~|ftD$jAttxUch-{a{521(b@7Xi{6}uBB zhayA;ot@MV+mGr6jyLi+$VT7fzen4hnn(?yOML;!;tx9Ud>VMLV=%UR;&tHMgZ{V( z4O<xo+)Ye*I_iDg9^Ie~lvDls|q2G{q zrp?MWX6~R%7dCt+TMI5Pe(QQ6z`FL9&Rr_Pje}B2i3~jfYuppzF{Yh6S zh~E5VTb6F2NAGn(vrau!98cS!L+k4FR`l^Fmz>p!y`m+5!WEZoR0}ONET_V%U-1LY--GV z>o@lZ>DK!EXEA47m@eHs#n+c1w#n;FrvQa6 z{R-5n(Bxa>`f{>!Tde#2^KYRYzokz6JZUJ#p{QT8Nz2vNtNSYOkbNOYs#wVWL_Tan z9|3j6O&vwF2+fN6!ukWoYJAo9=g-Z8oAVDcRNYRkn^I9`*=(dLKf~c2+kQA!XEVsC zqD4fTEGwYO^F0gIlJrvRl5}H1Q!TW!)oeY9hY{_~lY*;rOfDX>?an$NpRb<@jQf~3 z)DE?5>dDS7+xgDM{XOl&qa_1K8@~%*pn*QZoF{^kWmj6*q|Q;N+E26xH*Tv@@bbfG z(c2){IzjsWq#9x^$3sWV*X8%w^bVU+Tz8UzZRe8U?30}0Y}HgrHGO`Vg?ZX>RIkrk z(9W8hf9Xk<;EsgE+OY0g*~baYbQ))(dD*|&QG$;OBIb)M`^tr=S^wO|N%c@o) zN}g8ZH+2)6O-E|>fCkG5Bgm6;E{YDC&L-DdpW@b+@!FS}~R zBye_UzGR}f9o^9x5urRKDO&JX)M==4o3~&^xLCS)xD=Kas^?Oc zmyw-4F!+UqAI^zwAG3S4az>x#mD14^B!5)5IcycDSdN$mw#*x20XUiO=A59ebNgM| zp42Tcuy7s|vDwyLsCl^4Lqe1vrJsPgN|5&q;^?u*J@1hmiF5@~L<#To_Md5AJWv~F>P(Qav1zQS)@48ft*g-J;F6zx$ zEvcd2mn+3Zom@|%8W8kMT6yv;OHg!S+tgN)9sct6w9*JSefLj|%sj;J)v-sq?}q~0 zrGx5B1GH_B4wBi8vAnUKs;$RcbmP=cst@)>Z8r-8E;q|9dx+a{(XU%55%{Z zepCcduq4L`!l3eL5xJR_qfX0lxA%*m*h0m9RT&z}+s7-CK2LKZ1yL$wL_smqdvkkO8 z?%_&CEV?IffuNxE85UvrA7u0MWWofkUgaw~zvdEc`o=4)e@o%IRzxinoo1uiaTy>- zdyL;F;(RUHH9dPDBk5wt_1QZ^=t7)WPt*vs{OBqX0m7--23=~Rwt`03w^9Z%f$fZ1 zWW3v!nio=|=%v1q!J9@THZT@Cf4?%eVI480CML`*GV1+YG%N3+Qd&6@6B#QLI2n)b zm)Vk&d{4-go3m-)-d@W(Rey%|UX9J>z#fHD1c80-wB;dnb4o478=>{4rllbeT2WuC zpFQyTn-|B@$MshdnB(=$v)2uZPBipTgSiGG9|Zu1n^4N{0%~G*26ORT$={mq;i+hO zs4cQV57$q(bjDt<|0(jLhIm`_Wg3qGBHq@+Z1H-%$2pv*OJE7y*mR$rTj4MWgP3%D zBFYzyJo@>TOXpATA1WvC9!ifvMC9T;2~S!^TqK=V2Iql4Us2WybGa} zp@uVonUB6-wVy$FZj3rX4ir*ocEA2oyo#Qj)u*qWVCOuZA^HM zUd)65sv~p{RQ_GkZ|eh9p3T>MdYF=9;g0K)ah-Ub3+IWycdD+I^pE=VGU|AAad*4X zQM%~i2sS+MWKCS6-NCHl1y6fNtC_Xs%n=N0ie6$I+h6mBdlK*9*r%Gjy!hhi;?coP z#OM=L%a!Q-E$LHOmh=gGV;Ov}_4E@?3p(!9j^%}mtCc(}r`CRgk-*3_uv2^#$dJfaTyurR}&m^y&r;B9Qt!09M@J2G-%l~3!vDAEB> zgIU;?PjD9~nU~-TNK`cF9H!@JfU9v_=<4wZxPh3_KGVN%+;eluO6y5B>o|f1r;i~; zS){P_qU$H+y-ZAy2$x`9g0(%Kx6#saQYh^EJt&%96aYc2lJeNpp940{T>#z+Oq!w@F{;@)Lx)%})JL zlnXM4ugOyl@O(@?oiAG3?H-NVVTqu(zx62*XvO*KdzlOE?1GtUPvacusO^?{K8&)lREdMy-PYPv7{sxe8{`%Oq~1w9TMR)BW^>a>8cF z+oX)^6FqN0$6g+u6Q?xb1I1y9q<11J@YhFVA*V6fO`Xjw0du`%V|#~|kCb9$1%JYb zYIc=mZ$yeYfaf0Hxx^kW5()8v){>@yuo(J%y9(KM!z^Mi)gs89uE^d($$90fW_=Ri z1j|iCQXx6MU)Sg!Z?2dPs*5>IQztBfM;o2whj+sBuH^fB;6 zVlmCxjJ-!Ed#!HMKWfk8mXT63Uh=-0u|b{T;O$;6AhId9>m%x+WRm0sV9tGu^mj-L zm(lx@3H}{%vfXX6dnDNJO^NW}8qFc;`Gdco%(?U7h^guMHuJl_{h?mvCY}35Ebf5m zjH$5afns1x?kr4#7P9Ad}-7mi* z8#u`y>sy+aU#j2uAorA%KEAE0k)gO*;*ZSQ+o_qL+2-rD=xDn5^{H9rLHp(@9aaLA zKj88g_5WVKi77MJplkVCGBGc|nR_LF5s2Ya(ZvjIu@he)7G+7rLy)dlPjH>>XQxajvB2 z_UOpi#ik1Mi#t96e|ZDGBH5sp0^?v2FyfA$4%9jw-GlhhVrCKEQ$Pv9(rs-;ImuVA zgSXE(2X~5aEsKFhtqVQM`5p`ToS?P(aBtqJre+ftU#n>XWJz@I(w189eGjRFm=b=S z{7O-nU;iD6)s@RO(M#G+YJ7VLl9ENn5eN z%5gq+m6L(k7`T%Xj}Pu!+5s#4RZqQZfN*%iRCT%5c;*W$2Bj=ZSRGYiuNoC-mHg zPfJYo#xe+6RPuP{_CL+K8RbEhVfgO7fV(VM5-rHrYhWUKpB_KnFk zfo&GBY;KQgo8Vt|RTrNn#m%IPnclaEFx?fwo67aoEjBA{5@l=}He#1|a5~;? zPNGnTDji+(d0MER!+?S;ei;Xdr*m@doY$DwFp-RYb@U@T`>rvvaoVFYp6NoIf=~4I zoX%?7-YlJO<}>-mf6)Goo+I`hG*k4zLNUvK@KxIQB&IZ_8;C0DP*t%CBUHua_WPBO z+>|(R?|S;T#=TbWsip9H+lH;?+{d?X7kyg|D4aM%D{)-3GyuYV z^hxV&e2ec^cor6HxHWHpnj7~z7j*BPyX8y=tI^5mGJ?C=Zg;>k0cn$NR{ji9za@OF z=V)RR&eo=35KacMhO;xFQTdB`w9iUF2)!)E3CiPF75#pLg<|L?PQdM2RIH;){S6k^NcO6AI*nU*y<^*!c0&)Iq*pI0*P9c5tq$#2Hjux8HsiS+L>cY*;BponScmL_K=p;GjxSHowkhcN-4@^ zpfWN*Y8G%I(ZqOp1r_1}Yz87u^CmIDHHIk;E2+6K)29HbWVG?KG*H9Prq8%GHMtby zhju4dj$@EjVP@LNUzEsW_I)ZjH91&4$sZ}UDN{{|8b?0=#*+FM*=Ff2VV%jT#cWi4 zEZ_K15jH4V^leDOMzv=#r{y-hPw)~51V7(FNQ?ctNmp-gWHj_qs+4nbM7U2J_m1QN zK+dDLzwzjo|1DwVt7tTa-#*h*Xha;8L1q05PzC)7$!aru+}9Vp*QQO(bDBXut99-^HqHYZdl#$oiYI$?@io0Tp5n<5bX&QlY2TjdzFlJL1kCew*s;)8%6-1V$H z0<;9EK&(8J(`9u)v#>91&5yFxf09koACL56&lh5N1=u|3T3=+jj@s$LBFoIF>GXRz zSYm}rqS{Ar#?R}wMG#Yxb1O-wN%ZumYSVfF87X~4W0R}G7;4@^8M`a4G$$oYyxVHw zH#zYmowiEWzdzGWE3WOXuQLgth<jJLksaHLr5frH^0-CO^;(b{n z>i`+#B#d<9OZz*18`ZieHzQemBOZPIuzU?MG|2)u-yNA0SdC$Ks&q%~TlGsU!Q{Cm zK$Gt>Jk%>x&;0GR7T@yf3Rx%2442fsXh5CKxL=mQ{umu76R=-dW`2}xlz1qd4)$zX zJ#r7~Jort*IC*-U=&ew6_qx`&ei%7aks?WUprWV-I>mbL>FKv!rp-w;-TAPtir3;; zzW_i|Cj{F-5Y+l|UA@?R?N2;pXQfO$Ux@{0>E^zr9V(+#QFG3#xlUJ!aSjFI=mv4m0dJ?6K@e7ti=V*E<`KV01 zJ-BpxCt^xg4Rm9p9LIYPlx+-EZoZO_K^z$~S`48NMp<`p%We_d>w$4|$Q&g1koT_% zjZB->*NfKc$6XJobCXa2KXBdexpu&|>%40m#hlxewn)W{Ovc+U)%O>)sawT)58IkIZ{^5G6JWp3_rTqD1+|D-^I6Y9WTQy z8beq8%C&BKCY?(|l8+qjQyPc8g%-S1z=wUefwf?G`E zB4l@yaIkADGd)cP_3r0({BMhqPPs#J z1-1`Z*0%(_@hcAjBSn@yo25=aJKWxIjJ+(z`6r%R>&kTDOOYWAS1>!1aHx>xHk~MY z1KyfbhTbbxN{(M0fwmcy0L4OUVST@f4&R4%{rM`_oZ4i!u1-SK05Fl(dhyzvlV<5#^m++4@cvfuE9Nr>gpLLVV^nSjkB1!(vpEc(O4VeQEBW2mIlx}mK z{8$6NL;&Nzrgy!VWDb_o3%N$AJRxn|{ya}TQ^I6Aty%7LvVEpM7Haar)TnX3aMuk; z`{-24g*5bg>QA3+F*EFZzhzXp!E{cw_2Z%oZ+Zafk@;6!$ZCS9k>2|TQ(D%j zwtyPz^nkN(USnH56`Mym{{o*+!uhKb5VbKOh}yxXO~KPIuimuWb1L}w8L)aiU+ZU* z`%LP(QpzWKr9R1Pim}bArQGL-r1G=#Wr)+7nMm*yoseAbJa~qUYTE-s@dudN-peT1 z{3oCxLR4Tj+7kxk0f40C!Lz(;Kw|y=K>iQUD!>n5s0AvNT8Bs~oKn;Yux$OMemzPpa8{e)Ka=DT-EWE*me=&Eu@umUZSra}l1 ztElFLQ2I@eXI2-ftYwTy_i$azddPt?fHEGt$4P823CNCH7U}JWTVj^be9w3R+;(F5 z!Gy~963F+RS58jSmYbV3Ui6CB+Nn_;ZeKf=S(=-Kk~u*ug+H}%i@tlhHOOarATolu zXRUsE>9PzH9>FJ|2r2f-8_BEI&qM5V-6Lj<0kYkCjh;mWu@?3~A<*2V*Rpz8hEu>Pu5@JYz8moq+ zk{s?P`QzHyXq(hoE>3o8-oPh7adw8ziQU+sP7|}L+h%^C0A$da%MyUX6E3}v@p_W= zxx;1V&m_%f^i@+H3LExczi>Qw1aEEt3vuk4peDFoK6vfWG8h)q3ZD$z}nDtMfEC*n>>wX454A2pB=uRRW@Xt=C1J(ihWm z=SR8j1H0%73z^yDi$Mx-RFmjj++TI)m@iff;AqHAKqIqXQHJqfUU|s*3Ro|i-&}5# zmuz@YupAlLJus-%Z)fFZi^jjO5TF|sa#DDgCT#drCfWEA(pHs+dGN8KkK4;A3 zT7GpDn3NM~-M=s=Qd(f|Jk?~pgv&V>c_lEZ3F^zp(R1TM%?<4H4_P7?dy;>w+rJg{ z--`NgMg6x$y#(s~+oJy4qW;_U|KH~Nt$~WQ&Ub88up_UrI;YGXTv1M7!iyhKDnK=K ze!#(|PLqc{kkpBovH+k={8xhWdidkb9)T*C85u5}{K%}p!{r1i@AaGOf@T*380A8_ zLZbY=)iE~ti0jEft*=So@n0nguhq0g>4n~OU2eUPps6O$M9pl;H_VAZak(gw*ZL%v zOY2SwuX&4M3a=4s5O9G)2N^B*J$AK}B*hp;m1sJ?Ih2|}GEj7{G|WbLA=v!&ou+dj zc>9BV#M~QBczg%5zxwGRwxU6_Cy9#<$jzl>Iyb%19&*LH5)izh8Ey5i2XA(=Z60qS zqx;=%Xi3f|>E`?It)nU|WV@1i48TP?^cOx46io^=G58JUK5<*j_U=ZQHKR20b$yZP z!bo4;Be;Q{_F3)MNoElzc5^jqUGuS{)VRD`M2=r?00O#Kfk&{ zZjD8kQ>FH&3giFLk^b=$fwukJNv{c~zd4-@q_hLe!;8oqmcc>xftjM-Xy7wd*zu2)Op1eJld5M+K67rIPf5Eiv7Dc%prqH4;kMY%Cz<#-hEeo| zbeJD05Kv`XKFzpDch%05sDOfW7Z<@-B%bZj8kpYAQ;bP)7%6F#iG>~QcFo4g@&n@Y z=EL;fk#Or=pK310`sn8Zm;%MSF=Ak$Qf^$Ei(n`p+O+T*v(YKiWGXgqZ32imWiiK5 z&`iKqOmBv$n#{o*&5Vqx-*Um`a#7A9`ojZXV0989YCZpZ6mgt-o^}hIjS*@cMXd>0)FLBnPIy-h@Ti^*xQnBe1_=hb~L!HLmI0QfH!&_F6R@ z(=Ck#!gHM3KzK^+YR~w;YJ138<$15h${&(L6=(tN5#;HT4hV8eT8tN={)&k6P6 zL&mog)sVR3-3b?+Tm@3Vt|$+?S2}Iw|2+C_D9RsO0Crll?4H-R0m|JX0XFFtUyUQVXm<1(hU8H9EguA9p9db zuiX=?Kh_@9KGGqK1nUB6n&cE`w~Od4Yr*q&4ZwcsrwiFc@pJ*I%5{aD&V$drCriS; z&|_)fOL=F;rvFIEGlb3WbjHdIuy575sS|lv7{Uud)jC4aWn63HwTWU*taPmXKL(qF+x(hps|Wl{i{-`KVy;0|qGpI0U5`xtd=Zh{G0lovv7Cqt8F5QPe@HRm9oAcn#M)+;#N_aW+Ls!;A*IbWf z)Q{3pQQ7gPO)0O{`09Sio*h$2;i;GCEt#OxfWe)GZ!=QO2x6HXZ?ByZgJ_w|uVLg9 zPueDW4`DGZveRTG5#9)3AG)p8VvNTQy&pr~54>BxE$&<+6FWd~a`ddu(FohxJ{v0) zpp=Ov5mHO#r!ZGcRWxjLv)LG(9^8{U#=VWrz{L5qBoKG*)R$skxlFf=8S8&JsOJN^ zOwc53wA^~}fKO66+Fg4h>kPUe^#4qH-|`iaiW%Z zpFcUIca)rZh+Y$N{JMSr>HA=4(Bz>#0Y6%T;}>Hs40460rRH!2ZR-PPNWS$T!~p9d zTs2thlBX2sCB`zDBMga!!dk=A86^ynP$iA8M^-GQp1k%y-!g;<*>wBVS=BF2ng^Zi z;0s4dIBXer_`=<1-lo*|10P`sZSR#qq>t{@in1sZ0iL(xBgRwz0sf!h^e9P7G|cup(Q~Ue9s9TL75hZpDRkE?W`z7qArK3HiH!o zqB33D7#@64M~baNsM@3fA4z}&Z>fI{cuTcL9Rf({S&3fPPMdo0*h;lgs+6Tn)ys04 z!1kS$5%K__N&vBU_&b8-=dhwrrk|stRdb#1>gcD>9tg92AE`S~<{YSoAcGIm zzSo)wU66GIVab*vC-d1U<{GaEi{R=eoXOMd{S&>MAm427S;`R#o5S9uxD@inO2ik3 zcv1L0fesltD+-(7SC!oaDrBcy_oi=SV3Iha&`w*u(k;O!t4id`nN&Ua!iSOwnIs+q z{)P9LLXAuU+hKRpH7T6-OeignzQUw|kD_8*&Tq`F)ahKJRse45?Z%$eRQ+ll!w_vRW6F7B)KrVged%Fm-Z8}LdpkO9Ja50KC8Df{{>Ss#f#}~lk_TY zdq`*gjJd4@)m0xpia@mw(w<$E!YI6uJfL=tM5RZEnKcZ-1N58L4`>Yuh z>##e3hSW7~4`}C^JMGWM-4bMt2a3mRqozcriiSR`U%4|d2siH%0F^)LNd$6A8nA|= z_2yQ7hF|J^6IUOOU`0mW&7X5 zO*uEBgr@Ks20mVTi-1pW#P>PN^RV|UJV&1C)H|DXC341{k-8>jysxiCJKQPq(H9+p zMkC1Al0D338{HTEXpa`K;}sm1bH*L&V|)O69Cd#Px-2@CkX~iN4BOVO&$Wb`BYVcx z$DGQ0ZkMf&GKf28ElGZUqioycGPu*;CxW5sTlVV)+@YUBn{66b%@fRLP3YnNY}|ZR z55K##8HNM#tTd&}sQPCucv>A+F$3E(!wd;+o_MSUYZWq-uZ-aUn`DISTikw4zbrXu zYwh`Xf=SdNX?tw~BlTK_{r`LyKy4qeL$ZTT4>tS6XB4)%T5&B1ZI{9X%DSULC6+g* z{X+@85jS(8Y7<>ZRqT@Frma5F;7&`>;WDRSwbf`*le2~2GCS1C9`pFZ&7t;BxfJyx z+#iuv9A~9C_}LNIfj`tg@d0=tRnl`s`OB*-Rx&e2t^g88eUK*s3WVB-<@+QtI)I_% zX|OM>O)l0g>IOPInRSr9m3D)y_Tx3h!ad^_jcx_QAGO(7XVRZ5%9${q19L#gk?DaL zqt(VUV9nHU)2(dXC$HqX$dp}X+RS>#TVE7P#V*C!rfK)MZS{#qGjsvn3iNcs1jfC} zx=^g&tFGbT_r%2C5-sG$jSNCp80DM?-iOc*pZ$pzus+zFe}T5~(kCC=+w$H29U)KP zeU~$XkOE;}x!bbUpGZh@Ju=Ye19B!nnA%*_#}WNEIYSgm9Ouc&HiL{O@9_DxHxaYz zs`xfFvN6NR#IU!iD;JkzAS8U(5Eo3`vy*Mu>Q~EaQr9c~5)tIGeX!gbUevn}vu9}` zK=q$4&rqMlEK5~{n8VIe_|3R&54|C^@vsw<5@s(UY;m+v#e_@}ptXZL-X-n!!p1U& zTHZ}wYupYH&Xe0sfhT@P4;n_?fqq-)2~(YH;NVO_;OktcGzOtpp4n1|AASOHOt#U5 zdqbaAx&Jfvtkyv>yb#K0V8+$}s9MPB$&m^6@6YP>8aM3F0J-Y_9MZ6@iwQj)q`XNY_BeEbY)<2WJ zO8f6_uU2T1mkp&vaGI6weIa4l1`7n89^+@jrN9RoV@@X6njWAX^SZ2PrFB<=TwA~a zxMB=2k&*5q--vnwFiWCe9%K9i00|RHO4m$(MUq_}cQ$M(3bh9#N%*=8%I8Yv@XsmP$@VN~=~ z0O(X)Y-}oQwAegshS+j#Nby<9bZ=~DKY0FXu~9Ot0mHZkbd8YS0qo6|=|xSPAnet9 zo)q?(U*0P2TuT_mM;O-IdbqyV%8>!Q=$P}g=MjL#{mgYk#Tb3IRT(V@-^Ur`^j@8e z*X`5$3iqsyu^%c78}??ltE}_gT4-A=Qk6UW^(7Qv*m$b8qN%VF(Y%`K(f3k7SNO5y zpJAZUOZWwPCy$`{gMqp4k1anxgh>W~4i_aD?`@fg`yTKAg)e4k&)-e$>D&{Z`|5fp zjVo6gr-X?>e#{T)a_^Vus1~r@4gP4BE@Gdscp%}vaBX$6Q8+h7@0v2UY1x(|BC>6q zLH2k&FUO{UqwWSpok-Qt|$^K^rkitwsga5D*dVwxpz!iLKCN$iSKw57-pnUX^IqEz*R0 z_A!><^_;ryQIi)-z1xJ*BUL`SGHt~mSo%n|!e2z!QfWW|aIeKFZ2hjbY4&hJMn{k4 z!gQI@ohd=xhGsNItXFTke}Qcm@G;nf*i5bz!ieikWbnjyILJn>>*|tSpt!gc62}(( zke^2PS^KZnQ|DY*RxZ6DHs&bMI+v~Tn=UtTehv^ZY&a|4$t-S^&dE;imdS0)euoaO zF~W^)`Pmx({fsU*SyNMR+!6d@!frNPTr11c6R z(T^!Bm|e?|sxKQ zO1j85qiH(}&BPytUemChD>;u=dYhUzr~PqnNWp~%ha97KIc{-lWQdU3e|!6$jz*8X zYbX>z^=j~d&92CR`nLdFH0nM4PW6PNlgn1m{lN^8;18nPp&h%iq*YPrrxP;UQyHGl zHUsY;Aw1RNb$e^RQ`xvL_9p|9QksK?r*oLqXtZ0SU(yQejMhexrbRJOG3lU7p7ErM zyO=A(VU~(2QAYA(GTW0G#f>)Sq1C+Yi9MGA!nCrtY?06QWE?20?S(6R46ZQ+fDOV1=oWo>qVdFk5Ad0kT*fsYp_$IJ3s5XfUXFkkpt-xpnf~su01~hFzFm%H)(_m${Yb0*Aj*M zL@eLC-KSq^#FMe?D^C#9##!`Xpe&V_v3JB8otpwse#^>RktzMsd!~c_(d@vmlmY*_ zU@Qvs>j0R6M)>PsZQPqq(>lj=+We}CO>*TKKWw>>@1}Kg$>MHqG(UCq0s`vmBj*Q1 zt~#|2&oDr@1*UFV1M~Hvu<+)|+iK|D5iN=Nn}S2}5p!cC0Ody`Y|{oy8!n#_9){=_ zs3xZ&D!xoU4kPnLkIdAZ)~zKu;M-RtS_95b_PqAM^*}_G`pK%JDTR{_R8HUY_vh^& zyzamJ`s~sfH^hV$A{oZ`Z0~v2tX!zZbTrCuf;}42iCJY&_pPAY+fuj|HXsDOT0!kv z_C=5)!G4q6S}`l_=e26)$|Yr4rml}{j8h4*r$bb~KINM=d%cNm@lq?Mj^AZ$Tt+X} z%-KI}13bYO-4pmMKvgX=c#w-(dL6$?|Bb&KCv&LmVclSYqS}`%k)`UwwNVeY)je;| zS+=hL)*H?ev1DglF}S(hSUAym*gP;3VRE=uKchgn_^A*Gccas*W@--sPN~4~(~B=v zdgRK0Hji!1Mp+j1Y1#tCtYTzqIqnNrAvrIm+LsG6%P5&Vi19Bfa>=?yz{L>ng<9#f zq9BUBCHU3b1L6L?ES43#nB|_;cQ3%AhzXe^+b(M60}u{o6Bw$Xp+XIJK5`^D@VG&= z#H9W=7oZLWYN@fyv%wpu9e&4X6PK{J)O+NUKP4ZF1I<;$hMvZ5^}`4=DM2hpGwqM; zRKQ$KX1iy-$JJ^^;8OV8_FouP+s2q^f8FvRCd#H8=L-wc`=#HJ4nZ@gvIHFurqfQ& zG=70EhhE~9@qz$k?KTFN9k9!(XG#Z-8g!sA;uc7lZ^LFKyP02VJm?B!x_`CoyU zX>D}%cJ2)o-PVo{r)1%$1aAaGrL&pjApFW$oH{1w6acfP6X@WQKs-xMGXvAmAI>VF zN0P~&yehK0o!L_Lq6O_HFbY5HRR^g8aS#&@*VBf;s1p@4$JZTI2vewMJ=FI2NhqqU zrV~0+YG8uo;ahaSh>psSl|vDrfKVm-8ly<(j;3e!G=LhLQx0raIu)6IFQvFG^m0i$ z7-51(e$_Gq1ZDv6tzw;O07<0KpSPK986 zLIuL8z%FDpz*uhr;e2=&BE-A?XppKbQ_P91I5UNiVnYhE(FeqVu^ZcdDV{6CR1}7s ztTuB;>G0E)nu9}TpMt=X!!95Z(HbSawPO`4-2afR;kv)i6Id#c7r4=jFsd#rGyKGQ z-f>mC2&_D=cXM*4(Y+{%*9cV$22=qkex<^SI~f2jlyi2^#zMT5B!BJbAyA($iZWsn zRW3jMn}1h6ytDH8w?7hLP5(Qi3W|S4phB(;&_ELRKF+mxn-x97Kx4%1gN;H{7=5m5 zG2S@^d_j0p0&XmBVll*tEl*0yc{{+#b^M-Wk{$QO)rOLmy&&6FD>z_|2M@oE4gW zy&|8(Rsi#vXKv>k_V51sv%Jw;yC9V*?dPn9^HZRCxS2_!5R5}V=Esu4> ze6DFaXKvv`l@mKVE{T}?e$Ce}DvIeOAmHfCOsWYwI}L7xA%kos(G3+)MHRm~Na6MC z_P8h>#6}sEAp5T8kiVs3fWJ8w@I=wY2ey3~zID$DPza|o&TfjIe=tLi8~Tc6 z`grjAoGg=o+||!hzBkz-Ol*p4^QLt9H_c0cEQaRo_6!`!+m9W3fXWaz;Z}9?2Cxza zXVRoh7e_?*(m=R-atXqen4$Ohfsh?aMZ5Ro@^A9I1AFQcg(g1 zlf0IXBv)Z!doW&hnDk26t9MbF()}UEP0BlCEteFE30xBLC|wmjeIqI(23b5V?8^Wd z{`xo@v>#?Q!I3IN@qzH6G_zd2`KrS2gk0S!rm3L z{W46c#%49P3S2t2)!#6zY@UweFseyQZ!%k$O*VSh#jvQgmE9EnF=4fBS4WYWX5dR; zyPGza2*6IzB99L#Hi^_ua1qn@n*Fr^LAt?a*eHr< z+=odog9NgB|J-4*O{f6V!29rVf33%*Y41kFY2Ous4>!R`xQ=75l3PQAQtvi9RI3oj zZUCe{GZ?lBD95HeIXVP=M*BKFt`bm9rj3KD!RA9+Lo_KJB3ChWV?x?H&a}(1&hwTo zLC=xscwsK3s`xLABKKRyqhR8+W0T9qWIhXgu4bA3F&8QH{qF&GBEmXjto(Mf)BAb^ zpN^0sKia8$(a)t2$u8Lsq)Mi|JJ#mny=T=WSNZm8K#}wbB!p;W=S8a7 zZ|%rU#b*7qs{|MB_vESf@An9g`2#FRDy7V7yx0#zdgk=KyQ$ckAE^zg(NRiI<=|9)ug(IY$7^=FxjN&=8w2kie9P5p zUs)vP-h5gY7a8<7q+V?}^+dB1#VzYGQx^(UvxK2kyBEx3YlbCfd*p-UyN6aIdEbO9 zO1y0doMrZr&qIqx@1KT7jH!$>V#VidZV;{+(3Lkx!8aQk_xnWrq5j``(zlhB2PpmP zalA$W<+JHw&yUGT$$f76w1d_nZo*-0h4y$%h@ycv|s!xBE-=yq!8X{$K4iNb_NwI3~R;9bM z?BZr|9mmQO=|X>88?`I5gHfa=@jF(@D#56{ljFy#!u&;~4yid-hXBIf7fp4Y;=F#F z>(joTxLm5iR0y@3*m#J>VI6|MwU%^!&7*jZKh>nxwNg=kCzgkmx(GQ4%f{$VMTWXH z0b+oEk#3d8i~*N;)@=X$)!~m>!?9;Y%akRNq}o>AD0o)!d@!#zQZvM6jX9MIjziPo zr&MI;+MK58RYWh_Rqnc1mZQ4Cflme^c=QB&#x?Z(gOupuriF z-TB~s*ia~w#r%E?E~or(g-iJd483PEwUzeuSyrA0Yq!2uJ7k&7fl&)C^iKiyB-(%T z=7l-ePNG@bM_Z;MFm6eE9AOK(%RS>RM-N_t*_0>QoED}ShzcXq(<8rPo2@Ok!n4{N z6~*D?R$Y0=yki$XM|sskrS-?flA?>*OPaUK5emryS3#jY%_l~(9bYVn1pV)JuXO+# zm}tOsBy8)yw9qafOxA+`xdk4KAxp{#Vkul|s@ug~1(n)3u_ z{oaew3&7La)E3l%P3~k=X8S9bJPBWc8ZjCfqxYe?A$8ZwF6>4&C%x~2p8XTh2=E6q zh^bspTV4_BB8sUhJ42XsNxLvv{gdVwsAW6$Njc!7R3KTjlDk?!`h z66TNQf8YBQ-C4l@fIgK}!ngao{I{Z}c2J^V_6V<8)H+Kc8|&o{UnXfq&AstN7D>sS zehk;XGJCxHMi(||tN9Wcujd%Fd-82J5F_)@duZ-&1X~d^-`ND*A!Fp}VY4r}fHfY$IU(=k z!i2%-XHxg%K>CdU=fisKSo2Fv6VOe0CiN;faYy%PcaGDP%#1}PGhifNO}b}tviXcV z>was1w zWG5tIEP-AZ0YQx7S!+ulpTC24g=K64b>3m$X2oGTwzbYUz-AiHPInRq>(+e)JWfE5 zByh&{)t!wq8_x|5-$hg7x~1Oa@lrmk@v|c%uu*_WmUyDk+jB3yk?K_NsIaWB)Q9)9 zZm?-@1}zK#}IXl_&ImIH(V6LFctQg}( z^xbhQe)~7^{Z~EM38}I~r>b=rsVPWEV*jSy{MY4ip<&mNuOGsMA5o&u{5wsLe*iZ4 z_-&I@GFs}?`{I34|AunxKLXtjZGV8D^IK7@+J7TrMM1-cKF-y3zz^=n+b1RT-#u+U z6CkucO2Y=~C3igMzvs?@Tg7JtAAcINZuQ2``SkoA`5)Op|M4HHO2GJUMWX?Ep$jy2 z^gY!O@LMbZU9lof{G00gueu5L9#UG2GCgSeJLcK1Z}Mm305=va4y*n5q8!9~Ac|4< z<~hLqcXyB1u>iPNWk0VV&i(H#Q~&kqHi8U+;#hVoy3rCvo>hOgG6$lU*z|N3vA`o~}W3-Mtz zsiRRe`oFu@KR)%J-{7c-66oBA8?p4@U;gWVzYp+%j=QLYL)z@5Ls$Rv0>AmxKc3-# zZv1yv`epGpT>FiYeACl|^%a2k@H(yZbUwF~G2q4S0R>(TpoirE7C;UFje0|ps{dqS z|2z0U0m9WQP33J2(IR<0kF58bE|HwCYp6S+)&C)#0k~W_fRAfB>%Pj5%Tb-N4jKa& zJcF>eDsVv*&R)&zH$KNRZYq+w*fpUoagH9Kr^K8yl_%ec^9N^(qUUajbCNWv&63H0v~~hg1)DCu2hSQ$R?5m4SJFIfvq%Z=VVSQi z0L041jJq#IXxQ8|Yg!VQ-I&X3_Z&3HL)&gGBhVw4TLH|+J*!9k1snQy zXKZ-MKB#wff;&ppX_%060J|Ity+`*hE20lBQEmLQYb}t(;48;WJpLq7$oCFSMq4+s z^GhE{POQ^I-hWU%)eNV0Dx(Sd}!Gigoi9#tf0!xf=C(d`fU~ zVfzkk#0Mbhm}XVd;P8@{J-h{|hqCYG%NA7>R~sTTy~RT0)_k&lSE0h5`VXK>r? zMvAI%U>-J)8Tta@5YIO;t1-5H(4Cyn4g=lk4((z%$DfQ6L62G`ti!r@db~Sl(WC9~ zEE##j>>-QYSL$p8g?bndA5aMl4_)>N$2YD1cE+!GuGyC`Nq> zEEu%@zzLsJJt4v{JJb+P1ze5kdQc;bJ^Qiu?ekO;KF)dw;cm6VVh`ZD_GU=D>;Y7D zJHR&4DHqo1L^wr6wsgUH7EDLrG-5_=*Y*Jloz&=kmIRVmQ~C<}EB_US|Jggu1^hw7 zUyI>QPqSr@P%YN`iFKO$P}rs+u*bcg9pf5&t)l3~fp0-krH*cv1Wjt>g3C&6yn%;> z2*Ham2`L;#%+5CgPbTF~i>hW@tle&Oh0#m?^H=<57*#;Kyf|*M+0${)Jw;I(#{$_I6*vtbQiIcMf#)wIh3NvJaP*RngI8ogdLFA zFF~VUmVnqtqj>3D{ff}?&2=sKvYY|U|CS~E$JZ;fqPC@4F}(7HF27EIrIP+qQrNrZ z{ap-UjK@z~)JW05vzyrOVg13en+cvw3q8Mu0xT0Dfkw08qzpHEh_`;*7(wlr5`stm z;SLFj%%AMGfqvUfk%AkP1Za49iLf`PcL<00gJpy{2e{#{t>Euoef0}eZ(Jh!!*^HU zKbfx4c=i*ze8hc!JjlU@;|tzD%P>+VVib*~!FzT^0|PVs59cACD0uXjB&gsOLTIG) z|1f*x{|&RR2#rAP59=o6(PJ~3FBpZE_nrs*!Fl|E5pH}K=;Q$p;SO0asW>7HKv^e% zN8dZ`)NgYMr1~bc&g)U`-{2zt&ew(*Q%d&0xN5sF;SJ_8KtD_ZG#8E7pTOAfKh0zR z)>zb!(aKDFc_2V#9q1QArHvYQL`UCX*V6(Uu+p|%fxIUNTK-|ez=IG{-X3sPSr<1P z>F}EMrDVQHHA{2v2@}~dubgq!<$b<4pJ`SbaS15J1C;SPmMoi96hvQpH*TBrd;;OZ zL?j@IP`POM;S11TpK?q9IC0`bW%g=eByvTti5rC6`t^yj+#1kQlW+1t-hD;*>?lEhT|27w7`74w+F|x}j*~MNTV?${pw(^z zS|FwxT2HSQjHFo=*Gw-~3JGKx?Eyn1fCHi*yl!m9x^_Ls6kLS4TZw4F&i5?2=G!as z5W=B83&~Glx$Hz@Mww-2Jnt0H?RC(FC$JV*XU@C7ye`0nN%{QAx7raI19C0}twdp$ z_eicmL<~qwV!NJgc`u)R_SYPS55pXDyDV0h-D@0+BaZa3+S!#0y$Tqw?kR40I&Gj zM87OXW|#d!5K|IJ$Qlq-EICSIhw5313>>6rs^?T5YwuP7-I)akdi3(coHf%W+VJZM zCGr}sh&P5d6{EC5tiJ27-^C6xBf9q&Sbq0_<^g`hb=DvQd=$sU&zSYSZMMNPxoXy< z`+PtBlI^V|F$ri7NDPDOH}h=!d1S?RYr>&zW|Jl0^c^Dpq8mgxCMj@syldxkkVTaUV7saFO~cE()8m#Jv6|`ky>X83<)`~; zb-jm;u-C3-u7F%2e3qlO&*(}HAD~-&UwQYMvef+qx$A4Eq3<%9>Gil)`8L=Nxq|_? z+e!%UDiZ@r%zr&jp?JoI8u~fK`)Fb%PS^G$s@yH_F>SL%mvQ~751-&S?*l4g7W=yK zU|$VD*XF{esyAK5fY*y`JFL30OaFkfJZc3r_mNe;E;|0e@}9~L^eVmV$H6>Cv`uO` z@*giuG(1Wgj!IXx&rqv^WWN~>QCz{^hf+pHr8H|Z`o_H$+(-Ewxe*tDY}|{AdFM&_ z&5#tr0BH&r_2!sU&)o*Iu=}UxS*4NDnI3@tP_cSmknYEZlj6`u%5deYX|hd^qR6)T z4|hs(uIvd-xFN`gO~1Uk#jxLT<+lf!|JbbrpkSM@EGP;o)b2XL4bIFTst%7C1*>1+ zJ<>PDed^vn`P_AAvCqdq=+}V)3W+6^bTvaoky%*<8g{4Y*LNJ>gj!V1xU#0WJ=FJd z1%Q6?u#))9?DX@+(B2YXq*Yc!=AzH1ib=@X`Jg=fa1NlUyk0-;dF|&vEx_nBp(uIz zvt7IgaOy0|7t|?oL1vc(BF#*Pb;vFtavL4%j5Pq+VbWD%txvwz^lTo6(uu`mI16jD zW2)sM!`&W+-(nnP+^&6ruM9N-Rp(dcZWhF2Vn9|a^R@%7%?l-Ux!&IC&lj+rzPFO- zitB`WfDWhI4+3&-K{@<;3vcLpfK*ZL{`i&ATb=x)B2#Osp73NGc>!{&0dv4 z3W&yf!gJ#5c5>B zrc_L7D;~;QM07GC*ToXO9nZR0ZEBect~vFKRUH}`hMW_m3(h|OoFnHczj;M=`x8$$ zn_8vq-P_C31Q;>I%WCV|7TK{qK!`D&KP#QNjQ_h3U49)kwB2$rpiPl~md>QC%}7=# z^mFZ1VlrRvd4EiKkdBME+Zj(w?RGh)5yNXfGKbQDZe&k~PHvlHCWo!4T%2gEK@Aks zIZ7ROS;C-HK1{~qT+Zm>B!RAOzlB$)n@pJ5*|#yzw1aA=hV^-|Up}=)oiRtWPFl|8 z4D>EX{?4)6TdHbsAf80J-h9@4)_l|F2`C=wOW%^SEEucm;BXa1OoKDW#;o}g70Q_H zD!)F%t;^&oRyL*u%mgW-&v&)9Sqt{$go=iy0Ur;Sf{>-YTvki5%h)CEyf3y1P0y#e z{)cQ?*WH4(@_C=LsktOT5t%iR%P(jsldD09U?>je8l|viM-a1a^A??VTBKW?gbK6N zo0zr-auSFF9+2}0`S@e}h{P-qu!=J6Mnee{@6n7IW?fI1ZGz60C4s(tN-DQ$hg8Dh z)4hB9J-jwd$ed(b9!-6h*dn_@E@Ku6#u|S2hkXqshq;?#M_)gWiF@BMSEBWn?+9ty zK(H~dWwoC~-=TE<`g9CEW|yaLVkrTJaY zjpx>N+m)%pcVbI-d_M83WvI8e+2p<+S8<=$)Y+X{pcV118>dXvPS_X({gv=Zy~G%jAMRW~l^xKjan%5LEPU2M3N zy7+sSNjmqXj>yz{!682jmygC;1l(Ohoux5-NvNB8vn1jDwgI=d*9z+rQmEhP-SYmxXw~;q5?_H zE^PXKm+ix*ZVhOKG9K1B=!9Zg-hzSiYop7mVNu}iR;;E03t2dOykDNhcgIC-GQ*(- zM(wZB6%C-rU!ym0l&B%gdLxuoldS(O1~Endn3J#djFQs9jAilgZMR}ZgL5c@_k&rW zg|0ctzE0X^%4b2CR6a~4sEQhV8WH9C`MO|vfyH6gPK@}D`@x#eC!#bbo!I9fm(byD zNqXnH_U^R~FN;TUqB}%BfH0853n+my3KME;uq=P8b4F1ReE`%FUmqvg5|xQ|8t;KU zU`bSiN#PukYLa_)fn$dKR?TlcF=cLjprU6S-psDqd%@hhb~`VNA-i0U1)PCX@If{v zhDwcc;kcum<6R}+)94zYVcbep{pLO^#4Z8Dnbes9r|ragtOq$)Lv9depL`wKn5^+O zCOv^{zu0j~>eUU}kqx8Kk05cI&~>1AzKvQk@viha_0>xGT9Mq^f=US&9V$+pnXRL6 zP5rn|+r&@tCTNQ79DxK!qB3k#Kaqaia_=>z zM~7G?YeNN7ZA#O&-{c(y*x-gOONL399^;sP9l{2~m?1;eQ{&AWg5MpX5f9L^8TU%S zdFjfgzL=pCqh`A)8NV&nX2X}3y-f>f`xfLWZC=L9w)xp{rBmfHk%in(1zoca!1VS) zQo*!rhwPcAiphNTYZV`49e$pfY}RP#cFX3p)mLPmCRr6bOmIU&U~RKh7o0_H4qNv; z6H(m@???A=EN(SJh>kfY+Tn)N4|y7paAb&r#6iPC4JU$7M0HX&pI+_DAX4BUO$}Z{ zWzP~^9$vgD+R+c1ccFyNw)|zu%{hjim~VG5z-z zuX)b-YI^pcrrvVj)AZSx)HH4Fb&RH(Gf|-t15(|ByaVksi(;wf?Xy);eY8V?Cxd;y z&TVVWLN%kM_&z?|4s-gEbs!uqf3b8+n|}bENXSO$ z1DJPEH@*dlyj*|0O^BJglE22l@w=K6)`$JDJ!+vet7y)c(Q`Rgvl2Htb1^tHZ0hG! zeJl^fPB`hA(S6wx^8TTFkw?2Dw0GI>?+veq+gSC;7`3W;o$UbjAJ=L0lugx4VbnBL z{}58Atqg>sMMWMuj@CxvKy&~2^vYeY$Hz^ii+!Wn=!U<_pLwh`H|6O1uMZ|~$;|%* zve~H#GccIoS?j=v#Gntk97m0DbIIkE;u|f1AZ?3aK1{_?v~@)ipSOyi%suD{PCsR;)V`X z3~!GC*_emQ=jXebD>4O$O(fTwoFJ>;ZW9wUGPfF#mu>%)$#%A^XQ&N#%32iAdE@+} zlSvmhp)~Cn)Ef1})gj_5i{aaM8!oEDD|3dQD?8tM*@PxitDn_fR+6H5k4$`c;c6(q zmH*?S#R-mS`tV+WW$-iv{7Svif9-@G#!;f7`?pza%1I!WrqywT3oE;~_|7>P8&HR+<;P4g2+&^8*nqhs^zIFyl6Zji`KuC39Tn~1^;*y4e6_qK= zjI+|ptC_o&oBh?Pp{16d@Y&Oe%HDo)&P65rqc-*2)8l=;aJal>)+JP?}qRwHaLrmtNQRon8g)jPim6 zBv%%0LiuQFrC+dcsGJN-5qB;q1W9Zpm;#;o42~Pc)3QAWxw%(4gN%6FQlsHaPoeV% zE6C3WQ;TK>fe$GpdjqfudKTxB4qea4>hio>qe~)wXle*I3CEqH9*Yn=FuEbR!2AY| z{Q^T|*X$4EX@PWh-Wbjr)UBTe^^L|v;e->&7RyqZ=Orf0)Zz83*^4-2r zZu?}56~R5R9j|=UziIJlWL~DTu#>jp9@D1k%IRUD`s&1G$DYVS_C~RsT+ty|;!EIF z<(^OLKD-yJ6Whoi@Pu{8a5*xYMy)71G|OuH=3I#gpMDQKP=&;A7E3$wP5 z&vP&+#^ULrHJ_bcJd-^*ZDWq{_SHRer1gO-J6D?V^{9^bp{wu`4ULZYUS4Ugicr2w z<#1fle*n%V3#y>-$s5`>%&UFEn`~u+QslAwExf08Vg5tfGBia<-5X*D%5{;ortI&d$E)n-6j?}ki|8-g#V?+w zcP@R@2wt#c;_^9vzR1X>zJCPf;aEt8-I?gL61$$T@qQy!x)1)CI=8# z9~m5^6=L4oS1SQ;Y8`aaH~01I-D~|_bI#wDK7%_JjCE;zf}y(@0?Jsu*1}U_W-xZc zH|t}ORJ#ozof-j-P`cza83CAl(a;0N5ZP4e4@;73mpd7a3_4`XE^1#Sl($t?WIWUm zD{#1|8+<-diUh6ucK*`>WcyNPTNgP?8dbJ8Vt3YpL zx|q!M!~{ikZ4qYa*J3=_;Hwr#sW1#Grkm(J@y7%Uf}FG}D9j9qD7wPpE%e&m z0H3u2m%Ds``Tgx;zO?0VJGlw(b_zEwt0X14!U}bPDSV9o;ar?*FVL6{QncIsjk3^Vv^aGFMo6cL4avWG&Vt0WmOo+2B zF@t5A*=Z;wOoAWB;xU@<@;-1H8|_y!y#JU5a07^T6TswrI|-afZ%Y320!9{hC=8IHLvvVC;&ee-oe z)ga1w__ZcF%24rB9}v|IX|~(7cRn}UdFmnKTl5)E9;cINJwX+*5R)F`?aw;wB8aTjsW2oez931>qb zK9(V`TuC?93>QP*4MpK~M9YTKOmx&h;`&$xG|B20?&nFltu>K6cQO2S9LRsFyGz>( znGvz@#QN{Y_A0Nt4f#btZ**$#6yTvYX#!K$Wsz26u94JA_af((DVCm7S5Nt#;iN94liBy|(E;~qoa*HB@8c8od^jD8c&TvyBVq?xi_nse7s~)P+>{)f`Km+*3gvDprMKj6 zW0e5_XwZH7U3tXAfPYbYQc!0x(~-RUmMaltFWNLSiE{dGh--29<3-Oks0)f~ z-}6V8j;P9Mt5vH$+{9E7uTBzLNimHLr4*Yq5IDU84XK(;^x&{A@)+@HKc%^xe|fX; zWE+}4CME!3r`n(cjyo=_BAo5#nuWvsiynY`}J^MWA1BVkQ5-VNg) z7yki!7gwRGWmN$bh=i~TNBxW)!bi%lFMwAqnkWh_$4KfmN@@!htbdAEg>QN*OxqJs z^Ob41s56E^bPhEuu^wLI6%6Q=VHMvjt5m`M%lIH16fB8p?+DCdf*J&%dn~ zD~{IC6As=xpf$Mg+d4}Zf8b|yQ+PQ~{`cG3)5Bli$%k7eSAqJj*Zjrh&&w%Vl?x4B z8~&`1B)Rpr#?vcM3KHUEsV9XS(s-2IAXzB2Jz8aU_s4f;`3iS_mdks z+2HC@?9=zageti(*6StJ3vWw9${kfa->l_nJNKRN4uV5Ttf0`fY%PU~C`Ci-y&7Ha z<4+KH?rE)g{@w}9eOM*jIbpJOodN~f<{XFcvDuadaY|3OxyuJ9ok!crKMyr^gvFP` z0E`4@@mW7L;ldx2 zQj5D*ik!<^-rO~xHnXx4Mc6eXgK`+Up%{1K4f}WfN4|qnGHa<>bDKMW*&0Vb2 zlOH?GADN9yOXYh9#n=_iH-f#i&8F_ghJLi&2{2i+W&ZbT@l>O}+0q3-Q1jL!dmCgm zN(Ye*8e#+Y;a$;lwyhp3zil0w6QGfWL!(_n*}7uYaJs)7N?=kLgKSXyHtt*6Jg_RV zx}h|!q554h)x@|Ktb#U+YboSTKibQHI!zerkgR48tKhnolL^~;!3$bI6I6@W`s;@l zPni(2GjL?@SD<9M?al_?vlOyut9D{vZ|3}U=y{pt-;SPPk$DlL&oi2-Z36gYRXHjM zYaQdrM}_XQrU_nS8^b_(o)j*A@il2?8#IPz7PU=XQytl|w=}N_bW>bOyc>5t>+iabt*K_A9f-5Jh>4H%zEJ0ba^VJdLkKuJ(+2@b-kx=d>7J1^H_|fo* z|J9Uu^|1HxsyF2N0DVr4?;BkZR>h{t0VF zj~MG6ewRIgq>{{Tu=?EvUtIZsByJ+WkCU&G=nY(>5FQCbYVZa%0i-+hbpwDGT&<)+ z2hH!uO+Atg+DvJyd&H^0IoMY~C#5v|l#$^;f^x zXU*QfD|aB$$EVwEsgY>V|4z{T2g_k8;up)|L1*=HoNh=D?&D2K>rd}ZUW)(W8Ub)X zGQpEe6$K0x?Oy~Jz)(R%{okNU{0~Fr{}+bJ|C?sFr+5iSYJ<+(lcPQS<9a!O?fSSO zm0uLf#jxX?kn6I z=D$s2etjDkc1FaFvguAxK}6V~DMIY5spXNle4vz0Nd%Aqsp#_$>vK&_sYPu#>y>O9 zBRts{@}c7ZS?>iQMghpPdx0WPEjZlocP*h`Utvvfo7Xg?qVSDLpLIMz{!0|}7Fs|* z?OP~1@c%_eeDDP9_P3g{Ux3y$8DeB)#~ajskR;1?mcn6P>{MP{Ci?)9G`vpNb4@}2 z$<^^eTeRYjKUy#bs~!Z%6_EFHfhjR%M*Y@AiTLI(0>RxVUqQ|7kK|YdDF>gJ#{m}* zK9$e}oV!1wNqxuTWLig}Yt3B%2Q(t^<)!i=JCsckt5ha(WQ|GDy)O zRuO3E-fLMiK@4gMOaOy<`1>+`TpENGgRl<#iCaoP#Uo_nBvIsn&##u)Ojxw9f{ z(UvT;>#W|rAR{RGO&l3!6)Ir(j ztd41-$<|$qwiIv46o^1?&Viacta5e^<%=Ehy0$`7_XPzRdPA=VIy<>*hS)5830nDl zQ@s45TvexxHbruhf)(S%Yig{#!Kh)CvO5(#I=1fuiFtq}tHoBSeph7v$~Og2t7K~d ztK0QzT4m@%7K%#w2v1-aesnLB^2rtOz9P(z!aC(D@G7a5uC@)<>`@^taBc#^lXr;l zHRkN@Ox%@sWbFLv5IF+OEGhGpV%=xXdU*?#2M5>}YW+cu^xyvK{~p^sTvb~uCi-Lt zsA>}d6sAKk`xx_u^skTSCHu)cgEq`6K-k4AO>2oF*cfh-3l#2f?H|wr0&ZMfk6RPS zolODfn^b|OvkTwfeI>CS8nLk>mX_@tN&MSy1vfxVjy^5BZjE@Q{tFRKhGCsaoiT(+ zPUc27JF(>CDy7@rKilGs875^**I<;9T{CF#NCf=d%r~|s5_p3D{1pHBK#r0y&p6Ao zCcx18qVvRg3T=h{gq{EbHf*sw&`Q~8`T&!o}YX8}&c=$j|K@%(B4(*fwZtVZO&Hw(d0}s)d5y@D|dH?+%|M*)04}q!!o~`gF zmgqnKB3~p5&N^cY^}TF2w1&G!!_Wgt@=#v|&@XlX6l=k)We)JjH8GIg_W&t>J8uH%1ZaddMB|hVd3` zHW@w19G}5&n(=M)r@MHt*}EtU+~{3+85c4BpXspZ<^4|MxRhVuM#0PvnJb8fm=P}v z#ciV32gqJjvfSet(m>C9ZSy$ACYf}p+$Oj(pY%ak(%a+?9eEUYI|o!eZ+-NLsoD?U zRa4O;s)U=rlc6^pHxs0T#RMyggmGUgmH;OU4-(#$lL%J-2`a*3$7ZGTS`;(4KIW8mD-qlAB$ts>QJ}hWMtM>%vBbd zbd(=y_l=&x(@-3fMb#wP6j0n*dtWi(hf0^*KjB$GEBhDvOiGz!jA`2wDJoak3x^giZXvb@CrTRSb%K=r8Hm~L%D;r zi}pv{yB2De8af!VQ$I3t{tiJ#<8t*L+`|+rKqDNm;-wDY@Hni1F+AfSF$;e`I+&O< z{XNq}6vw3Hp-!dAh^+G%A{LtzlpnMA9!Q$sM_sBs>3I-#%N@7opwlx8Jx@Fof5{t5 zUCHlMLyXl+GK0{6VB;3fx@y!XWCk|4EV}+z!BP-yB;A!&I{svUE(YJ zp~za*p`v4qEf@?e%NB=Y@%|x7P0_1DgMYUFP`S}hNu15+|O$>hZbQtdRe$y)- zM}8!mF0nV6NO$Q1dk&xSP+tZ9(-^2Ww!|m)mm92i;?t}qz|5~pgayAvRB?k{MowZ& zZgO47CacBzsYXN=aSPK%4guI@VJTPy)L@sPL{h(J^s9dyiW82v2Ha~H8(WY%f(*Eq zr8)LJ>c6gwiY=&Jlm=b*(0C8qf8|yNr9e18_oxzzP*FOCohu$JOjyf)>;f3!h;z}k zhsJR#EIVmNl*Vp?om@4}8?4z@{4Ex1DzIipEOL%R!hc=2D4PFS9~ZP{*GR6);3l9P za?Q8&tBges-yza?75(;(Nwqy(X8~OHOC|i5}62QXVn+5it z154~1zM@${sk#1fL^s}SsmNt3Nazwc?g{4u#|Y?tArJ56_{+z(x@cLfXrTKg&SbR2 zilK*zu?4-tB&GFBG0o$0Od(uiZV!|mvH}Jj4+$aRfuYp&!f4QA(3jXVS{Mt02r@3{ z!(vcql%r4%i|ENHVHuWx8RBs;2IT`NEa0h5M2(+=u&|O_D5=QeNancC6z{ggEEE?I zrNJ_*=u^_O2!LmC-w<|$Yp@JV-C2&{1 zbjTU3TMivliytsA8i!YD+U>v0@a5razsVrT9YkU&+%15WJ|D4kyY^u_PWEL_)z{NV z_Zlh47cu$OS2bRPOKgLXJDK=h3JF5)>BM(NVBHQB^dt}?$3(}zj5MN47DzKArZnR^ zwXdK{T49mFS_|;tp}-mV%h6M)QJ4565>PP%?_AaUiE2vWe)Ge?6m@rp4LRYnuu{MJ z<-8AY%M~nTUmi_*`n*tZtCQ9CojSvRMKD2y@;A&%&{cn^3n2LKfLpci67Cmzq`0r= zF(D)37?WB`&9DyqVAxFlS|xB(N?u=3!i7y$>nLqaLjf9)^J_Pn9Q?!<>2jO`;6JDxp=jA7{Q zYy>dHGCkoF8FI&%^itaFP;k5CW^k-tCckNcboUN!T05Hf`|frzU_Yq5sK4pI0jvQ0 zTL~)$_!KzI^kwm@sraDFX5c3Gn8g9pmOXmVB8t|LkNI-A7MohyC2O(u4v1M!TITc< z)Kyp#yubv#2nD@uDG(EE8DxD*p_6xch{nd9=GQe-Njm9M6~JNnU_ib4A%_25Y~`B; z=z&#nAcE<>ZL*=24x7wj?t~M8-Fuh%8-o+@f*v9nT_!AdtIY)lCl;_75Z4msY36Tb zG`e%$3xuWq+1^cWi)INtGuSykbBA3{m5^DyoRn2IEZ>#*6iVd~vmzKuPo|N7K0@ zFTl_z$00hr)0bP)2{kK81!?oob6e4);)We3pb>680N}N2fWHD7B#60SF{bY}<5)6! zU=0ex6)-ZN9}+YbF;RIRL<*g4l|fL46%J;9#Vzw!cX|`JKkI=Bmk>uGP{4kyP}>x+ zO87vn{M-h+O%R=odf=M79kqKs4tQyAhYcICZO+3C?H{f{&5#JBnqM3JOEY&fz$1-> zP>Knc%`xsao)ruIoPXJihRgP3ySNy0l{Igi9RYsf-6ehS`f;DLL{L?l z2=w;CZy)CJnQSOwl7pXMslGhB>~)nn;jhYb!dhQa`3oppTW8*SG9z>)Qt$C9K?m6W zRY|m$^byWtUZAhn14uu51l>^Sdv`HP{pSqeD6fpDDX}Ar0*N%Z0HR=His_Amy-Xhm z8*(Hg@4TEj|8H6*jlCR++=ipc0{fXY8NE9|=)JqW6e9I`1v!MCL?aCi&lLI=Kp@N@ ziL(w=Bu&HKw&1-iXuT1~ z4Sv`b`jS+_7Zz+r#R!LrXqD;{8KEq0y@lGL86RFtDJAlf#9W@F z2k5)-#_PM1;;ct~DMeCS2(iac0TN@&T?Eqq0SkV%vV2!-tG}c$OKtXN8Qm~I=f9i? z0s^%?$=ruM;+N+ufIZ9y=HhN1gplLGU&1DTq)8=V6QFgl^9;y?hpvJK%x`^cr~Eh} z3`ik8fL}~@RyZoy%J@EF3?Xu8Ch7Fy4X49~k|@c{BU9n8pECdPR1qI<2z*$3a?5Qj z#DkE;u3+a~ge{T#Lhr92Ay0x4gbSAEkZTh4{nf&rG>dE){uK(SGb;qh{J4YN>N|jZ z^h&Z8MsLU@(``{R-OdsmtpT?RJXlG#vjsZ+Xh~HL!0;|xNwOj?7LrMWO*+y$J%yO; za*XGI{KO4J*vuy>n0W9g=&6i#uyN7CP#ibm_SP8w<;w~LqvZ^s>otv^oXS6@^%;^x zC!XJb8v9r}Qbtj^&u!1%Y=lZWb3gKQxH$m)WJdCC=vsJ;RNW8&Kg14Z7UNmf_jKKF z20F8@6S$c|8{fE+8m={f9##B$@J7TuCE!qv5q_NF)NF^Q&g(g}5~Y5b&lcST5IVOMVxjaSjAY+~9Rh3N$Q$d<6I6Jd~VI z(L%H6j>Jgm7v3yHv)Qg&OZJ(wt=sMaFL2O*-iM7oL?2OEpPT5~aw8tak=%Boigwka zTX&k6-RC}VPg^H2axoE-@i(Og?UyuNOhS6Wz;futI5}$V11U@BfzGR{xfjl+3p>ib zcd#{r-6G7lLQXZ3s1A!>UT@Nbd~~Q-+QFgn2PMwB#t_p^56A;(I;)*_x zpl)WbxVr~56R(B#K3xg^xeI0a{#RVrg<0?Mm&If+J~PD_$_iIE76gq(I?P1R7zb7m{+ z;R!772q@FAzXYA&3R%XYB}k-bEi5o;PDfWZU)#o@^lMYJ=nxJ;m@{}`Oo%)1=N{jS zeJZ+|XloA8v6Ax4l;iLsb^LDG+5`0y55Chgk?OfG$M!;8q7t*-BopHWl`FB1QFGru zzb5Z2I@o zqktWZ^($xqEE~f_NDIN%a4^&-_w6U(2qXivlz5W6({GYuyts1_B4~oRW4G+MH{a~q zFRS4C)&BGK-eb^$&#YcHEd9CbdpX5Sfg}ALDAgvVejw~Aea{_OeP2_!YDFI6DC8-7 z=JUzyEYmkdxm9$t7L}_`94VK24J!yvxIPCkw7><`#olWvU&}fsg(TxCvurakQC`YD zs8(m6%)4o(WH{#7)lB+AM;fKZhT;s*NKtq80)&m^2RDQeY?E~1qC-$e+61{Kcp529 z$$eAoAcFsDp?AvRS&LW z75O?zo)SmnhFO7l*7H%4;fpzsoGhmexL#_UkP-s^}-g*g_1Q#9eMh?UdU&O(!^it{gmAfEx1{cH}T9@ zS*kz$-U8NszwbqvH48kl5c$rrYLe%nmBMN)(SzDmg56rwt-N)=(5ROf&ZI0n$P; z%V|;rKF4m0pINsXmc-{eAc0BLu$XoteaL^Pzg#EP_%zd7rHONXL77UDV2rPmr_X|% zfF%xjeu|t~JDybX`9Y8+lc;*Fy#~;{XOF@&r$qQCIh75qfy3V|wOnj3@rjPv=?l7w zv+hhZG(u%mg_?O$tA#>{~y<0CuI0O_Xc@sd^wO#02#QYp|YYOhtU6(iKHw15lD7u6u``$&J z=}xL)%dQ|4bfBv4OZNruS4bQ>8!ho!7QgG>hw?~<@46UVN3okBhb+)JB_$qrI9~iD zIQVmCa@yH9>E8RB?kU5TgxAAjb!iBW4dBNhQn1)Re$|&RTHJKuA!5<2S#0^@MJ1y> ztJesn1)e%Fb;@v;S%uk!tfe7iN)t4$R8f5ZR@m|!&@HC3N~H~1D4Bu> z2j>REkaO-yv1ZV(yT<&9J8~AP@y&!!+tWLiC<>v@m%uOWdVaA6XEn*+g-^cqw3Hrcb zM>K-Zj8U^T#yh~sP$d5YIIJ~#fg7?w)`zu^pR*_9f1C(K6EB35d(axNU~U4nD&h@h z+h!u#2QF`YO#H&bBXroxI;gQwxjNSr!`**1%lJcO@B*{cHang+g=2~|=24py&|*DD zt6y5$U*#!!86#Wnx>n3@bH?k4CnXz-G>VbqyA1q-{WBS)e>i>$M$<_ekxbKu?)()3 z9)D|-hG7nIryD)qmL?^a!JPdJ=Ldg=AP=<0NF8oJmfZDv@W?-RYvOmhB}hht-kd59 zB*kBX`csP&?}u;J5+yb0t(5lq>faG}na49A4wbYH=VD7bRgJ+w63-Y&@ia2K-ZXLn zNh@zvV*bwU4Ec5M#AAI1>ryWuAu&GyiX`u~C9i1R`MZ;@Zb*Qj$E_pf=bDHLe}%6y=w)|zB`zOky|_Bq6hx#1mi@TI zU4>na7;K7u{u>4kT7I+p|7&7-wzPFpD40}6s~94dwn4?&yq~HD9!4Ry6a+-n$clS? zO@oetZ1@xxFT4o@S3p=q<{_->_PpvUQV&r0lVlcwu>&`WMai3j!#18i>b7>^ zBcqpj&dk%SRQOiw!DEq|O@&>(F+g3+(CykvkRLw+fBf^9ly@*&H&Al-YONS&e|anV zjpeBLzgzzY@53Y!MF#xC#*2@>Suq7#CwUDX+|^lb-$5!wbh^okr16By@rKd}rYYeM zBL!w{I6})|6W9fEfc79|*3k8MMDy4aOO}F#Z`ggFgLzk=%7xEzDa3W{x}z{10eXdy zZWVbB0$p(-vr&e+maU@!kt(_-x6jq;AIxK->7;T)hMh;>RVGk8q2FWGMF=RlLgYb6 zCF$1%FGmlvCZT8%#+Fq{OF;0h)IFURqmSzLekFI_?c6|J{>h)*y?VA->B{gH*h38M zQmwayn<~ch6!R2|d!boJ#MYyGhQ6u{zh^uB_WZs?Qfz(Ojb(lqgKtH28*FmxPQ80L z>hcG|dy4O74cc%rE^eIpIn4-o|5oWe>j3PWkGDY2U8}K!%8|nrDvy$XLLy;tZN=ZP z*E0T2aMb|#Li$!aq)VFsnra9fC1bC$8v3r=t(fsK^misy)~H*j=?uvo@6)zw$dY`x z-eOXrzYl6LVYhO+2(L&Wf|kT48H7yUgt~#>IZN$&tocj`W9R#&ipyiqOR*d2TE5gq zrTOy)vwHO`wJ>4@O@7MMaCv{`w6#Pe?$aL>v{J98D}W10_x)fJoo zwV^X{4xFQg`Vkkkw6PyrU_%ac&bl8+x9P(x5@Thh6TkN}wk{cU#A%D@VB?wL>dx~K zg#`T(in`;i8CjSFc>!3z86OvZizpl9i<5WiEBz@-Y)cbAczcNWGRN2Dqy3QOb2(b{ zP30E4$hjA{>u#@Hdsj?Tj!|L@qR=laiU1o0NycO4E7hiudQ$L6RQUt5TVtdKo7u20 z-Ay&uRx(;u)(fZXR`}a(z=>x(k2tx?gjQuSXE1xfmPTN=K@MGfFa|(3Ye3gt6lK@xqqassJOG7Us4!;1s2l zF;DpY{f)Hhs4c;ZlfvVl+Q(JRRv8%ssvFmOt1`#!6eQlCbHG-ma3*KCHp&_J>zPx z9sB$Ff!XObi25`+Gmk=f6o>O~hGJSqyEjXbu70-tpk05ADy!r@hXg%^$#5%>vT9ZY z&d1w=>p5=TL}*xYO#k+fux>9^wl3O3t8Xts+Hup~ofo9Gh=nexvtL}1n2DbLPa0rC z`I<>#e)#*#cN%l%is}!tf>>*F1B%K{rQm=X_=>;*oyhOBP$sCma~CwZDeXv zSDO<@y!00%o{ONj4@Rtl5l0grW>)OBZlnyYR_D3upYK7;hD}Ee`wp4teNLjFiSw)X zZw;%j^aI6B{5P!~28uhryb%Ph1iuRFWSrYT)nkNt90ch<3#2OYQ2Khl+XcJ_EHn;) z$rNnd$H{(JEdyNAT$c~7hvp51qHHy_zn-(omu{RnWnh|W-meAk0w(_KvvJ_sYo(!k zbpveFxyTOnq2y9~$=8JhY)u}|tCV#OB(4mEv4n8PlsshqJMbU=zXv`^lSasB>fW4O z{!8xUGW)l{EfGiKZQs9pI+2jD%Sr`BdP2;XknCfgk9=TUlstczMdg&SxQr0?CzF$A zF4MvSW&Z21i;{$?dDEieZQJgk^D)bE0u<{&*WLy+3>wB9go*;D!FuM; zBaJqI0wleCWobPqWVcvjIMdkDZ>2-pcrCH5G}9ax9WoSi%la)2Efj!d(bR;t_Tl1Z zz?V z8g=@alzY4V!PjuGRhz!#z+il6+L=ISv8mlTKd;$TqpVyPP>ir#zPo9<)8H~4O0mf1 z7~C_MQ76pmmW&$Vk{*@|w>T!DyR6$i6VCvC#GE2-Hf{z@O(fVIcY1b<(OA@%jjlPv zN}FS+{AGtr9$(BnEH!CtAM5fejm%{oZeRP`X5N0&7`8FIH<}WvC3>^@aj28%B;>Mv zPmP*;qt0n0S284rsR2(>DyJhh-0nRRTk8-PAD;gC?`9S!7>4~O=U&b7`YHZgv$X(l zzfK3{IpwOCjYl<@{LIjKm!7?}c|gG`oF#5-l0gTZJ=%C}rp0%exQ%#3Lz~0o%Ge3` zmo;yxDk9$+|40f_c`lHpHN%Om*S70QvVI19W6Ja2fl1(yq)^i4fxeCH&hX}83ph!Y zZCBogFh4je7=B&U7hx*QSez7PVao0Tgh32u9+`NtH5N4zXoj+knX+9zjA& zJ9~7Zm8Iff;Toah@g|7dCnq`8KW<)o+H&B>Xm2UJmMmHVfOuey;yexn*zmCW9qy{t zROUpj-?Pe83M&hK;%gr(>t6v6MqX__qWH*t^FK&WG?2eGP9uJ0Qc_E^1fT^8K(Ue5 zxean|3d*ztUnI#&@9gz#F(0RsyWHNBOlAd6uz~5{ z@<4uzE<8H1J*MHkHMzs6lJ6Lv)|)~#W*b+|j>1nY++PWJJhNlUBX_I6APXi!1Y?7u zeYK78Zz4IeULvUp&1UBM|7vDsprxc=(SQ_$@oONlVXkKyi2yc0wX*|Lv%!Ds3L2>4 zkq9Tmoo3WG8tT==6&>&KA%fwo6$VRv`&F?kHM0RTc%RH3koIc-823E^a2+hk5s_!D zPY+C%LWqF!YX}$><~Jb|^IF^pB{G~(SSX*NSS?3ot~P`yMZh0F5w+x0eQ}?L7TdWF zDM=PCK3O0Eo)K_j0^PKHD4WqQm8Mm(S0$oHeYWFim{1%+#k?ZFol9SmpuRAx(AxS#cNv{@0L z{&Jwj{)aGSzmNZf)c9#UFxi{Pjao7Wf}fDNwOV-;>8`wP;o20dik)Sn$-?wdm00n4 zC(UnQ*x~Qf8e<~FhQyNSj9d+IoqKz-Ui0!f1`4eE8-g(Kl}_JF;9`;hf^Noj$G-*3 z8!Oh)an70P%hYTLC`Bz^@=h%LGRh_k^w9a?6u6 zPdHW;M%Q%F59M5%589?zyJ}c#3E0l5W+&bxY(3HZ_Rv2_Us8@@^pvsx;?+z8Uf5{L z@V{e@_|5-&%&jS;E}i{qL`2&Q{bD2NbH(ztKl*^L5{lfSt>l_WnTaBySZ@KMbFecLPARsN>Z208?QYNh?kt_|%pO-m#EWKC z^|RfWng+qsjNc-CsuRClYpQ>jBWLq}AkF|1Rks749+P%w13W}ouKI2#G29Ps0eO~> z?Ucc;7wG83DRtjvITK2EMSjiw7(nY zkN}I>4_+0{wvn;_Ab&0E!%`$ZYYetIXI2FLV+zOgW}9B>8A=@I~JQIL5nKc2D z@lqp}?u#L=tt72WQ4UUb5Ufy}yQ387sJUn>?;Jz>!sB!8K+6Tzfz-`K9eis!u7Tvi zkM3+X&QWr8sVfeZUB3VBH8?!0qA7D*Y4c~<0f4U|-Cn9j|4!NV{U}n55C58wIG?v# z%BCGRd4P+%kYr!wc)eUL z1@6JdpfJ_nWU77d-}F8LR)6du^w++M7a~O=%@;!QN;RGg1Zw?bquM@`E3&#}x5RsM zOPfJrS)CTs16F#aCMS)_#bEqi1Ac3z96FZPa_$)?o#d^9b~U^Y(^O{M*1hkPP^7z+ z5=qZLlZI%o5^#&NhzxZ>fT*Z4g2;J2kwa_3CjWr@;>|6*Y|;s#0>smm9LlKrNYy)Y z!s=rEHcvB&eFNG04% zVS0wFLWVO7CYNUr&8pBn9i!LOV2TKS_Ku=UN_p;Bz!}JmrvvhZg&9rZh2n`p2_Lt6 zB}BkxCMjAMsmm;AQNtg}+!%XKgm7$k0$6ymCJ25fx%GQOa+lD*7sOPol+VbDZTbC6 z-n@Oz``A0%d2`nKYWF~JN4x(?Adj-|k!(UIAaYzwg%(|zLD^jH` z`=)4vmeBIwtY~8!F&Y8z+~u=h2Z(4RAu~blO@B{d$l2Zs>|MYbm+uu-BmT4h`)a&; zUi^$?76_fG+j2$T@IdhPvRyTr_Cnmj<##7XxEmyq;@ZXFy5&I_d!=XR)q0|G%}%^a zsAK*6p`&eTP%+FfTAX{YB7=NO!6xt0@ZQknlbHC8qor^e{fjb%8^*povJ}w7$i`f% z_hyW$RqQgZvPEA>k7o$7i%}-|D^rEY(E}`J(7yQ{h8GjYf6)2YG@5gAc{Q3YmjIO+ zRTqtXw2G!Ue%)2!!ORZzHx$iFwx&9U7jY-;J%%6|t^thW5viKpI+;atale&-q#9ph>d^K7q%TV4il!G+uK8a^+biEUt*g8cD6NQiWR#7 z5n#QoHY5$=_1JX}yBtw!8G3yWY`zmVh)(EbGHcBN^hv*^eNbslX2hSOG#?mGqZt+` z*1tx8xoHuLm1p)EiG4m_rgOn)Mec#+6M2V_mR{mErttkAPpAX`s?~;<$zk#qVg%PB zw|jp}e>HTupXBQk2szq_6Cjk;dwi05TbOoor5i$c<|di!WOiROl{*6)OAC6=MfVkA z-eH*zTTI4zk@Ycr0Amx_L@cpp=8L`l2Ju%-VHyrztuPo z@-ENXmG26l==cpw)IQQ>hcZoB#|rq^h%cI_d}hq+@h!fVo~tN)lc@3{@`=YM@AodU zsBCwcI~&_?PE`RSvh9nBo9(=zjgRsM(JR^am#27xCh4Uu{@e>B|}Ej{%OEn{}cbg z7BD^iD896b**>5QKXJ(&a|MeLSj1E>MN2Z1E0jseWgS_iW zXH@;>nS4|SP&t^=$8Nf20-}mK5pYjxE>nb^U}wzRx@FWfRR?t6qV|>r6df6W?^cdC z`hBi`hHz*jA38YuzsMl&xVIF_kp1ClF=xn1IJi8HR{iIhQzTB-oqtJ=t^cY}cs2|O zSTrAz_s4xgZp{I9z+Lmh^3No|pvZanERjp}9-rAgJ?~;OhjXxBM>;fUe^@Q-64VOG zlqT&rT|EZ*Oq;B`N_6cSnxA9RU3F9eDNn=LCu|4IFXb9^yNOgQg^j~wzc!GN=>C^I}vr%I|;?sI2(gku(Hiu`76EvV@;|lDs z9|3^2T{(>~Sx)*hzpb0ukd6(MYfQF^$18jEa+S z?F3*TLGX|rVA|S3Uq!2zs@Fd&Tra5ay*bt_t-PfQ&T-anlf`i zAD9A+>bxck@cYZLPUN<6u{8i@Y=e#@ut-Jb#unOHam7mAl?3;6wy9?({+ zf(M)T5t~(UCHF+!9W*Vl5qW{aUp`1b>NQ|_!SM6EXp2@5JpVoL{8xSeYIH`6nRh0Y z)d^vG{ZXLH;gnQMotGqKIMFNYtJ4c?R#M? zm6I(N6+;rnz-WxsrCt2?k)j7No7k4Z@?)__UYFxvrB&vMzx+JI`$vd8VlB-SAwU*D zo+ynX2A7nl%Or)Uo)!3z6^uWpg`ci4xQg%K>X|Ea0c%%dwg^7CCx^)+-?0RzI-v_F zgDX4KR$VA(9wW$EIzvR~>M3BKYFCb?7&%vJn~YW&$wptsz8a|ad5(N6|NlCV%M<8VSn58Db(aCUchn6BmG7S$4`BUrgP5M&2J0KXz8|Aj>vdSh$Afv==sUK z$|x2n01bE)9*`~y)C8#us3_ckfjJ6j$`nXqur?qDKS6o;A062@eH|5r3|Sxiw*5q? zWn!K#Kao6Hz>CcR$8x3%_`oLx`|%#&o4D;^ZzZLuqKtLfJ`AphhYG!3PXSc=yU$WM zhv4(ZA_=Qg|7j|cbTw%{vmkf;gKtOQVS7b_(x)BTrw{{tAzQY>crJ z>2nOUdyci_4F`ZfIPeX4JB8=49yg@HsnBXzKH^(WV@bA-TXDqQHCPfv@P(?^MlSr4-xbj8&*ag=8LCko`^% zFM2>+Oe3}c_(!|X6anyLD00s&Oj$x9o}&$E;XbDaIH7W&)BeVWopN-4lKm}8=l%OP zFBFmmYgA-FD52RJxbEc7Zb*PpWQ~nCFH(jI(Al3!6iZj8$B8bJ48KpEQ|5yJO4LGdpP%CD#jp zmu_dqi{QOfASMaFk5Vx~#DE%!_w0VV*movNj)bT8x0GZ)Zeu+6wI>_=N=pPhEm6S% zs`rLyS2-QG!AxCU;4UWg+dXxv)+0v>#XbK_b%{FuCEjC@BxzzR700SO19ow&p;@t7 zzZOd{DCSYm8#h` z{$Helc(8w_bXS{BtV>&w;4XJk3`h!yYfS z;qS-aM5wSgo(JK^igcll^vDnSXkCJmg|iPye&Yk|Voc*t880S)4amQk1R(u>eaY~1 z8?bwSBG>6iTBxJdhr(Ag2L5EdI(B_Ad}we8>T2{5s~xcQ7*Y12>?q3QHTDuMB#%V? zUlD1htdU>-tcABq&H{JWN4qSAhvULF01x5S*n7jU6djMb{ ziI*CP!p{e~a>Q->MwNJhSkg=aPpeTKaK3V@sJfpzt?BkJ2or;|cJeo{XI#6xX! z=|~Sb)j8mv_NmEZ5DIL~dN=CcJ19;kZn#>2 zl*toR!d?N&E~ri#$S#~%1DW#>o>}`SXF$XWtT%buxFYGn!AN!nP06wGOz(y7Q_=WV zGzyG*Xxx=Op9pq$XW2B3ou^O!+M)y4SI7V=BWys)&r3J~dDy5po9+Z|hB6m@Tz@?bSx_zc8F_Q^088X>2y4#_3AY>$bM zC`P)IJ8r%5S;y&k-{)EkH=O}#OemCN8NWO$231&}4R7s`S~uUPleb=)M7k`kf!+`T z3`fFTXU5L}eH3B`0#KhFR<~d>{{-I;B#Lak`tTLp-=4eMByQ8-j~{n^9F#baePuER zucH7jcU4R|DPNg6BjWqyaumRxl5UAGg9uOS+1-$}`hgdKm zXc^Fs8<1polE*bQ#Z^?~ls9@((q(|SG@+IY%=4pfHipm@mF0I^k%pjLFIeemtLe;I zvHj=?z7Q|^jLx-aHqX4e@(b3u3%nemNDkjy_EmQc%w!aP@Yq7PRVK80 zJLL;o_sJze$?-C^opI@<-3|eaPW_r9Enj9n+Gf{x7|Bwmi$?iw8Z9bylB=X{+LYq# zdkoC)4ZlS3wY`Ijj(;%37Kmc8dXPP~Rvg_V=#ZEX#i;m&3{TA}o7r>^dnvSoUfY{6 zww+i{3wL6%)v=P^*Mp({x(Od`-U1UR|L&|FE0p-v_Cztb5(rXgb#Z&d8Sqz>r3A8k zuVtL6Y2}q!SwjVJ_ACDT`u~FF@v62>K7SuR%*IGa)*L-G2*l;Zi?!YyH^Y2 z2h5bD%(F6X&1|$Nl=i3sGMl`KH}%&JT(fle)JCd8#_1V(jV`Dv4%(DS#WugRp5)2C zW^^E*Vifngg5!M@%yiL0=E>`_=-!aTxc%DG+)UsoYA~sqAL!03+ojHQiQbJo9}jG< zirMmzrsLQQJp%E?ALV%$edMJ_G3x=vvZEI$Bar^gNy*#ora4K*kXieY$uGMuoCq6M z9*Pk&v@r;(%`H<_!>G)*%wElUXDRjX(xgYKSCpFF`m~Ut`>is!83R#(`@Mg&UEOau z?A-x-T>}Vo+EMzfe+B!01{=mWN(%gSq9{rVJ6it`$KUR&(rquy6nAx-H|D{$JEp@ND&ws_=7SGQQ9gVTQ>A>% zbP(vL(&cgN9BI4VGTsf?bCPvEuuu-#Yk(0G%eBY$jPQ!e5y=hNu>iVb(J2dKjO;k_ zh88N?(i}d_-rw5&_k>7S7=o%B3oE}PefY6{n;iNV;H8G&;z;K?@*?_U4>j&-FVPUo zKeD2=qF3`+YMhsq&|11*rh@Xg%A5+1r~e60=#%wg<##rVsxBQK$*OL41`^XIPE82I znmtdmKR+&muH1jPtF*g$=LpF^m!qFpebhP@#(NQVq#Xt>aLi$L6g*)#@p^G{FS^E3lgV0s9kCACs$fD?y-#(S`mwn{vu(gt zID~x472ZT{ImzaQ8wb;z4j;Z5pZHAeI2{`_f|>t$A)P{923hx>Z#T!^2Rp#Iz2fT5 zjGSuS$mJ`DVpsz_GutZ64jQ>XNJuZX3acI@7CQRc1A~c~LLE{uvpv{Y@@m?`G8!(9 z@cBY5fv9t5`S6R#`i>Zz8n0Zfn+feTgk|TRfaz0(Lf5Ks5+}WRENM$MiPcvorc@zx z<7YclBT})Mq(LglzdTZJx>gUla6aNEdU@EqhfAIz8!$$PvdJ~=Pa7-0>q>$7%2$n( zB)S{2XA@1T9!kz*U$ywEdO3Q2)}LH;ujarS3mct~f&~l-e39qC3ZunggFdZdVvEyc zDg1K0-}H(q#5ecmB&jiiwR!=?Rd$arr#6G%$6J&d^({H>(Al)hcHx(^&yJ+`YW5-9kBMK)eJW0N z4si5lKbFWLGZvw_aJ*J5;P#SQ@}_Yvs;N#0W@+30?h@-8-MIFLLgf%P~(?Eqam@xlRGTJwL5!qd3&{&fDHcV&ZAPCLE!(1 zBP48G`C$8Zg|FY|2+)fxgxo-*zLOlv5noUX2T>WYJ-0nq37NiJS3rd60||Z>#LcWR`ZCTLr3+K`i`A^4f)tDf!0c>0$42@5><{oCAPE%oQ>=|rpZkNaeLTSPR| zX+$_Vxw*?)^^Qe{4bAc*WQbodQqtlwsG<$!FRZT%_U!`pX0n~*fZmxy(ROdkQR24n zm%HBne(>K;e?MsM;<6PIpQQ@j-sfy5T`0fK-uBt!J@D5_6@JR$bqb!(!g$;IpiSz$ zcBMr;l0b`HKZ+i9MkG1wA35(v7+Lvu*tRmcsLA}$KtntE@TaZRAM;?6!xS6umuYcG ziUARiQGL~h51Zmo8=A;erLX3|nAPGIt$0S3+UewN6Oh6U1ee(EUxM@-A;YwwrJLll z`kaWdeSIeEEV++27Xu!1ofsc~;@ng3Y2kAV)M|pdV>?KG z)<%-+*HxqEMD3~C1rJnjl$feydh)VeZweUqYF9MnH2?g>jqi{#kuWM57x>Bfn$*r^ z^Pq#=%AS}?In_xYtZ_J5uzpT7?fbHExp?6?O`E62(x@=b#>V!D%gVX<`|U8Er{S26 z2lC#R?j7rtgoLFT+G=ngomN7pVOO1+XK7;7t+hDb+}r&2vhwd;oZ_O^=|wK2GX^qb z**lQOWpV>h!&%v1AvXhZY^l1J66y0Bht2f0koldf2)poH^x~gKgZ@#_>un&!aFEF{tM3(-|mIeta1!AsL)6w&( zw#+Vkn!ok&x#1ShCaB!T(z|2vv`P)ii4W!F>O+riBDmqn88$9Guq+76;LB6UZGa(} zW&m^#NE@L>#m#XU(`LMk16mkF=AUymUhl61GTG=PLwJtGetVHE&`kF7GGrW3?r%WM zCb=@_`o6|?&kozxxcy=&hF`t1J79xJt8GZqYU~w~;3J26vj&=9w~Qu(yH-6Jfen*LU@#id{+Cj) zzY4S<)(`fS$?IADF&A{(U)J|>Zo-2rmdQ3EtqxzY(63$znjevzO#OHXJsJbY!s|NV zYdInMxlvl&o_X=XH`-vk3D~f<_dEa#Lkjo7n`W^l0fE?TggQrD+@BR0UNcCICYR}1 zJuZNduU0htsLybe%3!z6$-xPUw#D-lq=SQgzj8{tcmBO1a7Z44iNP-W1&?~Cym5s) z*Ns|A+iuter5WNOJH+_3ewc|*Ae7hE$2UO2rboCYx&Ehff0fO{8ESikpjhF>>Umbr zyZ&UD!$8?1#g_r|9{qp~B=e~}F6z1e@QAVlj4sEk8pjxd z`MrI;LYNu4^K`eZ+>a6xIx$~B?Z5B2pZ_6;SZ|!2o`Li>F2kImkV zr=eK@?}ds@LqA`-Klq~8df)XeVq8P3e|+S`NltjjtViW#!v)$pX@%$SYL-RzTf{_T zWu+pe6`}s*Rj>8+OR(rKM-Hn{%sH{wXNmJ-CgtWuM)y13s^>WGUB8OC%38IbuXUfu zR@o}YDuG;=ZEijwKX0zZMj5AQ`MT)2Ez^rle$gpO+|bgkSzM4z(w?sU)%vhV)iNel z_IHGfepDzp23RyX?O!ry5n+jx;kl9LWNxq`;c?C;c-NL1PTB{Vs;pII`y}v}=Z03z z_%j>0iOg9cXr-pZvgDV8{=|}L8v%M`bF-^23?u6FT3!U*21bcRW@{?s>?2CbbS5ZI zmW=pUqgAvV61;KvO-@6szGY0kpkFl;k=-n=&|$rXZz7Z7;=wQp-ENkGHqztUx0#xF zc{{yWdtLi!A+d@qRaOM`Wh6Xnzkk?Z6A@BtmYpY%Iejb}^hKe_`LH!1174U)$8tPm zHRaO|dpw;Aoj#3d60d?gH#AbY@_z283#s&p!qw~8%#MN@zWSDC@cxE1rVjkGtTX3= z5?4xw1S50ItDt_{V)@N^6Q4Fn=Ln*~o#(tPO4lT`J0LJT;C@;Tm$Tkyg}_%%@L0`7j7f?bsE&altX@qLvV5i_m*FrzDX1 z2)v)anAIfqAlU^Fdx{x6u2?r zR0#u>A*w`IbHp!epQmHA)NNw-#8UoM6#5+OJB7F_t^IrQN$wO| z#VKK}%jQSD@8mjPv!(fTZ_2gnrlV}M{mOd1(fU{T=$XAPy7j`!>ZoK&tEu4M;J8c! zJojj;Jo+3t_7CQUlmau8a#Qr0Iygk=kNF`hHYATB&)#d#C0b=+wG7+xl|)q0kvqb7 zhYB2|Tmx;i8xom5*+mT|PWY{1>3Ymx`1(G(?g*fl7Bh*e!8Tmizq{1PW4#!y&$)_t z#l9exH^asf_rMIwKW0y1U9m`5`-wVYT#{>d$wZ2!HOu{GrBM*_)`Ty=X?q@J;-@_p zcFL_T@{ZiByt*!umP{@f;z~0uP#u4q)ZsT6?5DrYLOj5mY4fv(QR7C=y^08jcA!jH zcC!+^#>r;Gbya?5B-2ILb555NZOj&263?UR`MGc-bNYz-oC^Jqc%-)pbiXw=ygM`g zEN`9!eBvV;P9Evm^!{-=lFB;P&|P=}&2s_>3VC03f_zDt33PrNJkLHSI5r?tv3AJLiyRGqUdGr$%?<22WLf6Qa z3!x9;Ccl$^M4dL!_ZuZ@^0wQ^SJ4hZxf55a+{AHP42Iz~I*6rabboa&k8MbMD!{ThQ6g~mE#->xPBl|d38ec&Y@f7SM<>VZ=m#O0WHk?er|3PS?ZO{$dBL#i58j&aiM5QxO2P=IV;s|6j7p5} zHk!F5%z=t;cG_b~h#*!nj~0xG1avXt45Jt_k`JLrvDYDDWNj~g`d8QhmK%i9%kz!G z@HNZ#C;k}FuXT-`aj-!L=fko0|5d;#?0c%Yh26%_{jIWqG%FA5A895LlkwZLJP5V8 zeUyt=AyeXX&VmnhCw@zyM++nzXBIXM`ORrU4F;W6D&CVJI>p{Sg!mrIX(_$n$Jvqp z{3T!B$C6IF@0 zN9mxcr-;FCi;Q!X!h2RzT?19lgV__=+^`MzuNVG}%*gw}cA-!%=OtO@^N$u3wEz=> zg~$*a+c0t7eMK``A>#12HiUH5D?}5fcURDo;`>mOMp;IDuloPEAOtltR^ufN8LN+7 zSrp55pPxZ3NV7ltUFPM6*3B5w)X1GT6*AtCLRpB5M+`wpvTjoXKe zLMm08V`5m+H;-m4@sI6L&iqsNA;sQSCo5ZLjTWVa#9vJ&V< z_vO;txT)UxEZeFI9m{#MZu8>ZMh??{820l)3wST+YS#%(kl!#;uc%s=;+SJUCR*np_A2XG+Y38x!U;>q}5M-$aUbP z`lAa55_9y&^@94B!*Q@bbbPz9D=cvH=-3{wQb?0Cm%k3Ja-qCM=NXm9(}1ULYQuQK z&HCPCB?B;JflO19%TM@E(HqYDL4(;9s^T&*$hT{r0E9LX2XL4<+A0EB?eI^w%Y>-8?5H`SD#zdkl|~DO%Iy z8Ty*8SJ~vg>Iv1{_vW2ahK8>L1%e6b-_e7q0e8n))JLQ~cWasSH}I$mJ(@{H=IGUA zGt%gp-Jr;3p$JHHl{yN83UdsHy=e_;wK>*zV*6M2#z`^YM4m_pAvz8ti)MJoU%F3; zi=TqMEz=0%71Pq(o~QE`*sxF1)Hl1z8V=^_8AW!e3})f%sS*fGP6j*@L7{KrTg{7d z+|hi|+2QxBC8^{Av6i0(#%y|2v!`7I{=lgZ=Ioq>OI;u-Ha^qzPeZc!^P~7Ja-F4;4ClFHz_*^Q{=>#GCo#JDExuwxmTSRnN z;!X76$AsS?jjwVb&l8l%n6RTK&d^Qeg~YgE3fO~dl`X~+}olgnN@f2FFiLO z$&*Ci`L)`bBOmOa<7CYg(8trMHZaxv9n+9h0>@+vnVbUYke=1DT1Xlr3%}_6ShLsZ zp3_U^fQ2|y&YNLkS^qtFT0}?YTqd!C%KnwBy?U(^MtL-;2s>CHocYAtLKM;~-t>m2 zvP6s8H(EFA%fI=nO;^t4Y+O-2)bzae&~=`1zy(Ven<&UGR7wPqi;4>`+~&e9>%wbL zr|&KgP<`B*csdxt)|r1b*0!!(H5TtcHup$u&9&%y5tS9~Q&HjYwnpKE6bU@}-!(+| z7iJ$MhMnM>O({qHUnTl?&r()C!-dSP7R+{vghelhuLVB4J(2eDe+e@iCMl`tOJe*` zw*rf$SN4bc^H&r$4>PXXntJv9ED*A9fpoxS7Lp-9g0rI>(X`#~Np%0Pl;y+9`O931 zMydhxu;Ka!LOb=a8oC=Q_bd9v8le8t=gC1>-LI%({u`wV`a~+-tZ>G;s4mP4+NuTO zi-Pi#ev6`})Pc#K!3>MH9)BddeE-(k~TJnItnNA|}{5Lb79$CV(?CVBqYu!pqkI9Y23Ho<8d^Yiq;Ck zO${sJ&Y~yu)IK7Gh^4>SSn0yK5ptjSBg!a(Ecg2V8;+c$yrUb>peCrFg5OdaeW47H zM)8mE=`=uTSELP)P9{rt`OSjnIKXc35bbPXF?V=XNf};xU;G-FIKI zApK}2x=ThP!>6@~BJkd=R7F+zjkp`ywpkyR#Wh$Ix+@sKCPIsq{a9J5#=BmMtWje4 z4Zn^e;mQh8d2ay=-Gm9jeHMS%xP!GaNlxTn;ZQn93z@@c_QpqS`_sb_x}Yu-eq`Y& z)Rg4hdH(rJGggPs@_10V{}?pwA!`Xngs^%GZ!hsz?IO~=8&l4O2O%>b@w>xqJohYC z(4T#1f0{$h5p;`R`Oux_K9&S?#21w1!7rQNOF-XLf3)!D+2faefd+$71CGDxPyW%% z$>a`s6w(BWu`eWq!+6-Ukx>cXEFm_-2k1{bMiH@BDXTA1Nh18MM=3LeiwmDCgjFqA#(+VlLEQvT0R? zyH9;V7UGxbz011)6{7Xz>s8&*f&-&Z{eqBaW5M&y2WQJ^%mBCiWs`PPG`y!=%fb>D zR0li$8&Vo$NZg2Q`;3@e;&GyO_%>QMm&PdV{RP_>gUa7V=BSjciOr8npXCP)WF@Zh zYE@|6kqR!tCp&a7<;lZ!4OsX!~^aHY`oWk|FgKS$2n-SLA#3DowR)dP02LXpqB6@7D-F?8h|c zrxhde3A12hHmxssCsNOtaPz8ZAA3D{vXf!J_)VeyqSTtT=Z4kX8%k(L3C@>$L-Y-W zhO>T$`VYS0h{*h_rCP;=c|q7V7Os67F1d?C%)S>-v57Ozw`84#L7HnSbh^9_{z{&x z(90zowWF9rF>nA2j{mRKVK=WraaDVa&u{rI>Wfe&+(yv2Db!*_+VdHCS7WMvp z@J0?Q?GIQkOQXJ+$ju7gG$8;-o;Qmb$UmvvTY^FM<0JL@2(v^rfI<% z-DLd!$ukNfK-3TiGs~Jo3wKo5kq@ZTLZ_Xb1 zN4(&F-ln{D?8x48BdJHyLKt0TA7C+G_PM84PV7Y)(x8Y3?USj>!twJDd>r2yNH6uc zjeML^n7QVJL;gfYAB5AEQ zSuCyXnY726{&G==Y!IUyuY}EqBk0ZF$=?g($>u9-*OuCLuk167CX?aRiD;JgNSZY5 ze}s`Bc%!x4vZf!?^xvd32PP$+_W!%NKEIqe`N&R797e-Tvb!dhCSY|`JbO*+fZ$H~ zt3j9|OQ!xMmVeNED!6b@M0~=SOlp?Ko^+h`v^J%@pWoaOIP1vZkNxl3+K1V1Zz{h` zT5bMGyp3@5)X~OtD=Aq8CA1$N#nVCAH}i)qH?LKVp)^u1lokB4{-{casR8LP3Bd;uC8`c>G4h4JY=44m_Umy?4I+kZ$7-M7aJx8IJslDwoT zcBm-(Eg_HQdL3DAxeuAtT(4(!&LYGlnYN zKfD~qbRr~;4XZoc-uvz?ETEG`O25DtBX?(>GyKrNv_|LL{E$+>BTZI%P-L04D??L> zU1+)VTh!s<@rL}N3lu|6ac(%aLwin#@?`oDMJ0vadNlHh8=|LAh3QPTXSG=)O5W6| zlUG^qdEYhN8_rJow|1^1my>Em3fCW;%@&93rDqLCSSrt4mhZA`^DAZ~Fc9;jnbZp7 zKN9Z+R=y@+m^Q+8mRT<)=33^<1iN?p6S2!Wvw{DP|E7P(Kjd6{vePQ0R_m|xiRo>` zCE`4{5GPDTg@nn%#0on{BMd!ftS$>DF%Ys8c3il<2_I3*9yn9JWM-K_r%TGAn{~OQ z^0R9RD6?df&MPhYjLrbh8jO2pfoNO+GLSA>-c2S>2Y;@9f|V=_%d`EqO;&pmg`xn# zq2)&pG^-N`993QpEXdDh}=!7k3$W+CdFQ-^gVX&af2|4{6vu&Uf70Ro8!_5o6LtCUg{w%t1@CY7eCi2L>W{-|w^^ai zg8%hLm&h}np8~TDBwykq#~7dN?vibBq{uv8G1%U}jSc9+7gYcF^}A%Z z?5uk3mh_zYA55OS^~S5e+JwfM6H!ks82TM^8b>EiRx`tGjhN&ZFmvsezcSR`QMwHT*+_Y%s6tAnMCSukMmfMTzUV4u>9)L z94F2KnLB;={cg(?pQrEVYw*jBnRM~Me#E!oIr(?16~>_lG+i?k9OP>UayUzwx|@w)s%v}#3FH^m2F3%_D-($LA&6)-)i|Tyo zy}1|D`-Q~9R#EY>u6k~;)2t$huvz|}Wrex`O+*QQx!*{Bhc~AhI*w^k!cv90C2T@y z=Rfpn9t`gpe;~C4A85M+e8@k`x91M<3vrKg@7znwWP@kjbH#)}_4iHqX{R5Oi>0VI zN#VPNZ|J&3{sXM|5k}O`e#74jQ~2#RTgTHJw700U7LLy!&0c}T!BvFm&Mx;k{}16V zn3>_wH_H7gA=y<+(;CQ!dMoZ#xJDCwv7o!Bm0wX?rrVwm>%4L$m8|{>?be35{*{({ zkt~FbOODqf+3mb73O7A!@{p_dky1JeVr4bP{O$k4*k49f!9{DJuylu#g0!U4-Ca`B zAT83}EgecXNJ^K0q;z+8cXy}6UHkQ%@qNGUJ%1eP7<=utXRWp7eC9LXhb7o7=tns> z+Et$W(|jZOJKK{ZbMlgzb>DmJo&3A6n1G^3XaolLW)vDPO5KDj1gi4e zfg^tQ3{}q(z}l9?Qh9I|#RrHV=c1OZc-@j8kgT$?977D?1WaWXGtd|R_jaPCd+}N8 zujhrc>vmWN=tlfA4Qqf2kU7W3k_VvGx8{2JuibIo4hNZEqfPF~zi0MZNmp>XXLbI^ zkDq@s@_Oq#UWEnG-W`rDnFw4Y8>62$_wm74&u=5PrOn`J9)e1!f<(DYTwsB`&f}ZamQ!5sDiApW!^&V_ z(=(c_q(|viS^u7Xd65mdps)_PJZZ*8@Dby1Ly=k;()qYofq|l)br<;Rx~RFywo)k9 z6aNBvQ0KD}NL_K~Y{dn(ZeY;g+>d`HB&nWStIimwEom-VyWBr>olL)u;>l^8_CWmB z_b^&hy2{oMsS|CwFRt_MoIt{PA`GFM#W;Ng+_p*avxhn&QtD_t|5Dk`19lT?HOw2Y z%Q03*O)o}jrmO1QC{DPP8b(C9eYsbk6!OyN%|L1L&4atW+~zl8$ z8!;YjUiv@OprcT@DcQO|#Lagu1XijL5@dv~qTH{8XzNT$Y>;rY+CY^IfPJg1=wJdzFlp6B@2m_l;+zYu%rQN*-jzx^jG1QGr>&wf%b2 zu#(nhNE|kgJ_qlAIYY?#POv?=nSu1f(Z|r0tN$rekpBPWsuqvJ zvL&gx&GJ_IY)&F@soEeTY3HCy@fHKxjLsPQiDS`2>207kk%-?h-OF046_|I;SorJo zUPmaMYl;%{t}}7i?&rvr&w2FDj)~8r#O;gc{Ad0XJs?AiOXR>w{ylnG$QHCs4T7PM zk-9pS$h4O|n-3t}mm zXp$D`(;w{jp5PSBu*<)Xvipw>@x5PR2Jf$3&J<)wXD{0cKm;$(0Rpsg>r`J8Vwbu^ z21J>GvB*@FPz?S$Gqdh&ByRDeF+Y07$8+b&ir>gjR@u`1TKJc5$gW^Q!=1@O`A-De z-@G=s`_94NQ7|JpAP8;q3tTE8)e9HMAwW-b+KkrXyvVlXYESZG)v@BON1$)66-s1j z22XdMmQ>4OCB)(@k6a#gfW>Q4*h6#GcgOKrRT%H`IfL$fj{IV?;JD(*Pq&2>T@+T2 znTthv|L!n7KQ4#y9Zs03NgY3o1#kwN5fw8IY4Ct;{zA8jO=&Xs{rWLj=fdpn@T_iU zcKc}uP#jsIu`3}QY;Q#HT6e=^NLw9P_OXtb&_2c|3>?YG)#qA`)cHWg|AntRn4q!= zr-E0vBv2!X`n|mnRX3kK_eKl((bQk=es9e2dt~n5s0mlj^UC2b8!rn0Gq4|W=(JbD zpQDr>kXS~`g^QH0il8`J2E3Tzzhs^OWWztDWi6QFj{a_8waRHi@_b>miTI?P3W9Z{~oWs78i>03!%Nd=D}6@t;~DnqUNA8Xu+q9UaN*J$o&xt;Z^>! zr4) z9LT-R5X8veM!V0ujvp^lwRFK%jWF=0g^afLMU!o`@;5nWhcA(Rc&?iWZHy@yjJ^>~ z|5w&1pWYP3)$8SzeowAJYG3caxfFaqWb@U*8B9myT=_*7nFv7$Ku~O!%@-v3L4U~G z)17^vHN>jN-fq#`>~i~^ytOHf>LR|v_&Efgs#bq+TL~ogC=?}2-rznh1IEy2D~~Fl zu-G%1YK>0}su?%URB1{r;7F-no9X`|$9YY758X&gIL7B@WfUHWuslY+V@257AhqOo z-J}931G+I)H5Eh3fG@eBP@QGjhY-W8D!La;6ImnOeook%cDG{;(h{HDuW=vctQ4QW z|L+Rr3a(H9kFtiZJm-4Xuik8r#&<7?FY!z7EIM4*lH;u#TlQUk-{pgM0y;Z5VtgZZ z#E;v#3ukJtzpx&eL%eLts3}%c3E`p@Ueli@L2SeSh0sff&5ASr(zO!TgR?Re=Z!D1;eUx$*Nce5+ z^`#}crEHOZJ%j>&PN`mhgSRhxFV1pB_w(&DH@X=)LX|j%{!n;?%DbsN&UckQtOzaX z+LiXxp&A876jq-;O*;0wC=t@TM$eWw^lHf*giGS$snx;-ac~{Mdz@D~3+|*kOrtmY zlmS}YJiDw@9VNZ=_y?;$QGB8Qi;MY}%+==mRO6^pfxB^v&B0ULppmpH$w6=es9uMt zIf@~CG6xk$fI*CvgW5u~>nag28t>P8o}$de{(PtL^*5iKu!2CyaloTb0TRL2{Z^{7 z>5(u5woN(M@4|Bff-8Ywt$t_q%C_xzW=J;0c|uBN=J z)*hs7v2>F>iV9jglBXAD!g}i>U*75t5|b(4W_X}_2fhpty`GkeG(~-GYZ5+l zfAhQgw*NcL5Q+aiugSb9ACP|vF(K}j|2Ws-m79l6aWRi4GC9;2FZY-HY7tCrHQQBG zmGXD9Sq2v&=Fh||6?O#VHf&MGeTA0p_=y8@&$BaSMshI8mJcH$D?@?{kDg&DG3tP( z{$aWMdVdZ8A5-KI7dgM5iAo|xIakFb%%}D3VIK?lOI+zR)u1Z?NFBV0NJqA<9>B{V zpnmb3iS;5(i%p#DjtxVSAR=@}-`V&^oz7+WGvGq&0=lt1LQWnR{dKTOhL>{(l7)Ps zLs=haPp{0ooX}fprcqh&P`?)Zv-7s*?N>w8N+j1W%E&908u>=rQtlF(Uj`s>14CIb zv}JFiEB)cEphF*T28K@GgRgJfdE_aHgB+oplKR4%HkTMq_1@2sHln6jcb0geRdoO% z#~!Nk1rddDLGs-6b=!*Qgvt)esqvnVi`8xQIcB}Q&PE%j=EE~UNt*7aqhayvO{g{2 zo|2-}-5ki-xGQJtwF!PkO?2l_u8rb2a_B!Fj%6pOZjB{U-W3UMq)*FsFI0od*ci72kZ?7K03|amM5J(#|fz5s?h1<0M||a*O5}XwpBOE}tzY_!)i%LLypQL^eQ)+l{F>|Ni zIe|pMPA2fJwR0ZJON090c5KDoTOrN5Epdsd&<^qF7+kc6>i0QY?!uoYAEp(@T@9|F z_@_lT8QfPfwLaik%9*4;kEApxRp|6@3jB5{pNYlKg@C=K!NExO+vTtCT1O8p*;ta|GsopN#+ZKrAql`kw|b}yct)}3FYWp zG}7~i8Jc<~IK^&EB7`}xxP^EL3)M-q&uj~47X8*JcPOLDDwC5$$1h=^GtL^Hb&H4{060A!XzFc?02V z2;dfta9VBn?>2W#ljnV!3-oYt&p`e`-{X)*v^o6?i&5s&9Ov;1`uM7fI2NDW{(g^N zId0U=lzI!wGrsGgSWPw}dx15SsA_m=$~Jfk+wDFTZT!sdnS#S$8m$#_F56%to&YSb zTw(f4dK?9}=BhWzENUCR)Q2g<3+bnE6FGswGz7l6owS(a{RKJBrAaQwz8UdYD~Eup zjUk-*j{*T4W*rM>j8?V$?B2Co2Y-iRFLaEW+*-jlXH;DlZhkm^;7vexoe9!=htbC< z0eccaw6YMxo{-ByricLF0)x(#$qfY^<`vtc=QVIWlo+F|v-RtZ4ETDdsfDYi|LP$F zNHT_XLAeAMvzT6!?HJa|e9$H76A>(CdYgt!~ltD*kUVpB0pW%6xALytQJn+M_p&a$p`Gk8tT~g zx-i%Duc(oX8p@?>6Gzt(NMff1HKBbQuerh2LSCuYr-DC~JT=a6L+D5)Ww~S!dRhCy{iRa<{VyX5H;Yk`WA|WD49mqG>HX{l=Qhm> zIXVaUwNmjdUu7#N`gY&t*tIwYB{8=DrNIy^h(!Ly^Qoom>mo`hcG2 z_#OrCYM8>!Ijq!~k2hF7GO?`qxaOq#ZfIOvYhjtw(Sw7v7wMY7^M#kwFWRv^OGn+v z=J)g-6&(lajRQSClFvHTt`BQd8(RlO4M!eU0_GMLs4EgDQSj284<UQ@-D#02X zgZv2rZLVkD{Y~uhOqWLKE(;IC;@Y8N%JNHlvWc+kVS-49l7{&y-U z5C!0OaxGLZXVXhB-(&SSM`Vvq`x+v2=w$GWO4_mX-+x-A^MYTp?s>!3djAGNG^10R zK1;ffkKU+$T2ge=x^G^=lJ-;r&+@V@rD6U{!zJ%dpBd*!VQP{8#F+M401S<)^9OV@ z*97HJE|~gO z4Erjd=kMZQ)upWG;!J-A9a%P5$jjEc6ZwxvUfXfC=*o5OqWjh!pKsdLLIz_e^G>AF z1>7+_d#0Q?zWYu7%s915{I$@ZAi%VF8jGh1i$4}P%DI!)PORiC!joH!z6I0WU?KNS zV8+-V_s1T^UrHOkU<3VrPc~GC3&tjFbhFVHhFJ396X{kcF6|hVAGePw(~?q|YSuC< zk%CcN*s+=unc{fX%H0RFmMh36zcu>@J0>QBOE@Y_kN z&EuM%!={CJhS(CL0`hy45oMD( z>Fb(iyf;W*QReAl!owR$(&3zq{+642l%~&;g7;&G=L3v40-PsF%9$3p(L7FLIcXG8 z&+eRpPGimNuzOfE``<_#*BMLb4#Z;qBv4jluyagy~=7<)tQe3db9WZMJ(M&sqmZ z^Kj88^`?E*p{8E^@WW3%DJJaCQXW>Gn^S8;Q>{`<%c`8zskS08`O}OEtfU#hI!jRzIu58fHhkqXh>ezY0o+*?lVC)qI$4P%|61%7sf<3JM(z< zgFi5{EGKI%D9#5b&|kXy{(g?!RbJcOGvRb*;3;c-9kmr2YPVA4R^sUxIB~1J3E`4MDOCqjOFce?!qUo z-z{X3N2yTscGbe)ZK5-JKXY)*UNu@7hR7L;BJ7-!Z(gBDiPu(*(JR%=j924Zur&}% zV(9CH9Lt;^jyCqFg+)*x>H6Z${z?C!{j(>?*y6@~!X>A)*&W0AEr*@Hj1;9STKXJl z5S%vpJx2U%g9yKTXX7w7NA&B(aAnUf)|OHP^_APqgXTg3gYsXOSJ^+T?DBE*3qvR)H+*#T)wmr|M$RZ>)10IXX|~Y`?)wTQ zMB*WQM3(xcb~{8?6--bWh-$V2>j}KENsBx2_lPjGdWX~@g2)p=4;^4CI1lu|ucxF2gky=mmcrE_dR>(uoo zx{|3juKg*yOP@Z|VwhM4vwUWz4@R8r7eHu)DQsnn`Wm61d<4P?J13)i9s`fCibK4b zp>tW&Hg=Hi+AY+m{>G5X*BSaXTuxSAoO&BZ6bB zmgLGAL5vNe)%P&{wt;mtBX3={zNTTOo2msZl|>`oJLJ=k)r!3F|QANM|%qHqTodZ8eIQGjH&izFGGXAP{M8 z;_}cr@Jq-mw7C7e+H%LY9Xt2rZPD7Z;Oe%B!X8asYpmP^Z@Mlj}hvwaTH)RD^ z*p3TGgN=JDp^HVOG-GY43gPnK%muvi_S^raHSw>PjNr>$s=P5T85_DZTbzxLDA%ra|-ebnmEJ$xeg*kC~gOnXRPwy05*TN*b?@C^fYVT|_xQ zTelr|^F>+*(3@AjazJ9i(IT&a@>Cclz{Nf&OsY8+4gz``EhXq>f>0zy((= zoJBWY%B$tR8K;2aZl!5`5h|Tpp=<6S5$ioiG_ISmvE<5(dC}$CW2{Mv;#T{f0>^f` zRcO=$?R`Xc1a06YN<9(6kQ~x?Kn?ok8nmC*>(mUJvIL6Gi>o%KlERDVD%g%v&l;sh zTx0W%k(5u^I3s)X8XNM>Yl)-6l7w5Rbdd4KoF#zS zlCr%N>u2HGV&U3>aTIc@m)3WH0d0aO>Kk?qgw(*JheQlzJwr}xVO8%)tO{Cbs5sQT z1OG}64~DEPpZB_W*@4{P;n<}mlpaC5F4 zNfu(J?l^fVf9H3oi1a&4!A8L}Z^m&coSxBx9d$e-nmC%0I+NP-qDsrd)}o027L*cu zGV7HrCoyD6lAYlCUYR;5;v>52VQ(K)^RfrCC85;+k`z=_=7cX%{?Qsl$*dwV!9^*LM!JwR|7Y+7e7}?(;4+iw?px4 zU$*o!W1g43aZ$9tW5T>__B6~ROV0w@L|8JX3t747ej#smoMJ+heG-=L(x7wI!&87F zdgg_SkLbo9q=<-bZt%jxpPz=xiE-bts%nJwkc@!vjF;(S5RfxV;}io9`rbS~eF;X; zA4pr8R;{(wo618DKG2MA91!-s>JC5Y92(PPV@KeoZmtD%l2Tc+qFjRJDCZgox6zZ3 zSZHi_YuugfI84izGz=b{3MfL_Kf;m}L`g3!7=Zjwf~O(us?LDcVgyp$cui=J!L{ns z{qa5vuc<%}F1nZw-p{%?ilnlq+ag-+MZ!#0X;$afv5BwZcu z@f@qTT_e=GeSI@;?7~EaqJw=i7x+BIj}5@?2!mQ^_^nW3pJhEBvTssCeOGITx?HMi ze&8n&kOYdlv+r@avtvS5hZ)1^f`M^p1IufV62z-@3yqo?1;|&`XJ&sxe-LXRx)d1m z)jPLFSYo()!SMQ4*hYp!AL_V(3G;!qXbn+c?F~$u%{zhCu_n2;*2!C7$|)jhW4#py z`sRN6bKTUdY4GrV82QY@1Iq)M6GkL$09NnF7GZ}-!+`)CFU5byG?xKL>R_GK+@c3a ziudcfg?=U)kQBspeSPck5x)Z9UV+vB?)`@&ano^Y>m;l&0uKG8b@2R->I5cdfp_yjp#a1MlaZVEzYsma<3a zbRh;q-$xJ`RW>{l_yBSR3TbzcZy}Q3?=`_yBvc>Y)s9SmBcQ`Qmay?#15_S@XMDJT zD`2y_7>SA#+Xke&&KI^s^j$nOrld?vupk@+>ofMl!=D2YB?OoC65*fz(`l6?+?n+` ze$o%pqz4}aXo+uNX+?CI7e-8&j^>!Jym7%&1&CIPrqay7A#z|i?aKYFspVg!EIww| z%1OAg)hgj5K4})Ng$;*6q)tJS`ND?w-`bZ-QARK7<{*pDT0Tg4`1%R}u^js6_Ewq# zu`sy9s%1ZBW>4Yw?1~Gb!ZzJ>C~p$r0lD|E6Bnb)jV=^L+FshEgY}cCowI>>-BDp% ze)UK`;Na8zk6tNNUKyzoLu}@qVCGm`ZYMAqCG>?&A9S9y#i)_o4q-_LVG9)=C9r&? zqds(r8Y=8kO%}BP#HO^20wkPb+l5X?a)Nky8uY>H^sXOdnxj+Jf23@tp<!Z}m!n)>!e=5a!ff|Q7J({gAanRlejMZ4j?nYGIW-@|-;(SU5`d}3T*;wKS; zFW3&6FK`w4A9oVzB+@yGgc!|J(zjG!-=Pj5o9#88PjtYd&A5-VHc^00x?v@#N)Dtr@qB;W5Z82-YSZvq-?7wU5Qx)H5R9QL9 zFjpGrDkMYFTibU37BL+Vm$KRjmD&ya}VTM&^410xL%9V$gE5{Urc%!!w1-LL##IaYQ0<7Jva zluKx&s1J*eSWnbODvKD9S&M|`>{tzcn|BfTZK$Yk!7oV=lk-GGz3l#HJWbLREb>SY z%Ty*<*gZJc2l8?2Ht&yuPm_1MJhwoDp57Q9-z>7QG%!t7; zXJW&lD8Xj=;ouy0`~4<0e@jD`^)}>tMpmXD&ieu>SY9gJlHZ-naKgWRn%-r#`8DAk zy0<)9aSgcb93M9rT{mexUGUvBYvn!dq$XGH45rp~ejTH7D+K zT|9$(idJNC6Z1>V=T0$YHzZ$k*iM_N+udK71^%szx4W-cq-Mxax{?W@9S9M(r(4WV zxG*tEBC<2Kb!Eo(7HLW4|B6f6*{U#X2nk&ZM0{1E$9svn#IXLe;pUKT)o42)dk*{h zk^To6X}wiY;%668q04DB!Q6CCuxGcMmQO98z@8y8mBaF_JBvmgpU5$+E~0=4gQq=r zQzR1)NV=)DNS1Sh(;JmHLtOSULM&gB5bg( zuv0J{s~uPu>qMX3h7uwRcUGygoLZF-OiXAIAw)zdGE&$8pa1uN=m#Jkf`kf1iPHt$ z0O`^j*4+R5XN3^KU>5kjgwr|Pi-f*-+5g)&{Ia<*9U;eK@QV4Mn9twQKxf*qx-dCCB{~(wD`ATDdAMlZedDL+SsB%i# z4;;3@IbcpmRc&w)LoiInhO%vPb{#KuxI*AVBH+i+iaNhzVm6f_n&M#LK#f_caK+EP zf)%roc`&qU-&DdgM5@F;s zs>I%rlM1BTtV9-WWlb<&P1_#O@eo+A6d0cYf9UB^;l7Ua*{$&oQ*G};3|VIA7Eu?; zqy<)y7ed>NX&UKs`-|WC11&7-KXaSDxW|D;_pL*NE#0ffhV~a0^5jY?{U}Zc99zvN zTfO=vCec*ThnLhoKD%DfX6v$b2uFl^}<>2*q!;Igw0Ms567tEbantf%A#(ho4Q0JF+b|D-WemkhjNveCqkAp(gza%@^8<-X(aDtks+dv-REOBW&vhGJrN&k9kS~ z_`pmId*d=;ptEYxS84YSK?og8hlOoL21fD=(-MbW6Lz~>l0`}(A#SRi0ddfZbk{F_ z9ND)S1kmfilJoFyKD%sGKQ4x39NAWyGYkjBPaF=f&T2Isd7lK{D5Hqk81B%Qv&4jI(Jm||kaH&1Q~;W!zP0CD|I47*R5~Ux*li9> z)ZZ8?)MTUr*l1x;P-A=e?q;`6*hFY8kt!XoK*}2ig{f-bdz_s#ir*eZ;i4h>G9a2Z z9{Z&OwHpHw|5(eN70E>WXK>;wnI@IsD`46Vd9`1lz5-_yX@ht?GH`8p5F&7(v$EC7 zX~(2M+=#5&FxIsiI~qjN?;65u`h{(6rTqO5dp(+`lyr|E+OPtKgQ1#el9LKu`5}f1(C5k7wvR8Cgu`)v0$Dq;n>2Y zhsMzX77%jAF7U7N5T9GCml#V(z8wG5XDv$kfz=Hn3)yDTsa8c0?A{pF4wa5)P0TsD zF{0rTT|pPK5Yd2@eVxOKRDq4xydrK23-j5fXUXihRs&Kto?0?Lgr^|=y0D7=@hn#8 zpOoMBs)dLAx9izkT0t^QaAq5zV#iCa0MGs_;YxfL8nHb#V!riEM(U1783qjR2;al1 z(FwOHy!J%pA{<-+D$l$!2?h~Br1QN0M1O?wPtK2HG4{mFkRw}SQMKqk;3X!B{2vGE zNw%@Q03HXJ6mp(3sMI44e ziLA#DFWGe*d9sEHY*oc2VUFLZ((?dG??%ye;E)18f$F6rmlV285dDcl1_IQX0tiq- zh*c86QwVq{v7x#D#r})ZnLx}x_>fqKSF5cqqR$0)-@OLy z_ASKtS}=BIp~sHiczA8hzjt5YI#fLe|Nk7;f-&WHMoRjXP(iOSuS5Kw8g0!K*%yQ$ z24YD%N%sjc4p_+hKnX_p0H0k)p)}_8qL2uQMYke%L*R$uWXgU}VBl0UoY~9IlJ#JO9u4O63T?b5TRq9xSw(ng-u3@J2yzs4g#Sg8Sxc zV@+tpI`F_CaKL)qdgTz5g4o|cjK#l)0Ro=)EZxo?II)tyk`xDa2!s1#YV$|A?*EB* zXX8cY%l}>L+yj&}QGBO?K(s{j1Kx=Nmk}wa){fgXZBHxC`voqD&FHWA@u9$B_|kDa zpoqpj<)cXv?K_D1+4rihhJh$O^ygyg(iF0135zHQ|5(}s_(SgL>Ev19FBqIT6eFX( z{%Q#qBkJ~m-jkwkU$w0MwDj;l4x);hnuI2*M@mMwzKVi_bmb>7EFvkl2lH#)fDXf5 zL(AU=r?Y-yec9&@lBcNGW6VW16@64jidUX6n7baNx1eJrK?n@RzQ~A$^rrXarC9&4 ztlLVc##43tsk8b3z=E-3Z?^QVD-x{&Y-cJoWucooM4wMFoYRhG;CL6oV_7|=rb)D)U~^{4V1%w>8r&MU z=lGhu<+h8_o*S9Knr@&~^wgK0Y0)^vil9$vGV%_aSP0&NyocT*#Tz5zGFi~**Y}9| zb#XlkR!sa8Flr|BuzpxjP&aw-jl2ex}|h;yZJEOl0u;V7s? z36G5Fi~GAGn^+SaCo;KyrA0ULQO;-lBCD-^1|Ig5g+fuhy7|i&iS?7Y1bdq$N8qX# z)LL{q)NgUW5V*po$1bjQwm{D0C}6%&TH%<@ECs1i$`S*5vBYY_wY!$5gBGet_sMJ) z@#pr?Q0r!3Y19x!#724@8lsfl0LH0JC=6Gj3Xqv*;Je|3K*7!d){*6|lUiVn#Kb82 z+6M-`7c~@xacKyW#@;ky^w2yH;%sc=2lLW^we*n%zlmAgq~eTbD)$-eUc6+-d^imj z9NeWo^!`)_+KMR^T-&i?z`*(9sxci?Jl_lNrycK@9sUzH6cnCP*RFR|7@n&zu?@>t zrPA?!e`My~KX4tCRL1P^?Qr)2-7YnH;cpx}Wc+;#pzV*HoZNKvOtAN>9gLo9D1DVc z;IJL)s<(iFEu9Z^!^%S5x`C#uDB1WuB$t^8l$`Zr;U9X=Y`p(2^ntS9AL}Py3=F}C z)6IV>3tcZ<1m3-9CYBD%6yl>*TqYWBbyM z?^Q@ppzvQLk7(nMNIL)z5_AIsPhDJv=cE~ertH^Rxu4zyZX(@W&`!=u{RV&^=hoZn zLmzZ6v+yW^gUQ5N=p1~S^Xn>d9Q23KSXGE?;=7mH2EKa>N?j(jBZ_4Za=5;wldm_j zzn?)FfLBY(=qmhf0f7i-stidtj2jR`A;ds%qX+lM$y)$bD{JjktQ8;O(#v;w0cp;1 zQWaK{yw>2rEt7E_^PhE8QHw~w@oz2KO`E4^fe_AVih?0uJ%@yY-AK5VZ(J7b=8}Ar zYOVFjhQLJV^74Yp;#8spv}gY7-;r|if{&MnQ{Im=-jp*yNA0G$H>bTz$Ii8|Zt!=y z7oM~#)q0oWwK|t5qkUS-=Lxbk>>GaUAvV0-b46YER$EHgRXrr$o_^NZ-(6PYEwncX zlEY9|nDYfdH|q%Mw%UkM%O=zb%MShtgA8lnjp)zXq>V3HI#OEhDbPd(Xh)d4q2BHD zY|+Ki3*z~>%B9A?7l@8+gG;!9`ks@$Is&aGnlKAOg=D|}1z{{L)p1;U&c%J{e6GNE z&>^v5(TGf1{cFedgqlms$Cpcpz66M!o7n_iR<3c1_&I_=lW)Ng_g!cWd?eYu=dsAI zj%iA9zPr*2?&I|sZ=E%=g$j^!768S~jCfnrLpxrx?b5|*8*P4S3@um34!+1OO$jn; zmS@h;o?$U^WVrhbNL~RR9ZK%qO#cK9Gk|9q!9FKL17R)>j%MTIhj=*WyKFXw`NFwe zO94`ni=>_}K~)tM%p#2--hKegS+!1zoty`x$wU4Ex0nQyciPkeBqlUtO!xD{n-zT4 zfU?X)!enI7p{N~4Q5?CDTsetLm4NT%(({p z28weGh$Ihc$1`vcsmABJJd&0pyXSA?8=a*a8On3XyJlO(Ca}yjALyL)<0(7GSBCZ* zL!qKd0c4O+N(d+O1z^h z^I-@O5{3PIuGo>q`SyMlZM>vc%+0KUPEjcxkofn>^Bz^bn62AMPvJW>z|gv-5n*=g zAY5jOyy;^6%Dez&g>lOz$^Gpwe3-#kRpx$awTn-P;p_MWvoFI_jMP&9E}7GCuAD`< zyg%gVNFyb&(tT;(Afh>Cd6dnEii^*W&4KPa3nQ%foZYzuI?G~79##?hEOak^1a=dH zZlu1Jhk=&Ok@``F4~4;iy9|Yw1rqQ~8s2LRuJOYyuH)ABqM9w^FXvhkoC0z>j=RX` z+sHJ_cqw^wf?fp8neZQIy0Mw=fTHa%?lW_w+v{MW$=aqPtBXJ4 z4r2@rhcRw&J}nx)hZA^1l5WO(aCc4M_Ar8ntVUZ5>7q1YNm4i|GefW^WU%wfv{{?r z;oF+1u8WY9G$8u1Dn1V>$!TV22n;Uu{{C}}ZnQnB5ow2RgCRgVqYG#y6(D?taCI<; zO$H8CMbc?F z>WHquR-;E;3TFH{r6$N|V33|RS`a^~*}TG2r-E$}p<<)T)b<1b$^^o2W(mRb=tx-& zH;Gdcc|^jJs=J3B!HlMcZT7O{x(8#)!azvlOS16dG33BvpxJoXHxWRt1Fd^YmAjjf z8ae0lF45{8`o?s6yzo(Qn7jmC@8tP0V3!E<0F_wNq{{cTnLJD zuNL{vK7M(8AcoR+VO#{9Vs$4D*Ir(jpqj8 zMP1-S<6?Ic-1!wRT(ZT9+lYtpj=Ujkt({L-WFzZLc1~rN_My_3r+wDWJc|8!c*gNH zwDn<^X4XVaeLmr44$G+IXv$d~Nqtl|(2SGVpnuhEx%)yCG1TOJfW71&pPqG`$L`GR zEYB;;YQ#(769bfCSvHjgUsIN%sUOM2j5vD!NN`8yMSk}4@6Oxv!Ue~XRTY-dQyV>>ObGl)xC=?z+g%|v?>vs6s zPiC@3b}?eqABQ3ATcW0;*IT>w-mst1Vb=mQwmHJ3@zl?1lviLo7^(&&TVAgUp#}2x ze`8v8@*z@yZQ-qyncLi=cF=yA9oH?i(-ACi`SWnlCEbl8{kA)sZR8-y6VZ<*^=84Q zMYgZn^2R9S&rbB{tc9JXk1tDi$+F!voj2^TS}oC_?p!!? zN*(Pc#rSRH)W^MuvxvHU8YxAcfDex*%0DNJ=&z3rUyuAOJQZb5JvoiA1IS61f%yp+ z(}(H`=}5l?K6qEn?{{Hc%BP}=h-S;{w{>shDEcPCrVQM*0@imZ2Pz|1W*sMS8Rxfk ziYnfPH=~Cm7;Wg#xVRFW{`t*>0Ruy}XmGR{<=b?z zpOQk{2rZxw?&staC)E-`c+D82kc;yn@-NzK-WDc&_x5)SH4D}$j`1?I69ceo>&(k8 zNL3@a0nrM{i%Yp-%sE8JO;cS(mZ_*l9eMSb{U@=@07QJ&9VjIG^m8jr#;RFV3UU?f ze{HpCt|xGXBuaEgE}QK^w)!$;$VT8K%L2E*vUQPz8>f%>Z ztYjY%d{r+L(|E23sMA)nf*=&I77ty>g(BWopp$#>X&fWA`f{V5<-l=j{?q;k4|>(j zvRwG}YDb~I^?cr_3(s*?wmXN6*LD*Z=jX0_==+CG`{;b$3CLu*PEv4Ne7gJl>?1r& z(FuYrLsr(6313~ePaedJP6sw}B|6)A?r-alF?^F8J;CIW(%evrisq(1IqQl9`Sd`X z;HU8=O>VTD4>#|1@#f{!S<9C8)oT0C8_&XR8WZU5PzJ8q=?h6zcBSR=cvZ$&-%w+D;Jmk)tI-@MEk2`Xq zKKCFhHg9pEQ;%p)uln9(?{V>?s!hhz%Jbt2-ZtGf>j3YAk#Fxrt`Rp0PQ;LSqDr*f?dD5Kuqf;9ZWZ;ECLMjccWW`O&wS zA$@{X>1S0#E{J9gyB9RI#oB1NRD{@%KbE8G=@3B*v~#<*h$o;i$sJcaWI1pJ*d0pz zSU9GsPb=MBfpE2ZX#a<@0x}Mtwaq?+5BvQkifJ8@zai7)*qV?UWGAnEuVXVF-m=))sYj;dRq z_LuGHbtscxmkhj+ckwRCEyZD_tbMK9{%3Elh`TJ?mdr+^o`N!iaC|DopyENm$spt1 zkk|cWrBFI?*B8yx2V%M<#nJ2+evEfABc*yY#U*k^MtgT%h_Zq5jMiiK#kK-8tSm9- z6eM?2@?{diIVRBow8F!Tis`Y-k&k(vJKSVf_E8f|C_(~&tbg0>ljbwt#rpHI?RV5| zm@AR#Y+V5eukG*SWQCa?Crh5J2&+@_G!mI8E#SE;r>FPiF=LASfMPK`! zj7<8A>Rz)1+U+9?M#}IeA6PM?^A))Xh&A4M$wD3=rz;w3(G3m9@!|iufXlE z5_HI$-=3Q+?x5iua>FYbc4vUyCoTUVP^6sEyn(uG#JPiDXH9Zk;@O(J0UEFm2CwG9 zprYiA#LbOar=qIC#e#V^@j^x3IlCUBqpS84_2%>VLs>22pkqQj^7@pj*b0YBE{{=> zdOGU69`A>q!Rk<#Le;JB3k_+lzY^*^s`;)Ocwj%*fAA6LWn@P*I+k+*iI(=D9OV1O zUyLu6;H>P!Ewr<-j_f4{!B-^4BarZ~At}&o;_UD0WUti(SB~2WE+*L6)|s1xuAO7M zZDg;?6T81yLOba*tG5 zMwGj**%V0)k9&a;wL`jYiRp!-sX6abDtA;%&CJTqP|)^r;+wiR zL@(i8XSFddtmhuKcEro0-i=_6-QR%2wFp;K4+2kjK7>9?$|!YdI>4cF1LTG2BfOk{ z+R!Rkf7nH)F#PFVG`DM}JXee!&^}Si7%aXGyh%6dH%+e>+@e*GF2EyWPcUX^9>s+5?+z4Q2O7{t-p}6AfQMCS-Y{izOLV z`qz;u)NopDUA1K@jRob3!-(6kL&eOK6k+IzSyN%E7syMkRP;6DHN6>rNm%IXu{N7V zm-r*~r2kJ>G}(4KrutGUTqLjP&;|Eo8pD0oLe>Xnm)y|o81hGGLqxT%2GQ;}_jQLK44=>ER)S8?<6_i=@z zxsSV6uS*BIrSIcws>T9IEw06F2Ig~bHYD_M9zBKlVtiBd4=Hzd8v)WRbIhs3Pi0x}~5aTfTGva~%7!F-!! z()%2ItPg>)Uh(!5GnM-rF)Y~k;`&oCP&<+i#wE1g%&U34WUO%UuLBoGOF5-dUS%QH zMahf$JEl}L3C|N!e(%2#agG-LEvjHLFzNwF0W#=&X+nFr!@>OG4>6@# zvYA&3p6gg{DyZG5i4iPGt2^-(7aHI2hMiO$6+B63PBcf{)t*d~UnyM3p{wqMLY^I@ ze9t+>(Usz|;%1qmyV2$U4|``7l~uI8eL;{erIA*;yVF+`1wo`+8tHBY1eBLjx>H(O zy1Tnmq`SMmwe_6)|MfS{tz)>^@7i7t8dhbs54W+^;nC%_N{q3 zC%G2hM(1p`Z?pr~N?^)$%??U+l<0NJi<%}0`Lfn~-44|879}r-iR#p+E)(exJ&$m* z75#&M7#;fEt?Ha=zl+kfsH%Q(wr2F*?CocbF?uMDHa`LcrU@7F1nlw)@%8h0xdPT;PU4y8uLQ5AC%8VLuZS?MG|LVy`o}&gxJib z6#X47ZvyVKurXv%=y}aEx&ILnfVfwfAn_f#e~S%eMmv29qI<(;_{@6*!I<_P`=1_wl96 z;zJTceS4LIwiY zuWCqMvAK4=Qc=zutBC<=Wp6r{q5fmc8NW6@*v0#M9@_?#HT_qC?0F1{q6W7pSH!8T zql%S zU3Uld{5PE^3{ppY?Y%uZrzKmp7Li@e8?M{x+Fgz88ABq;lB6fP7S&kHs;UhV)kJmc zu$P-jVm*k}-q>n`76@?$N$vM6o7O3%?TD)IX`k5Tcl}z%*_k`eS$@Htl^AJo;$clM1Z!RR2CTkawW?@VO^852h74vReeoSqDD*Rs0^_5(7 z!^VE#ng%s8ooCzraC^-`>RYDYDAONZfBXaK2mSr9JKPe1)A*#Z*lpkw55`pSN~;Jh zr{Py3W~VsGmNB~j8zf*1n7L-~I_f;1@y2e)Vs7DR!^7$KaMo?bMeFe59~}2Zd+}l(CawlERW=&Y!0Gbqo;B&! zp3S?P*byFK$>LHfNR=KH_I~Q|LC0TZDD-SJKo!0f`FMHeq|LLZ{KI>p9u(}@DjOF7 znd;Ck=ndl?=y})~m>P79+5be;c|Nd@P*Zp}+-Wt(w zzYdNYi96K%HC2{(xs?WBNMw80c*r6ZOL*l|#_=BC5Ui%Z zSsAGMCV<+S>0FC03JOWROeQrFmMqz?&gzXEBXnB#%)_ul8TXSEH$9{;%Zrb?LoQRS z;?^Xot-i=r=oGKex}OWwpn-Yd95tUqs;ijo3QntsB6_rhKd?VV?%zp zg*a}sx_)M~pfva?DcQHD{U@Eht-4q7%BIj^TUn0uPk6Az!u5l`adie#--W=U9ARC8 zAJAo&$h-a`+e%c0z}n%#1}<^`j-d=vH>a4t2ZsS7C2aLHCiGWsDOVkCQEy*Sq#q6D zkGb%qoYn#<~l@XS( zWJ!X|=c(2rtr;+<1dU8ytF8oWX$Ji6Y2M zeM5qPU5xpa>}6KZWq9@6QPNqjQDW|SrzWwxdJ0jfdHTNF$3pEY6 z8wI8aUEp@i%D=TfCpKVeN9a#rLvPK~;CUO7xv9Q=P>`Kp?Q$U)>(TfdDsvL8{igQu z^4$5L8&71wWj6SN{Lc(qr75J z$*n1!H4j?wm{FhT;^#*t_7twVD?gi#WR>1LO9&MQN(vNzWa zGIK9678GSd#!#IZ6#14)ou5*&X&s(mXv0-q84foxy+nE3Fb)cY<^4C})}>yM#m_fi zu6xCy=KFkPXj$DU*$bmvm=zNrNtV1TUNLVsDNJWOYUGmZR>-@QNU`=R-E-L7Z5V4Q zcUY-VFd1^FN8bX8l|dvZj9zN1;5mZ~9RAIOUaU6N3RtN&@4_U^R-ZXt88#86aII&{yi$6>D zhTQaRYfmt56FI#RihOS0zbpOVq>h2n&V@ zWjxn>V}9plJq26CGbJ9!UZnpC#Dfyff;_Q8oGPJ+#JF|gOi6Ncm<7`1DnFt2G~Sa= zzEIa*1N8X8$c5L|GOM2bs(z6ZEmL6mqr}4cElHM9=N%PlGFyC*szbn`bJTPTisk(9 z_T_GQf!Wt32H^_7W)1u+ZksO8R`zJEa^2c`Vf8tt zYHI~ag@5Lvj&;7BWsA^&f-~H*Vy;|is`9+-s4Xz)L&PfyDq}xhD{Zudz7S1?1Gxts z`FAHx0X_FvFC|*WSTH`v=n71HD^0H}+B`b8TIqJdmW)LvBi<%ns+hIwS!PnLlJ)5b z6`ozhR(I0ZXh+0+&oIuq4f3Y3?$7`5VR60ShvkdhzS}6PZM!>r;L9qEg9fG0%hQR^ z`g?_m9nlu6@?dNC?4BVX;oHlP+&k^TmvlVj@e}9DOkCI`lGR@?)}9H%yA^RG6x#)C zCda^>pi*?9T;J%sFc}IxD`ONbMF!HnYbgQ4X?l@GG(UfK8;@mL%Gdm4l`InEevy8KJg{0|OJS$iZMZO?*jxDs1^e1N| z%(SG9_IJgfyAsSY^(HlwqG+e>fCzA{1-5*+g3X>5{iJ!Qebw;y-2 ztDdmrN-IuH0PEi)>*a#C7U!kmxu1j6N={hV5Q|X|_t?VX(w_Xb_{prjAsa~$kU2ff z=Fi&D=?x=iC<=5+zPOy~c9`vRW}IPOFg1+*{d?&mk>O9g>~Kt54@l**r_{na4Q22R z>=i$)HT%JcQ+M)3&VA>;4Vo+N*BVl0MtuDsjXBMLHf3hiTrkiwfS{vD5pq96zZkzD ze1<8aPEYrjUhBl0iN6`S=%I%g44}oP4<-_31#xoAy`OG^-8FMhZbWx&LoEV$Hd1QV zKquKLwoQ)Y>N7p-2joi?MmwlSry>LWFZ+j{#FYGE&~^Gsn^kPj8TF8!j@-|(>`KUm zlW&mkhzZ}#yr}kE^zQnov@KqXOkO(#oslfMYe9C5y!xO5TrDRDS!1-AZ+0Y%G^4+YT+zJ;l zG*pR_J*;!xjt>dXI9ZUHmD?JjbiUH-i<{F$>9F5g!#lPxp0 zO4ofrVUSz@Ca(3TdBZ#!f;0$~DacfPbMZAZ$?f1_&FSJxHNfUc&`5gr0Y42u8z=%v&_xbc!g!_8s~6g8%5`68z=tC zS+Ed~9Wy7s^cSSuQLi2Sd8(1i(3zG|Kz&$7pXl&5hNaWJ&o-+sAa5Y{QN-$$KX)Env5Z<6z~+Q@jKq3 zb}r2UWtaM^x#of!P;ymYinC4B-R)@xr@nR(&rK(uZ~b-wrr!KI*Q{cmJ;hM=U~ zL*3s5Z&baKUOJN%{*Ya77Ksx%u5|?Bufnj3sFmpIrS9oAt*!*KrfJOxcE<|NrlZ^+ zmPcgaA>G}DzN+S7{T&b5<8eIKrH!V3CW5+vpj<|KB<7vNqUJ42>!?XgC> z=hY&+B^OC$+RGNphMRBSSubNIUG4pLuSrjx=GB7Z!89{#f0l-PT#N-cdF2MHc z7`(QeI*1L9a5Jz5i96b!IEyY36?_XXS{*l*=VCIKRVg`If!C&&4-ftN0}&lx&ke3Q zz9u>$f@!`Ya$U6zT%Bot#_cMA?}o8xB_uC}p))Y{jOZaa&XuowRsUVuBCgdmc)c8l za!#mK1MFYqTgP%G9D7`%9=BN!GF_U5JBKAk`LSJ(8`W#5u-6eG_JI6hXjEj4;+{G+ z8E@+YjydI695GBOkDzGe2*izoRgrqt68EQ!7qvhnsN3o9P4CDYlXZgVr&@U+c~>>y zX+_P-pK)fCW#azx2XjEFOKK|hTx#M+T#e@&yL+`3o59Tz`b*$g+%ZUTd~a^3f+0EX zGh5j!!436QK}$s(YpUO#rrU>zW)mfKG@nnicKsQ-a7NqMsb0=)tnC3^AAV`wm#%0sfAEAldG%YQ6fxMVo9db-7xXbAIxD1#GvL zm}HbZLfFN1ly(nQ9cJp~UY1l=Sxnp8jRS@c8|K%%ro%lnN%eI>1~2^VB2>j%q&KWu z6U5*0t3~CH6s~<>uNdnaJ#yMK_n?j?$yhYnFOm?J>%tb#5@y^{&RT#{9p8jphQyZN zkuh(4z|_-6U9%?J^C0nhj5%_}8H$YFaM5Rd$gun^X(oOsWiPsZoq=7Ah*?^X;Mgko zfM+Av?sWc+>y~6^f?TN@2t~K|Np+5&cT~gqSSTARktkYh3J0;ESW#|JD7!aY5psLF zpyp+(2+|hS&#?K#7`fRph0l)!TCo}sa`KYjd|hg|@2R=!Ci=wf$aBykVLJ`u>r3l; ztm-5&P%F>EWM$WV*M+I=U|x^e{xZCxMM$}8On+9Pe*dz8qhQw$sQoYh@U!%5T7@uvA0O?t1SG|M%N^g&6f%}Ao% zg}c`CS)dy1>F)T^0zgv7y>+QD0Vo;dHsdK|LkC27*>lFb@1ahVbd`$jb&G)ZJ$ehxJbES=E;tvNTqW2lO26x-bYBbm6zZS>C1$2>Voj1_p$;||HK0j1+fpKw z=6`8ED`!)Y=yuS#a8+tL^3tmbOF$%sG%6g@I!--4te&W2vp2K;S{H9HoGJV>9JCOg z(=jQqRcd+dMX8hFpSb*-zgn?fH+6;s4%gI~W#OuLo6J;E8}+=Q4V74qv)maATzN;y zW8vJxmRepzaGi*uhkGf^hU`mtt62_hc237g0|Kk9%M7O7TE5>2-MIM&XOFx<_V!N+ zPX^`Zm*yhf%Y`K`yu4WLBUPiK)|_~r4NXPOv+~MhRd;V?vY|DUd#gqVb#ml zM{g{4gv5K6(>`);bgpd`Zv7$Xud7sq6~JzvuNuq0sY`l7r+R)tMw+=Gc6Twb1_Spg z{(+E&#e7>+IA>@&4p6LEo14D0iG01k>vxq#n-}1v8qmnJKBu7+y&G$N^Xn2;`Bt_Eaxa z@#vvy0h#LP#|Yq{_HlPi=)0_;p5#6 z_tUgQPI9I#kJ;QUBg!^n3eFel`4%*@s*!>d&Pr(`gP+I`|qIut*YH#89;UWG*-i(%-`h$;83c z07hWyqk2xQ8<8x!#Ig^#+A~(%ONa)RwxSE3qzwW0n(#$!)Jv3|~XSp~#5OV^h` z+W5NsekWP@&QnUOocQ)-AY0ED)i{Uc3|LV+$rDBPwI)}izexh=e)fz~vWVQA_|{$l zy@BHzPSn=NsMk-XGk8;dYB6@+?gGJnq6kpyvGBBOgMP4bNkEZj%sd0%ocv|s5>V0r zF6#L`6!ns^!EdV>zE}q;#CDX%c$j|qVM1>#TUH`?&rJj*sJ_R~Z5u~Dx$`5OI`Izh zE-4xiyD}`R@8g@vhnHAj>+@q!#(UkO5r}VbvAQ;<<&PR2O6iC(3ERim@3;SU=D!rE zE&$ew^$29#Z6Cf+4u66x&9O$|cI+cIHO=9~#^Q9*(S4m#*>C8c&Xl>u0b|^cVTRV-wDn(LhCyp|ol7>xQD&Y;ECa^DN~HURTY}*_mrzu$_=3f-CTpn)VYMT$}-h zbw1z`!ANFlc<`nn`!)Q~-n0asIz$#}&Mn_Q?C0>K0_Nbz?+E+~$+)GNc8)}e8bnn> z`OXZwE_*H7$E*Kk0i@__&0%;8L5H__2@lXY+^{@J=!9CH%nQz|JN7gE4;n(Kgs#VO z5ApDcDdzA4QeRoOTjTGSDsT9v48xJmKBBg(Ru4yh2dyceHhG#SHZqkSi?qH@4SZ+^ zB;|dxwBZXSpWcTM^hFHFym!M^DgnfIQolW5BJ&NXdW2{O~fCf<_aYq!DVCEkg#uWXoIVT-OB29=SYtQs4Iebfy8u?;rD zWuRre;gPx-O&u`{qSB8MrpDM;0*BrgNM|S8WhNpWF4`s{h28GTdy_Xo-rm{>H5KvA{DaIiMDE>!2YG2R*`xdw8{Gb*tiVVpN`ow0UKB5aJYE~uw+9712@_nIU^iG z$Q|apgQ{!+8PZJVZqm(a*ByAYdDjC2LmteD=4u%N7u`1mWhZ7}%&mDCqudGXwDZr< zrBXzJvG8<~5mcrEfoGBNeIPs1IPJeji(;*R#eD%>blE+Ajkv%LiCwJvE(;f7$n49P z-5Dw>A#>lj;UHjxzfyCznm-|&>#w;}opT$S$;DH3Rg#jp=KeANPSZaGSVPxEGcJP> z{`o8oQe?+$S0JCWnqVW70_v!QgooPwC$K4Cz0V?>M-I;h4%~-x+0RFxNgV4uVt|q1 z0~4L3W5+Txty{bYQJy#Of8TBZ|2HcVB5*?@P*oEkvi@^J&iTBEFua7G9pe?6>u2x` z_~6@h;&l^YSw~w(Vj3($oA;Gh1mA(tklrB~%R>hqP68n}A~N9ovv?M{kbn!!**O(s zFFLN9J+s4pNC#-g0>4mQ?3VZooS~uZmrT9t0fxe28DV)A)d&d|H7q z4Ob1ANlk!bnF`5G8W=dq%DP>i|MNj6;o0WpoZ!XGNGMQ}wBaM>NlSQC3gs)mbq6E8 zQ>@et2Uq~@Aisi4$O?JsDbhw5Xq7dY*J2sIZdvJ>9*0E<9Ig9TFL)EMfeU`)_=iS` z?Y~FQ3uq{H-G2_bl0Vf*DaUhy;UICo{SwC}M6PIpRhgTXj^G@UOGu6|cs zS8≥2WR>^rQ~@fkG&NC2$(bQXy#ohwlfh#E0nKkN*XT>%^86s@7jiD_paHnVRD< zm@O?E7-JcaLF@_gxhVmctfFT=zWp^Al#Yb}dkgP%r;xgOTT8+^%g3iouHfH4wl4&j zH@N_hc5qhVyOG8JOqa^C>^Ms*$mGk1Yfiw5Bn!eiN-CY`z7+74r}PusDnFB<-4#); z;{-FYJ&dvG9^`pWd1U+!d1xj`NK-Btgfl&G$16aNRWD}XSp6(v`Om;VL5BrPcmzFr zb+p2K3;b=$kgUR0Ev2E21b1Vl_KaKa6O|6nMo<**U4pbk3~d+@KYCDX0mAq>xc2|g}EEgzjp=* zG9#X+e|_3Hd!tbsz$%*{uPa~mG;M_OYdlsbpVZoeGW$UvptkUJyk?vR z-|<6e;#+itgHTfm)O=ulp4lu?c{%c*H+C>nXWar*=YbEl0%H#DIu>wggOtS57hrg% z^$}dkeX(7Ad2m)Os*HhTPf@K-()-8@|JMch$-AgdY^WyDH)WD!Ta~{Lg zVFygwE0gQNxN5+fZ9*dD#*Xxdn#v0v@WU>S{okY4UTvAXB14~#DP<5~a`eGWD2xfhM6I0p90U`rT80GGN0p8x= z%A22)il}1QYpX(UI7f(nYawne|^*rBv02b@}VitvDL4# zgaQY~@*?f@KtV9Wu`#vFft7z0Sh^oWXdFDJxZH#qg5~b@PnoeK zYA^@M?Dn#)3?%>Av(*@sPP7=I!B9ajK!1eD3+Bl zpp|IBsnruO7{SkUjou*tTR4s<&#pqr%D9FH z+4uEYwSVNk0YSO=S=d=h?opzAHaC9}V_G^Ek}j+eEKgV6)T-WiU@V^BQ&b;)E^(|v z#stGh+yVog@B0krvxGI6fNs7jBm@7UJ8;uj@%|En-g%QYJw{5;5k#G8z%N;Iuq2lO z#EUCfh|=N3gJWQIsC&~8nl&jkv;#;Qm6i|duqv$Il`ev*P2xqF<39qK)f4OAy#h9| zzYHQWnGZ~^jeqBgjcT?z_j52;mij3bM_^gBoB0T;$__lg`xVF1z*G*!&f(I6yy^s> z@@b&CB8Xp&ix>r9>(EnB%(@EMJ2X~P45jpz@XqJY>Z6sV9BL0dQ%QS?z&G)@ z@_Nlmlo*mz;jgJWGz5VY;9wX<#WK5#KY}Q_G01<&2EK_CCt>wNL^Rm-P7dP0P1xm3g&FsPF*{Sqa)^y-0!d7&2gMp=txwgBO9{d7P zgggrj5C{a#X#r9xgy8I^!NK?)_lpmBK6+5M;p%^$kNdyp|8IQ$7eD`-U;kSl{NCJtss7 zI#)&}y%XkphyW1*HBY6IA8hCX^L!WNH~5=?KLjWevs8ab%N%}lwje$QiZ9=*pSJ=G z0ZtdxgPDbLSoiRIv{q;7=3ki5Usey?huQt;@ul|CN0Lw-G z_At8P2_$K<1C*Wm)3iWPN!Cu)UXMJ4%8h)vUJxbdPmfhe*k>3+#DEn3EtCj-?x?zK z3vfG>?a%H{UqeiogMG-PI%Lv&-E-&@Ffl&<{gw9S+g}|xhnvj-Mvk#t_Csc8N&K+| zIgiJT*gm}da2`~Z`!!+m$;UqhfgxeyVZt%e@ntBOUJ&f(XqWQtyknbaszOd8DQh6M zWoA`>=za4r3we6l{t;E&#S-j{yh49_3=F5qiHL%it&u@Itj(o zMp~9?tA{T_^MkaS({_FWp|}y(%W$_4POAln9szgY3pKV&+#n*J*?iD$dPv1Xu3Hl| zcXIWYa@0&|cW+6^qvPx#L3-hMT$yqR#Q@+=Ld~vK|PdEC}w}8#U<2rwo6s-lw3a;Y} z-N4-A{uG76Mb9{FKo^M!QU-ljdL!ycZZ%QW@5q%j10d`fpRhUNn=L6lfS%loQ}ALr zJUV2AI6BteY1%C7hl13?UpNtWzW^;9BUCb;Pz*f8xa^}JvsM!Y>kW(=`eA}qpjfO% zN>pD7s3mcAAAyJ@MhnzlSc7}u1s-a#7eTu6e)7?de_^}yloy>cq^$3KLLmqfea&w5 z2eVVC4RpAS$RE7ehjD_NcF{FjW?DK9u{{c(ye>zQ`!Qn}!XRb(G7#l^{U~1T5Wlsx zYeYaXJr-8Up~6VPrhlDnWzkjrrswZ>pV)n=6JWOS_G<*L>(X=0MDqBucN zr*OznvzRyRZuk`vP`fv@U<(^w@NrhEwU2H=JgD#dK+So|a0M%nAiSFZV4v5VmHTh` zeI@mjkL7*0h9BE6LsF#WjBt64u<)+?BqZvB*KA*S8`9UAG#!FP4jNI!II0%0tksyd zN)+O%kAl&y&+ol~YBE!4JAAdPM{!qg8@ zp@yZXa*gutfHE8m1WONXRDz;PQWAzYG3s%bwf;?9=ZW?*ZMS91mcFMWJJKeN9>6&| zXt(;fcmh1oS=GQ(NL556+x(&k;QWolFTlq+K&Bq93pVnlWJ3nCjAHohT-!nDI7x&*HtT5RZ9m>4lo_aJf~ zn-wrZh{KbwX4h2u;}>prow*HA;rDV8{q-?tdk||D)ILAI_$=he&|NBDmqH(8??^~M z5SeOnLjysBkR8piec2Y`pe_nVEzlIAhfGUH0-USPgmpz!LOf5_{IncwN8;ysT-&*m zimjS>H`FH0JP0yNuOP7{$s30gS-p$Cg9@B#&lP6f*aW+7##f6h!|WVcjiv)crklPZ`xi}fj1GZS_ zk|)@InYxL_8>jjBIvj-f7;(3QPj&J zMjFYWVvJ-du@Ay;O5XY*$SdKgq>`_ZRQM|#B|L8mw(^!?KiMgh^a+dZHcX@GmH{ubyjus?TF{#Pl z5yY6DOjKXV3_Ik^bj6YG+0?tZ(rp*nTp@7lWZS0rp#zyqDH7eNnQbz>n~QMQ@=SDOv$M|3TM=bLLaL|73Zf9E9lcD7Cw(c7Qj&nvTYKTK&i;7DJ@mM<-Wrak37)4R^EOVzFvL){{H?fC#& z;pciy^;fYpxYnTGe04~8DK#;#1A_PDwe%`PiQ+CaRl(I^Aa03;PiZYWzZO5qc_Vkb zk$l^gM%PmhJN&ZY7adyDO(LeNjRCmB>%I%k)#H&{FDGDPG@e8{^mRVCroNvbuDRvl ztC3c|7tm(ijXC_zBsMjAY=^i|&UMu}+Rw+La+(l<%!s)r1x*L__dJei28?8JuFzk~ zDVu`|$M1kj@4h69Z<+2CDtS8YDckD{iB{2l6S1RM%qP|fJF+#Y0SN1}>;{e-2ZNQo(iN47a{ z^t=q#2+=p8t*MI$peDAfZZLYv)~=maq?4lyCTKYbgtQk*+UN(V{DZlK{QCv>@SGhW zUu;wic~NDOty5i#6+W1R>3sWp4fJt@Ix6EPQLHG#W_12wOfyrvM7 za6X>5Ocg(A{Z*8YO*n9O*~UA%h0N|EX$STZ;ZQ`+#Xn=FaAX`7A0=W!M9)F@$>wSv zBGU1&aL7yK!J>!VHWJ#k?zN^gaUpt)_)PFN8@pZG$;e&{ky^_T?@&J`$u`Iud)W+Q zG3|qU!NLk^Yli0KDm9Ml3$}q`T#C@g^S?d%1=kFZzK>ys(y*vd6&XZS^&(=}+uB;% z6EElthPYYF4E%*Ey2Y=hQS`Lpq%K9$Zss5$S7Jo9RSIEVT`^CXr%Tnx;{mPXzwl zsrT9rXfW?Rx^_`1Rl#(IkD`wdiy`0(>?DtQ!ueY$Lj`jo(U|rC#4-*7odXJdRU{K8 z{|gMF5pkF!S3y9yXT;FNj0xFU4B6nWA&3~#8ZS+X z{K+x!NXMax#GSYob&+Wqp0;lC1l&|`Td2sr%F-Y2@7`iQ#6Q{I=Uw_q67zo8Y6{&R zznZuKb$-qhD6D%vp4+uQ>AthcdPwoWrb2E%kZ-p5x5jAD*dmkCAKx8Fy)sL+PQY8M zO3V*Lo48LPgcIG>Uc<-LajteY>LoHU;zdoTUFpL18o5CeMf5U@<9@-y@^c>#5q82A zO=V*uF&3s*1B7@nj}qC+J#G@6kvE7`)L#dsG3WMf<&CAUciUn@YwVkw2q?(I3cIY2 z`uGRt&_@=wrGDCn{2J>ET@+#dj^VOPG`$!|KGi}9+t<-w!uuk(rw`v8e(doF%fQG0 zt~-gmQ^L_q802RZaHf1z(}kD8cyug16{OEnl47yyaMauu!h+fR*+x9XQBQIljnzg%cAtf}hxjOagsMgNAuT#p(IZ2)2|CuSYtk_v++*Xs08=%U9? z=y_lrN4{)71Ck7mpM)U*t!b)>#>;GaymI;%Ndb-%5LNQ;y61?8@u!XN#no4`XsH2@ zRc@mGKd6BNPCh9qf22J_MNd1$8r2!Mo!`0m#=i-D+gy`TM$Va9g19oZTeG(tZam>N zmW?^Q^_yhuJ{jtJ;*2_df~HZGtbk7vCSHraBryQm*PK&@E~EeH?f5L_<>5_6@LMFJ z=xv9sw|qOrb4C%$#w@4jxS@XJn2qyAiblBm?RFY?ooJYBGG z4=>c^*#owMGeP&8AnyLo-C*a^c+$J(s;n1`JF3b=M(QfYs{f4}3=lVNH{|UP_hbdN z-btdf)B6c>h)3;&?Q%sch9t&oJ!z-|r}2S)*P{m-g{bV@?fxfwZj|vM&9+bTldY}K z`+JZW=G2M^NrhhcHcg9Q6q6-Y>hH_i9RAMNvVW?n9Kb=jdqccy6vuOB2YmdrRQ#P@d(EcIv>i##xLBQKBUj>=NOq{c-72tLB` zY;e7vW;;~G)WO**bO(Z;e}_C8!dAFt*r_iXY*8L>!hO-aEQJ)KVlm}ydAiRtItCj{ z{|^Pxa)WAFaruFPt38u@TJS9Ks|-oEJ(AcHERIPt^^OSB7UJ&OO+kZbA1nJw|8*NIw2}i*ogZKH+-IWYkHGbV50u-87#${ZE1Pd%(Qw z-~WV@P%^f+ydyqao7P*n{FH)uU>Bqs44dzxE35n{%^OAZr7J)sX#Wb*GO!1unXFRx z+Hn1w5vU!(frhEKIXPM$$<(}J&Z)=Q=~wC;L|*PX=%7rF?6`=AGB(tO3NqIC&s}@e zjmrV$X{z!;D~t*OnXEtquN>~9YZjV@Nn5R|60uW2$9_JbMec6&N>R{_j}1&EYSuH8 zK`G|S8O(u?#wZU=E+ZKorFHbbbwZ>fi}NL7%Z_JB(}_aQQE0Hv2pW`tir*w{Jk zWHUYfpVjFF=I$1uw)#*YL_RsP^N+Um)Ur8%V@z)JcL=JTmu_va_nSX&BByB6zi_SQ zIP(vxg6?4@3`UMc$BXR3D{74r*|J-aXsth|1-sq-#%KqL>iB;Mo|DJDulP7djNf17 zmHM2-&2r5-d4V0Ez%4jWA^NK*b|_gY5R5JgyG&?1vudT_9r|JpQ!E-!cn(=AvZe?U zGV7I6Wm;H=6-;*_ ziOo+cfCC;Ey31|BTe|TLlr|DV#Nvy=k*SiXsNkh-34LeYCifxKi-0*KN1p{-f+TCr z$oelP@a|)K4JEM%$?9AbHZOh@p}NXnTZL*a7bL4@z?n;CSJQVQi=qFJsY&iPzK*M;1gBReph88>L!JdCglLd75shzfh#- z2uQYRMvEm%7dpto&$4#IC}tXw;aF%7!|-r*+~~_H-kMy>Sjk&3qs9&YSbMF7^0a<~ zB)+d`du76CgQV~;CEe{c+DQ2~?q(5SmUvHv8@`Y)X1VP4YDPtDvwKUW-pfyd?B8;7N!7> zGkm!D%~YPyts{?GRAW`Xl6l9?*I_K=ivl&#E(F$@ry@W6Zp}RLHw@TjZeC8)5##CV zi$ItY)5oCc)(_J+fJm@Hh_k$NxT8EJm@3w4T3o$Vl^}Fa1C%LZ1#+nc%Pgnx$aqs>$ zpqx=T2lQPHGDuSBxPsiUxR9__K&9iRL~U9l_9LfpYF*q(So0rhrSk*K7R-fvPUXA< zo7Jjx1Ma(TcG0Fyo@ zJho{>z*r*1(6zP;kADK_R&Tg&kX+R!0cRn6qIQ*ciiXRb@U}dXyV>Kv;g$V{sA_(= z;#+9-p&KSkWQPYH2arEkKgBvW3M=2d2H5w${zmDc&&7Qo^VJ?-!J2G-e$dYQ*3|ug z>TtjN!K}`KVrX%r*tYFcN5H6~y+SqQ_s3Bw|CqV;H!A@uT6>`DZ0!3D?&OPJL=K=w zx3H_3nPYPwKS|epuz_sq$jt@qVp2cFKYa7UN#NWhsDT7ceEl;h)aYg*?;FW2*AIvH zrukug8(GOo)LOqjHCKP)nGd#6@_jkS)w9Zz7jXCU!|{=sL*f&q%n_p-_%}ji3@ZaP zFoTaC;&(Vo&j}W=S+Xr*X!+TNl$?-QWk9Q=$74Mc8a72+Uvm@I7HOz&19x=VI9o`t zKIRmtH|;2{>E~Q(YHG|U5EArZ< zs-t1z1RSDAEY)b>w5g)USoL?DZZ>;sYM9lP%g^cG@1*Ijc8H#bw+%wM+vdXa`nbt6jW-)WAE&XZY zCBvAk-K+pWhCMKd4X%JN)!`5{;UXb0gjjvD{_FL7dk0JuT?c$ZxWL7D|!GpcRdgsyVBXTmoLE)UR7r=FnxG{>|e!mSaRXPMv+DWNejA- zShav}Cki(mN7GCIj*sLNiC@Oa{je(jmGn+6q=x}>JlhGSDE#P1NB z^l3oii!yML3#N#t{p)6(e|iqpw=8nU`Nd2r*Hbl93)F$I0-?KNwC61ud}Fzo-jg1k z&D8h<#6wUs;AZX(n>~Br2U%8bCSZk!UVp<%*!wKmjUq<+1`y}B6%&zPG7t*7NB$O9 zD@EbGbzQ+7>IwP{v)9lTE5lhM9gB60U>w;f2@wS?HMmv;57b(nL8st%q_WM|n;{E} zj}@QCJ6_P_qnx#eCs8WKP=JONup#dHwk0W+Pyq;BIP4{|4`=h7#cj#uZmP?Z=)sYW ztLmU*?RdQZp=oa&HF%6LYcu+iv)yjqbWY)^^k|>-!5#>R+`@9DW z>ib*CXnUAB(`d7`20MJOk9~>Gz4>RuxA=QH7R#u1f|9ZmW?kThQMT&T0r8-?hh>L1 zk9MV*CB>0-^6~gH${}SohO6D8`kXZWbQ3t)Egw03%W-uw8@M!g^bAm~ir%>(-CPgY zUx~?_eX_!Q^IElLdJJ7Ot;q!HCtiQA+#K&4dlo!lajO8FfRMonXk58qkA~85<%Erx z=_l^Lm53GOMQIHW1K>HiW53@Kor!L1xC16{%tVs1@&9A*EyJSj+V)XOKpK^9xTPB; zq=rUGgA#_2R=U9f>F!241f|OXiJ==wk&=>b7&`s0xu5sl$NseU{=T1&dK@ek>vyhe zU3s4D_?L(6@P)aZEF5!Wu>jJF~W0>EkP zEk`TjKFCxrt&18QL-58Vu&8O27mwTBhD2+r_FXM|5W}Z3Iji%JsWnvi{M-*ys5qNP z{W|;`y*+YvvHva2y*>@jDm^UD!hA!iPpk}v*3DY*QD`M9;bNme!il_}0)xTUx&@#vJe= zfBawxCnm@gA?Se1$`<0{@sNOfpL4Ts@T-Lzac>GI3q%aj3`$_b?k_>+OEdeTi_J1S zVn~}?LVa%&Yu(m8jbu7{z<#4~xq#u;I_1|@Z?Tz&#Kx;x=DeDtvEs4Qccfv82TU#Q zdEytCW(T5RB-_n|Uo%m(=@ae(3xx9f&JF!K1-#lio=u|WOQP3NjU;9LG}RtO@U+CO zh%zJjya>lkY;B>LKOy}RN^WMgXI4;mca+E~%!U3*-auQtBJLeo@(;23wd**6j1#3& z?G>R#S8m+LN#6v%APeoU^XrSQ!W;?SF;fWZf6-HL=!3e+>GkG2)o4gZ2>r|UnwnF3 zqCU#h+rwD!pkt*qC2xnKC$)cTmDFHZ?|)|W!@3=o^%h=NSWTEvT=qGXY$r~oE`L2g zR`}P;PPt{6VBCWihHOkEYZKr5YOFq}Oteqw^y8h?u=ZZkp%qg;%!G}0K>1aWvk_g7 z&8xCY?;s47Nt_hT;+o8xZ!G-Axp?^=8K))4;b zX=K^QK;>LwX~SQeTDX?9#DwF6$f|P-xiZlX(y6Au@VY_Y$ZdUB`zKsqnhuw1yf=Le zQ|H}|xVQgK12za=Bk@Q5*X# z3g7azBFCfbo$nQX)WkXh3zyPdo$+Uv_e?3H4m^7$$l;8;GF4{MqJgfa`3a$YG~ABX z52nBN%8eU?Le|Xpg$AufP)4cgEdK4=}&DB$6&BYA?U zo<|aR@Pp7j{n}*Y;m^7=Uv4>i z$O6yA;^jeTNjHt6)Uv2@GEa#$v(+O|J(bG^!_7wqy5H}7fnZWV)YxljB=(lHS4*t4 zR`!Z=+r<|(Uiy#t6b6prNy}5@3~o)4HgRW7@;_AIYSolPCa}8dnsJ)u3yA2HJ>py8 zH#$MdkI2NF%-^7u$JjAk+k%pdv#AfVH2CwBpR~%KF-3N^=}Tev?(Bxz^CUxU^iSJz zO$&Mk7W{{&W`EXx8$NP^4xB03&*~K=9Um>Z7#;*R8PmR8`!&(qGzi^K_#VsihW}-7 z?E>LLe-z(M)f=i=6A$H?X@Zg9h}P*4gr+Ytv7d$hD2%{$rM@VVeS26myOq6)gMlbf zFhslb>-d&nQj1ea^^{~kx9Y~?htJPJ1NWdIJgQ!DDOUo9fa{@+5#Rn8fGqy*rCKB=y<4ICnLPQ})GxsB81O3p8 ztUVf2Z4O@t&AnO02T>frOP+2k&DUr6(d%LZn0#-7Kn|_QQB)wZ@X|f#jxWToT>r-OzJ)^SnNtuvmy%V|OB^l1+f|$)jJ5Dhp?SjXYhFE=-Q^Y+JIz$Gme8;aKXq_NIpQM{eP}~dirLDPl`VHeu45<~X~CJ~dn(ua zO%ANekK9zU=*HDoqw)n$)NoJyA>6(@oKq|6pUYuE*-`F{x(`1AkJ|^r;8P&k`=25p z&oy_E>?g7nROuDym{^3E8*3*WWbRQl`Xd>HEwKGY(d(j+n^Ah|_ z)pkTx@y|-sju?t2ZVyQSY(iu|J)5Lyu=k$GupC$r{QN3RiDFi9^ORTB_S{Ji+kO+( zHeeas@}gdKCJ$n?o-&QUkS*GhPg6GijgD94el^c~<7uP$SWJMLu$uj#hZ=p z;?DM)2R%o~UhD|6(j}AW^)jlz`6%LzC{q$W!rVY*v)>!f$s%guJ=J|T1m$a;Am0ZqW$zQ%Py7J7 zEb<7N0`H@Gq%@3YFwaMJ*gT`=JY&SB0T+Oak8-l?91WkXKcAWTT+K}NEO^*NOsY&@ z;N%UFiQcTvM~^sh$3Amdno<0>(M--E%8HUguW!^na|l=cuO-UuzTYZ8VCeLLI0tPw zfTl-HDDH@WST$Mge+GVg2V^2GKV+>>zNVDB(b9s5ixO3T%6oNlOlw(OHW z^f?Pe(*I90+HP+ewoS<)s+~z!$0>H)B**7$*%=DaGHEmMU_;NF)FG(7%5sq+wY=Z( zN9n7De?OfWd5={9$1i?i&wKO-F=Bth)V?gu;yf}##XYsk+D$J&qL}z0Xubh;mpm!M zM1g9##7w7QqNv6^FiamJV-}K}>EPK(Q$yCHgAm0%9^#s6O4%dxT#ZHsyNqzh$=GY# zqKE5>FcMrGKZ_ieI+nzNKb4t{%j$7ZlP2hOl6({-5vFBrrUzG4ENbAI_1_@1ygS6( zE9q8Q4lUUb&Dp5gsTwMQHU3{O9*uf&1H>{O6Zz<4ee)U*KB4cjhCkfQ0U9Xm`pbfs ztKii-mB9t2uj41#Pj#6zA5q#kgV+l~kHr~Uv@6;M26(*bU7EQDa;&lu&6zYk=MrsR zx^=45qU}SAeIi)LoJsSqZ;m5<2M9j=JjOS^kb|dLfeCQ+v)T8R+{#twO{OSXJGN^; zb|+_JR3yvW24So3#wQ{CV+qJ=2%$#pJ1cu>B9jPG|vj zbAN|kp9}f81K@_h-y>?RjdE{Hiq4p=SPb>eEb34c^wR6qbJ@dyV73Aln-hHsR1J@D zcaXJiSkm5^dVbP1lh%`>)LRNf6(7G88Kd>24W@PFyD?};o&Fr6p&GF*xQ8!%`$Ehj z;}vLSBz}zYo3o)`L{}7FiL;ETQOM<5p(=dZZl$YNhX&POVG7^vynNDi;UywlStMxx z6X(g>1`3x3=+jv~M=J^D!ipLM@zpChCgEoe3BzeZQ*5h0!Fa-zL#tBQHpAVW!CYK_ zQ0j4qV)zTWB)*3a(PabXM`0vJp3A{AxfT+Wo(w5Jg#Od^KoD4`ix!CH+GJZJ2a=89 zWXVDBI#r;A)fP%8@oCyFN^YsofSLS%xd1L!V%gr1M-Vtd2SPlWU!=?F5d?Isp}K5~ z+C(fwBE`g%sh8&i_6%!3c>V>YGu5y`ua~&^lP7%^rJmr5C4^OeTI9D9G<&6>rn~-@9rKnzq$4?d48&M4lG*pA` z(iD49P`IO+l=HLkF2;E`UM|kX7#O=?RLFqts^YqXdk89@H&Da%hF$x$MwXSp)|WC# zzS!4Ph0hpxaV>ONpPLRh-lABBy@&+U=aTFP&1sP3uW*LfI~$Zx$)4Kzf0T^-?sL;u z`T2ix$~@1Ewvm8)8N-i<$G1IJNc8Tt80@5s8Cuh>T$8*}4(|rSIAQ7{e)LC4WYp0d zr9W==Jw7Gi;Pc0^EphZHBY5_jy%%1wNo-`F`%aM|Z(}6(RqDnM0YQ%-Fqoim^9{8! z-vDXYv--SZ(&ua3#yxMyLw!JZXTPBr&EC-hU&sB{_}pg;$K?v%>l{5VXo_z=bf#*) zs_q`hZ$2Pa+O&`ctQ+PM_#B~rsXPdV4flUuffC{hV;X!+xh@&Maoix)DFMzo1iY9V z%z$MNTr*x}Jn#h2r{_`LiS5-*I9Ii7NVl>F;?gpl0fIX*2?TNAlML=S9_~k5tDaLz z!&Q=}Tv%5Mj3TYtlanJ>ii@?V&cwZr9qrR!5=>PD|Kc>2NgF8*^6YQZJO%DPEteE- z2KOp*jqn?q#qrmd;NSnP9*=<^C|0_%^Ao*${TW-<>&=Q$vVuW$7U28?AbMOb6!tHC znGAO4c=(vdzOh7ZMkBw%qBe3HMSx4jY~hCMQA|o)K%*q9lc94Di*&ex`z49a=ZPj$ z7Lr6_8xH#=s$O+*-AV5`#g}Bg3$n$&YqcBDNV8T;v=xMkAKY`$HzVnp5%j`QAG&_$ z``ne9S}ekvYBqA&oxbs?LM1&gWv>ntn1fxnqn9lrH68hWFn`I{g8#Yt3)pN;t_jz! zPh!Ku`abP4Keq@!Q{>Ehp#LC0E-8Xs!Qy><7WcEH$92z`75~wHKC89*vZn5U({Aza z@5GIpY>x%;4XMGQ>tS)15jUSj@dNSN1s9o-p>!+q)WxSGu;aeu^+IA#I_!t~RSyi^ ziN+63q_zn|?o)1WH$3$kEuFBF3YQLFcwWw}ZrdIMGyTI3h2g3N9=zOsmKmtg*=1hF zU+%nVrc*v{JAs(9yDU7Z?rzx?F4PTs9bCJ(oI%|q)3}a%v0g4kmCvc{UFv>hMH9UC zeJ8@MM)bF1=O68ie7HaqHhyToG6OdV!Wh(?yyo(< zm43PLB$fnGUdF;rM`|7E*GEb?&O=II8mFXV0%>DJ8_xaeoJJNk)7{W$IrdgnhcZ%N zdd(Slf|dF{JX`{G3_;yqs(s4oo#G7BMEzt4Zi1ZNP(OAI25g&oC)<}VKlp(nNBn-Y z=z=xe!-Z<4>Ma$QV2Zval@)nY5urSzj=;RvMwZ!;89z;r^@nToqc9@LVXDC2jkG#7 zOE9l4c~NdG*gzg*AXV%IBlmmEwgQwU;GE}5^y9uRF0lxI>9XH}o%VE;5EpSN#yZu( z;{wvktfGa<&Sc(fxA@K)u}j#(ucy+p`0Xw_lHEFvlnN-SJ&T$@e*_!Y40JjtP{JeS zt#?-mr%JkIpW2^y0qVuxU6|=X!g55JszK38VzM;lYHvESLYn2qOc3WPJ735#n`yYH zV_(Wm2Wv;TbYFf`LPBa2t?Ww>mw``SXKqDaZPh^MT9q7asXVzc%xUWVhLDuN7u(?P zM*auLK{MxqR0r%{1-FGrFPW%RZs5IT2|8fj!PQj8`ozrWtPtq>YLy-La&vqcNnR3}9(L|NH(Wkk#*vDFcRg8} zBJSE=tBIujrOL!(yt;L=)AZgTgx2g-h+tVy0Gs8w45~u!#zUi%XjUW^^F_85oog=R zgs!p3n4I1x!NC4|w{3F6s2qN}%Sg4`TY^*l6f5b!3>ei&Iv;gPYysThJ2d!y@44wb z9a`hh%EIXTvePv*tz%PAmmg31w|LvU31|}P`PmnNpn|0>rZ@Q&`Qo$DZ*GXhs%}w4 zHNOV>3f-T!RTbMGl3$JIp6mgiNRNldLix`0r$6shub5X^&w>J3f&*0cU-KZk-Cyw} zRpVk5=>p0F7N7?xG(9Q&h$E9N8tTKUt`qDVf>65S7oae3H{+)6-CEY8eabwlj3qZ{ zK%oY#L!7;V{y~COi26hHcoynHgI^y3!!0OXQ<7Q-`LPF35{^gX$&D!F_Tp+0eK7R8 zZ;>Ub{-p+!JXsPCm$x8>2puWa$Y~n#juEo(3oYEJnF)gM3QQn<9EP^W*8bco-YNub z&CYUEXc?X9Uz7|!{|xFhjs)an82Px?aWN%t($c#~a%ow0mZf-jy=EsOBDv>QUzn41 z>|!bU!HDtrScrqryl8Osly(&SU@jdUp$cHsISGt1jy)tj3_x4^fgct1j}w+cjCGv- zGc52YVDy^2U}B8$!`}K*5}f{w0DZvpE!o1vpM+wm@`k<|b$Ue|rXdY2tiJQyLqQ}2 zH?H2_&!SEPt51}T8=(9h6Xf#iy@yhy=zO?Z3(akPDi4$)t6|t%DGIs&-THq|{l9?u z?=}6eh54^>{O^@s9ahh(IOQNU{w%8lZEhV?SBAoR!D zu$6i-cCO|wrLH7yT<_7(doBsQ7)hP3I|$9kY?{}v4UX26B_rzX(}e!w#vR-VSVS$8 zGCFjc4Lw>1{@#zy01t&+4&aj&g^kIOTF0WTl}ou3Jj25B{|Wpio3CC*;eK+APZV<_ zh7FiW2*JwMB>_}lA%2qOXrYzwSRnM1ArbUAerT7{e$Umaa98aDlBGMD6CH%Ga-N;j zqYr2vl*ZlLB*jRor`IO0rRKr-+7BYxv6t~w8ILi(as=qV{ZSVVp#lpFnqNq=V)ad= zy(?(-Vv4;o@EG!P0VlGaCeXDD_H1R0!?ETEQ~e6p*IC5X@`bSsT!cZy!OG6I7a_Pm z6&at1=gT(o3T^UnV7+{W^-P-=e~t!=J+$R(Nukj5Y*y&)0-h#4%EdiJLr1pYBzJMg zFhLe#WIJ%sNf{S00tUa}fCI2P)E>f63PM}s$saJ$@s5PNLxo5VUk9Q>6~IZ5JW%aX z$C_n^h}%Zeb^_lU>H5i<7^oCjH@FQZM6*B;v1T1?M=X$q9%E(s0j5il!dY|uqG+)2 zY?x3>5@~MpXTxjmCO+^1f!FRM5PC#_=l}CjdoE{eFckqfi1ycOx%hI~M2+6XI$}uc zcUnSuxFn2=EMKrJ^8_$f?acZpb1^Yi4R8)Ag}neU`d|5>sga@&%spzid>QzkWALte zZQ0()825>JGk~n~fxi}r0pytmJ$;xV*;fie^9_9kt~=7*35f?Bzr6nrf{DLYqU+Zf z$a2kZ-OW9~@n?fmoBD~^s{}&HiHUg1bC#c=ZR&s`>t78NITu^&{Cm^A? zr2=6ss7bH*ifpLw5!h`pnqcB#44T&t-Ag4sf3!;-bRuI?|NG#(v7&WNDYUU*B#FkF z2$q6zQaor@S#HW zN;~-;dP&?ojrkh1YM}P5z4?R?AZ_to)a9NKz=QM@{V_fMe~?zqAA1@0?~Y$D2?;4I zF#$jn$}xatueDTH3~~0uRq%tnBXq`!6T;^K%NqFgFq(ngn#CQq`+?o! z7=Fj(rS_6o8i=m4UNs0x?%+NJ=cegU5~R6?Ow;1~L_ z0@&*+SqB^P(gIu zha>?c6qJ!$4#@dQenVRx(E)ocH!;i2W`-cn>;60#5%J0pLoYIfA?*hIgucsykc#TH zTMd6a3&bn3IUudY2%w5~jBy_SjbP%061WlkcCd7M(l3E%YgI(gPlVosJFGv|#y`#$ z8}cHSTTu$!VQ;Z9T|*G9IZgJCy2v94TSD{^aR3W)`GXDNZS3F_UPxX<;?~Lj=MEF9 zQd%D378c=R8|QJG@R8=yp4H4I3<`UFGEBzd;P-ljrK3d6fwB6bkgU^I8(2%7j?UC< zaM+TV1DgqQe#pevZnafHN`6R@6+9DUAmra=y-DgUm|&=bIE-dkVZo3FvFjBi-YH1Q zPm(a&k@_f6+2*H^>ZJ@;pNC*xEZDA3*|)p(bl8r=yud~+z=F{AQxl?bSwCco2DG+t zndD#S67@dr`E7>!W>OWLmOgFZd{N(=liKTP?m(vLi@pM?fRV!D7+@mZ`qFc8u=)&$ z83iL|apN4m<>f0g^MmhYMesnH5u=?XxA|UR3MpIAe{7E2s^yCv)PBFj68Jpu-(rG@ zX9943mBLuH`LIjrOpmcTCdut73Iiv+Jat5(s-t+T@O@RHnNp5F@Cpv!Q8?#^XK zh!;?Bsrjc?{yzudZfG_@ids0Vfivw}5IA2}!%Hd7r(UxK0}*1St1r5eJIlP3{b1)r z94wg_7^{1aAeImA0h@z<&mjzA28>QLlNlQGC^hfCOX)xa(4 z!u@>;B$mMsmdm(xXZHM${cSchAGQpGyo)di(Gs#@)`|dVdqj;0!$n65=MQW;>GT!Q z>(bXQPy)*?U`{}S4h$t$a-0@@q+FGwfVN@Jo`-FIL0R^Nm!1npC1%Cf3 zkp30wjf;CZUsHA~>*qY3)A(Gxc-3a$+d<{-YP<|L)vFs|AdaR;UBrM%lZd&W6D02k z!w=;#qn8G6=kk<*DkU)hvFCPx_!i%P48-jkrwcs^%2Yzwsh*Hpg9o7Mi7SDaBDfwL z0a8naeFf;cypbXy02kQz8BV~H1jk7h&gD*Uz${TCx7Y^PqlifSp&BJPlodRynA&@tDTS2#8&WHM- zErKe4w=_Qv49onz*&PxZ8M*^3EHRGTsJS#a;Ow_Bu=}Qc*3c_uzY3j+MUg$s{QjNk z6@3T>4UN;M#y7zKe5?iSxQjDDjsEX9JY#ABtV?*82x-^YG(JrnfAyAFK5-?%#!HfDnN$3qBYwqL}SKrPK5Bx<2LkJI?mq5?cO zLn0y8;&t)YD-3_FJ@0!Nx{fLCO_{a+Jq(qhr0R%lGJd+n-V^GgKY(=ZltpPJ;;Qesgn=yw=6nXuT=K)8 zhdI^+Ym_9l^FVJi5$ba~*>hpp%5@zrJBvvq#%N#`{bZo|&D{`aJ=%8-HgVut?as_fT0yEyMR4cPzn7 zy#f5Fhvt~&XNN7WjC_9{KF#3=Aa=lCsq@C>ap#j%X`ED`kx^->OzWf|u*7{N8*&b) zFLqIqI2;U3eWp`&@gpA&T0|wb3KMGv`C1KYpoU}a`#|y_8izCz_dyF4vnHFi1w|GC z6{HncvTj}|`zXq`vgK^xm!XUL^<>`xAUfi>2D~b9D8XMEub9}^eM^AHg|m1J*XARt zNO|}oGIp$2`mA~eu%~aFaFPB6-($e&azK|_{v4&rr{p6ZUNG$TMzUnWA^FCAQhdtz zW6Rd@Z%|!%@cDaw_UPgQNI`SW-Ni$G5&v99Nt*Zo?it|QHjMGL{WJOWVWbkqaqmx( zH1fq4xs7{GrH66;s2Q*skaIUR%JIG0nt7Fte3Uvx;BzyfA;EL~hoV*NjDC;nYF3r^ zyZI4OPm?^6c-LkDYa%;8qX%G=h*4XTm2NtzjZ`}-0`6q9T?vMt_%Skuln%^!_4zIl6mY{qb{clNVbTHEO8IaU#? zjQZ6i)Xj3jSBZ>}T}FHJ5c&#B?wc;qEE}l>Qikt_+yez{qYPSrbn(}lnEFA|8e@mz z?nP9)T;gU&eAbgpzjKWAy#OW2a(hrMqsO1z%GL05e(N@UB70itIb z9ecqU>S$nFt(Z)4OoWMnnzs}r7?K9ciGv#AYe@nYxWVUV^{w*+57eSYk!>;G?)5$T z7@~zz|9uY!hosKkEiz}D*aG;2C|6!m><1L^!%g$$(>o&`6Xbul%y4@~Q>(OiTH#@V zYEB$X5DD4R^x1wje4kS0qMdk%(a2`$=3dm+f!D}~9{y6iPLCrN5;-F1=N@je-3oMZ zf3ArQe#;i15%R-!C4z3FHv5!&!YRa5p^4Xd`ib2trXcS8%eAWa?TQpoa~*!2%atZC zT!QH0n3_QD{4oiB~Xgzl?D9gD#SiYYRsrkXKR8ivusJJH0;>z6NArUP&Xphc%PF3 zhUCrXmHeD$FCh;-03!iSpb%1Toxh#vG~(c1;{{0?_Tr1}#=Q?za%n-%hwV5Nm4k>M zCg$yJ)BhA-#xyTW)RZ{vM-cx;tR|>N^wUDGXDWm*hN2<33-GaIM8m||+@r*A{9pU* zU)ik=Ty?FMNB_JyAc4_nT6lZc5KcialdUN0+Y0F$1n0SZz0`^QZTd75ecg1kW{PrN zXzwKDaJpVpa9}X4mJd%);&GM5WqB-kee<}&pQ&_+pt=Q(L;fVr=EbBF2b+ZBY3Kx) zS!E@LKokb0p1^D1wU(^xc+;=xo6rJkQS_HzLj65&Pp9~9Zoyk3%q6&rF1;xr7S0o9 zN-%+GK-pFDCNEHS0HyTOZDKHkx5bNXGX(D}d)v6hvSdJNqDoJxeyS`XJt{hDU9fw1 zeZW9th|+BNfyc+;1+Wtch($*F$^;31nFZspx@=})p!7m$r#2z|wncA>xAIqAd z+f)~$&LNJkOzo%B$4z;L0i%l!3hGM!AbFiZ+N(ecP+tw%^ZX`1&pc9b_U!uDiQ$uS z+ZT;i?SXN{jp>Ka@*Jv|sg)Cf)-f2LN-!UaA!wsd{Ie}q7S)62Y1bvcXwgY1I%JQy zTqls=442PLg}SHD47|!dqQ=3DHN!MG#CpqdlDXoC8h4&S@e&{4ob_9LMo6-1C}ucvZKdcU0*nu2T#c z@A#hV@r!+(Hvj@e)z4;D%a!_k4l*1nUKf34n{%E|wvy~D`3^w!ozlQ*YrUolmW_>( zw^sbDwXt;Ac5Z~d)Mh}FN)Wa{j=qRo|HL2a;0(Jq6AZpv=QD`1PJQg!x}Xu;8V-4d z1si-ZaZi4}n}e1}%w-eGHc(XGSk_^-Yo=(Jh*J(q>{fs8V0Os_vG-O7l#kj{PL{|s>2LN2px2m(ZJ5NubFrU-kRPY79vPH` zPdsF5EQ+rE0<2xFoDTnCk*=V;PW3xO?3Jn?tOQ$aAFqbn3T5mLtJFphwx~b#PfN3b5PFVoJ7>qHkV~I|9vCZkg z0$tcse6hc_5A8faIeSIXsrSeJ^je&ZCW?+C-YVa-eat?*Z}onK7JdK&c9PBaz%-R* zEcybW_>royZJ2Hn){>3U42L$9d5 z_zY-%66F8!@;XVhj!Ms#9Ztplyi4G#*gMrspF*w}$2WH0CRb0V-QL_@RR>-A;R-|A zifNyyxLX<(h^p+MtCdA1wGRn)IV$mD|Fe9O5`ASz3q8Nz$${p1a~DjM>S zFhAoK&_&_#vSH?UTYMcfo)MD5RH0!RygByL!-8>Q%zcTpQ&?+ef#PMZ1eE`=_>6$* zxh?a0mX08}3@*ccZ2r z6p0C=Db}IrB97!CBwZ{9@7$9+d2Luedb_bBgPZ5}7|icuyQkYlOcu@ReHrY(et{Lz zF){Ws`tNp0V(VcrA0?*XTi%_Kt#BIm*5|~Z@}}LHsotM{RwCLw0K6u8C;w|BXz%Xq5q4jOw&K&(iM<4HizH>CfCo8@}eZ5t?G)> zaT+s3+7>=*dKfe3jA z)-9|s%&9EP8`IpkjjIlzs&%CRUfAw4P4AcRLEfe`s@1DNHJab9p2BBW%~mbUJ-)@A z%M0{bs58qR;PnB-m8xzj&EoJl~5)lakb zHIsrBy#plncc?dAKgynKlZ3j%d3#71RQX!!&N{BCSe7yl8pYJ-Jm|>JMHf8H;GhvG zy;tlFm|>?Fu4wp!cMRyC)|Kywor^peowg`1Ca)@a7fCgCpqU=A;r5Z-HMmCUb-<}t z|L0~37d@vLNOHaS!ntn^ojsX*q%3W-knCin$vE!wwl9ik@#MPdMeynGT1~`^mf9=L ztEI;M)M<-$hyNQ+;J5D#HolFeL$9fla_SmnBFC?iMCUD&qGb!BK22HRD=qN>QG2Ak zGS&bIfQN;R!l|SKV@o5fv|0S-(mCvX%jqw!J7=>=L&UsX!R9g1xgmnkjIUW(7P&AwHGNgGFMN6*t z7_NxQggWh``gAwy_Qa00hlcB3?88)3m~$@Sb3HjJ-LR%(QvIK#TY@^vrJaWe2HcAz z`KGQ*xXir`q->P<;j3BdROx!J6wQBX3NoA4QVb%*L>4?(zQdj*9~E?pB+D!0b_TAf zkB7k4toF$-2cm}+5uerNKPXMnqrmh41L{^o6bm1ov>ISjCo`OM#*JB*h)naiG!Op{ zOHhu7Zlxxl5{|7uzYc*bNc7=cdB^!=8QK4&|4`H!+(6vU67OX4vk>*B0Yb9Y^udux z5zqA|(quV{ou!wt+ltbV7l$i^4xWLD@`psct4+m^e8+O~Bk}!7V5tvge}DRkP!%&o zB~pg+vVt`r5=7D)P3%d|{rgQD2H4x1LsB=J2-v)X)XB_ofm}r0(fn8FlrKCc^8A$K zuzxPDv4+SaXrn>oQsmxC&>eSX=quc5=sVP7h@rE=ao~XKVa!f>bI0A@pJ#?+KMMP} zZPlvE$m3L9GuQ4;?ZA$*aT`#$s<<%w5Hd4ql;wby$Is8mn5F)`BkTjpn_QctO{Fd= zG}){gfUri{dCa?|Hd8mf3k;yoq&-fPf#^S$NxW(7Skd>rQzuoP#4*+PlqL@J)1)tW zcpsAw+mqBGebB1&ks(?o@JlU^t0#k-E_KosGby#?jSPuKzP+GiaD%QX4dO&OS_IPd zY5J18#%mJ%WRjT;OQ|e$wwRL~9MR&6BAmt5qxR$T1}lsI4F2UUYAkLOMe(T;_)D>3 z@rr#`2%mG>D3&G8JASRQxe{3EO^4pNB2oMSuZ@}30}F-hv7X!?L%Q$CMhXcBM~X88 zNr^1--iNeldA`wp$M95tkkT_$mY++&>Sd0gSm9+^^Qd_ zl>br(>H-*I=2Tw9dDv+Uc*ybZk*;n7rdZBD$>Ex_7v*e@Q3}*c%Ix%8W!q03x5SU; z6gO08Ep&e>BWCN`=uT5|@b%YyR=p5`@}w1#c2MsGR_dcHfBaHl|RC?pVj`$&`nUd-} zya_M5#cqy!SS5{}+7jQdL@SMz1|t@}pScFB=if;O zN)ATO-^^|;odYk@!9^q>^J4~ag(ZsF z#?a`}b^tfmepyG~BKd1!)Nw&|az&snfZt@zqOrFdm*Jm}D0pk*cEX za4*QN5;&se8a6B3Z)W~bT8(7`+EX(FTKtAHoe;oByrbef02h(-xas7b*Jzs z*8KZ_;}$>~=RKS~Ybm*sLC%C-vb;pADcZU;ag23YFZmhK23CQ3g58nZ$M-Mwnn!Sg zYi=;>a4Sb%cmylYF5E2-ewr7n3ZhTZ8zm%PtfnYq7u*QU>OU+MR?dO z`s2oYy9B1lwk@6q*dLpvSsab7#!in-gD_A_=YLyJtSy-M0Uwa;$f(ZR!q z6~q>A2?k;-2p6t_r`&Awy<|3G4*qavtTSA`Cfszl6_^`iLi6lAw+t6l>?3N{H38 zs)dc1E8;=MkB~f3qU~pkI_hJ?#yd_HX2H%caWQ@@S$RxCiKn@dY<*J^kpXvDre)Qe zvBP0iu?0*NGav<~D>2>YaB_|$yX_W=*X+VEV`crYT6%v7?O&Wf%&{ZzMlns=fs`$a z(=MP}VsZ9M9ptW6L$P^Vq^U4(v}{Otr=g#KoMkm`tSggf+gp$f;L5&kJo>?+i@;KD z&iKh&KPg_}db~GV3$tRG;u7Mp26IU+h*}1@Skru(D+)(`je^!nwF=B&3MVjl;*$XWX1Ai~e9jzODYIfy6d{#Px#p>8p;dy4CcZH}xpPl-Fxz z2mEFSO8GX?Y&8>XU1N|Fjxpz1tdN)kI9BR;RE37OqUQ*Jr7Sqippc7!p5y#FUQM{t z+boW}3%N&Eiy8>C%;k`I57&B$G%`Lu#;yVUa80!@G>KieF5HSu#vy)0q1QJsiGtU8 zD$8|9Vd4viB3w0j(p7`FPw2&{0s)JK)Sobx8glJFjhrFBQUNpenf#@ZZq z`m@(z1^W=knKqBqx^G1K&i#*n@Dk`rMT9f(@3-gG#z1=H+V{@`Rqhw&4{I&~Q8IrMm|GnZ8frAM%5sYktLngim|JD`3~^h3 z6j)dNz76FQGSgEkn*KHdb)-lur~_)sgdy5YyY*Y-u+!&jpwl3Ps+y=nAs!Kljkfs? zNIUUbz|9KH@B5`^7EQpFTYW_>L1Y?SDz&`4Sr9vH@+dD7B;{ZSRWVh0L01P)?}*2hA%cE3H}1GJrJ$5 z$ATUI()e6jQ8q{?0lkE7%)P$Z=F+*|1Ft&O_|#LQt1i9vkH~(u40ulSWS{op_4*w5 zX(4pH!mzR+V^8=}0t^of#^SfIUa5sT1ii@*Ni+kS?xX+-RcnTKKp&;eLAU|(Jn42uSej! zR1nQegeAv`VVfL$b+^hUBmPpaY`kN@T7M=s)dKUH1)bq4?~?s@R`nAtwb7G@ zh2jy5{C*~Q7^NMm>hVEWnj>Q4C&+kf||M~G1|Akc%K$? z+j+%EldztxTKyqUeEzwW_v-acW5p6P0gY9rQ^?M@;~5ma13?qpST}GLQ7>UTTgyB= z8<)jec5!uMCLIipdKIO2F&~Wf42U2-*S81FQu%f(m>)hafio!3qF7JdLD6vK*Dhs{ z-5yi}^&+~@Xz*0HUf9xONP9`}>6}App!%s2?h)z;^}VVyhZDB3;vNs)*#}N2iSRR^ zOki$~@x+U3v!PP@Qbbj1i+8@c*sj6;Ts7n5eEsuK6B7#$UJv=>){f#If_agP5&Z zn6|s?5twcvH4&kJFH8_M_q1_KkJ|Z#e zhs$INZ^;q+c9MiNzgxMtN^RBEl$ni=bD81-0bXI5G44fze8wWbuZe^jY$-fYI^`Mj z5-EY1V;WdXVTQh6mfRvy-7|c zJ=jzt1+V1ZnR4ob-yogdE-y|@b~I4^=qcgvxrglLb9VEKCF93^Z1DG}Qm5Kai>>J` z=1kjou8rooxnR=(>{U`Ech6UNpr-rP#a^UxMZ;QpPc`>}-nTKujn_viNdMA>=Y*{p z)X^xla7v8;19<1QJ0<$(?2?mgx|G)9KtDc&y!$CU5#$L@+N)Rm#ZGz!YzU7cBv#|( z@yrBS?d|Hul&Ds*dhtv)fMq<%?Kjm& z6T|EY^bT~Jr$pa`d^)QYUshw$|GPlpuv4sOtShn{qtUum|CPwV&0(;JGN%c~P}E~! z46EIFJL~ES6^F&-JjYBAoEd3fq+X=%rfhe)xaRetMEZH~Y2 zULCtkBdg~kwm%6HJKJ~rRn9<+%-uybcOF#sFT>*1g=Mb;W#LD_i=jAK$uKC!Kmz(C z<@#PIItzUy`zHH_<`b$lf?y5|&E*cXPnYU?aZUuhe7LbSV3cA+uYmM6wQ-()>mZBz_!398{> z5tr&DzvWUW)9^Pi4JK2QbkosKN4ueTf`M2az1w{E(wfrJqrVZUkIf>U1bGvRyn;_ZXzMBD0n!<1d(YDGW zsK;2pb*Fj2gIV-lqgO@6r(L*Xx1Ta_W5bp4c^h&Q?YskC&CHa#L#VJOt$MdTW5m}f zh1#)}b2Sf5qlnGL)L>;FuxsvXAx9`;pXZClK8djqtYGW-Hs-MiR4D{EWlxNa4g)BX zvQzPC^C&F1PDBDtrvq*)n)V0oPKsryr1S3h@00luU6Qv+v6X07zZE%v9ksl_j_J>x zWrR`?E|a-8Cxqv0M$&_(fZ+qB)mNG+94k$~Br4|LxZYKj%BTKsHlf>~FoZ|XXM2G4 zclhqSiRcQfFZc^76mhmlHL1Hg)2l9jWRk}vG zQkp|(lpo*a*A8486^8s0<9S6Zx%%r}t6WK7qu#6m8x@o!dLqG}PPj5aDbsc_jU435 zF|Gei0W>^Vo0vaRx{##XzKqejy<+vsHD)Gx8S_>_^j%<`6gxHx)g#ShmnRi^WBG(e z)4pJ0(StS;+tebMzz8L-5gb5soGJ5V0^KRN6H-*x)wvX$X|s(Sw5pYDt7jgaLoZOE zRACC`Q;FuSLkT4(xb_FZXtgo|6L4vk?lgAbEXRX2&X;E#{VxCFt)i3H|X(C15f$<3|T0CMmnqcA{ROMzEK4dSnL!iYRMX6LRgfaXjAhF#?*Y_{rmZSOJ zb!Or={^g%hc|M<`FPuDu0$=G*e)+XEh9l%9VxI=)-P4HSaa_CKu#;Tw<`g8|eU8o= z`SxvGr1B@e_vPPoLhMq;T62NhWDGl)MR+_>F%!iu%ME$xvnKbQXwh^j5H|47>-5~M z2;vdfzf`RmXSJju6;$9ci@g5|;cD?}KlkSw%|9NXwr6LqWK1dXB56xE3-E4iPIWL6 zLWz_Ys3|l5!jR>I9$FMq;n0Gr&KSN5d@VQEl8dz`>R7OTO)_s4vzMr<-mWtiL(HAC z_&_W^newL!1f&#O!Uqgn{sztbo9=_^nsQ#et zT3B}v?aj=-KMsA`;K-El9dgfq1G%Sf$H&t8LZg2UMGGsw>X9JdcnMEdY@l&yc6v#I z$Uz5(kSSW|f|B)!d^&=I*l=cfvG>w#*Ct$H5_hR78`_ct({>H1b^hgY;sJElqt3_r0O}J6dtB^Q(W-cSpW08ZpzS@$5mJoWwKcN5oTfkjbca>fPFG4$SM}R|5mBkR+-Yb>cNI=R@4?g zimv2XLZ0_Khj?`L9gpkl#}boC9o&C+5HgOB2MNweWREL)ncAa)J0RWgF=a}Y1(h@8 zf&@n~D)m0~s4V;C1}rJ}^^RJfbkZ>=PN?)GrOv;(A2@@jQtU z^yu#9bICf^(Q2s3?;nc!1a8>@RZMakl-btD1J+f8&I`T0Ybw@MyC-oz0=PXz9=OC~8)dJx~+rA6eKF z&$3;I@tl`qg2>;r-Tvu&(3BX1BVwrqS5y*g-ppEmE;`>g?GGM9IaKdROqWW}z35ZZ z_dF;R`5|2P{n=5Zjre-Z=4&Et!OeYw{T7QU@MQOLfPOES-O1y1d|1gj%CD1?Mt}1} z@-tRZJ@~5HxDE5vGwH^}^CJz*$6~tkyWiVOzHg{!g?c;($?&sSMvbcy@ldxOYj*CA zN{fC033>Am3TG}m>gY2-R{arR;V=rFTsI*#Ole-fgc!o9f3 zr5-=hCvP6>)1;y@iP+C3K8ZmM9IV6Nx-2UDHb%LGNRapY-TMuO6tI|4Sr$vbQcn(5 zcHpU0me_A43#~@!6BuRK3W}e`7kTs{>JDCv>;&W1ikF(;@dPodrXFRnB<%%3wc#Pj z<+B`DT>{If;WDLfRD@05Uz+{q5WM(C;S&xKE6 zK%sKm%{pWE0NpowTa$EE&wV@2sm<4F3Ti|EU@1@w!H#RD}*$_?Tju*G=< z+PD4i_H4o?e}9f3UK~AQv{mP?{M6!_JKPb7J6T`2*PCpPif;WVc68;sIp)8$Et+`; zf`C&asPu$vv6=X$7G)uQ&tZ3Itw+iEurk_NyeGB zfBC3gEesOR23U~HOxeN<7esk?Bo$OI7Hj%jviK_W=W>D@`Id7KGY&&Z^%s<1v16g( zIJ=&pKtI>0Dy%}_+H&Stzo}jcUQb_b6pr!@i%8*i1s-=xuL|l^7QOIX^Lt73@1h5Q zUGephoIC27*=e|UC(wkFuF#Je2NNcrJHYpO$N-cf+4}#ohUV;`sm~GxWnr%5;8KB< zrJ(&>V%;h~Eh@9%NoyK&cjNG0?I&`-a`Qj=)DJJXJQfHhUn_F(FBV!%owEw?3UT1< zM|X}AYdpu`!SurmTT~;0_OHd7yA~Y`ID;D+*!@`TXgsY|`*TCc0;|FWrp#Lv$%VJR zI@Ld9o(B1Z=giLG?|0InLN@%!pLE&=zSufN=e?-qcc-QJn^r`|h7(>x?b`ctrgIfc zt@?-1S86q-Cu^WWMw4W&`9Ptb-x?<~l7d_J=H-}2s4gQJsCKDW0%cUBtKR~p=hK81 zGCCImBOUeDV^Uo5oz4CuQz4Sk#Ma zc?S2WV0F~GFVE{CNLa79|8-BVx%0jV@oJi$UEBS?(S>CDBr)0GQnUFE`7`nAbJq|! zrPCf6BGwp~xaUJoih3}U z`lf-pFaqJXTXKOLxZ%MjXC}4_hR^hFZ01QT;pfI>{r>X&YK<*c-%G+KFfPTGBC50M z`=Fi+6d%M8&`pC^r?2@rlf_M@ z8NLB2`gg5Q1Yu&0E^uj)1izVO?JYCZbV;2e-Yo|-M%=}8st4f2x4p|V{}?BBXl!}< z!&j%~QKIGPfrnaMRpm}{zuF&KP%L$KvlVT5AZ3Yav%^cJ$Bz0jL}D~o0wgtlRY=Z7 zGQb|CN}SF6WfMP=iw5D&>0Y@pREm#OK$4)ZAPO6*ON3*$b_61%e~v|3=$z_JPC5|+ zi==)+iDy-y?AM(+%*M>UVwOkc_gH!N6GKG z@+Ane5Dh;SUs-jbn%VL;FB@WM@BTpL{yRBJ5t^y`Iq4vgWd73{`4%Wqn&#XYcb7;O z#~7KfjV-mlW3%ytM^&TpLt=1p)}HV>gun6PdsuhsD~0Ep z{KwSbIb9g?*TtxbN$D?Wp1yv(L>iedE2^%b=2qr4PUTmQ77!>TDMQzDsxFvMTTJs% zqSZhifDog->aP~7HbS(x&L`ze1w?V0=$oySH8=# z0C#Iw5&U3I5lSAPN;FSl%kY40YE+xR3?yqJ)+3c)Q0?yiKGkFNLmj9moBFp?TRXn@ zHDe-LqpC|TC`I=SSo}(xKJAN!Z@zT(?-I?h`Ob1^-=s7h*(K^Yb;G(f#L{Gke@4{E zjSseq367H1yJ}5moETU}f8EJl2D3A4e5Cn=lm6{>?xi4`Fb9&+3dic znq-)nChFb(fp;*nT@YG-&20)JoF-hc(i98-%}2lTxV`kWpN@txsCQ%!U|OV*A{?y@ zdO9g#>Zcq;4Upyay-k;gOphY7eR)QLuz?9B{;Pq+S71UBkPh{#1t^@OY}CRV0FcFe z+AiA~L6Kxutx0nv|I&)I453=t{U|_91hXA4ND2*rdgxLnv2%cO`YrSIz5nv7FQciJ z>0PJq^Xtd4S!~>OJ%9IzosZSB8V520K8@^^35?ATz)k{ZtfuHW03Za6>Crv;wnrCm zz&L&P=5M9W@d4~qz`Gr9%C3={aYG0bU8GSi_Fuzy07V*k`gQ&6nNQtuF!Rz^f3$M} zeEND8j1@rfbeAkpG0an;cPHCCqtp-i7t6}&{1orXfTAmdeFiZ}6VU->O6k-8hzhVl z0)b)Z)PTw&dUFOUEL9{$BtrW=Ky_IZ_No{j&-G+|i5&Fsd-MiZ0QwN6YI`7S3)ajFH)J z{x@F%)OxwK=_70o2+L_|-az0YI3N3my^e(f$XbaQ0PaV{rY~Cl2XL>}G3^rh2XIHb z?|0YN0N{>((mg@q0C0E1;$6t?%=BlIYyw~mzWN1Ph|(O<_q*p>q5XUnihqocqBheu0$r7H0pKp;IJ^4gOO7Yvx66SFZQC32UIiDx zQ0`IiVgsc@6-ueF0$ARai9JHnM6gqu-F@nzigiUV<$4HbGJZk+?+;>#`Kg5lB24J7%=$c3GLeN~_-XYWn;Oc>=Puy3j=+0>@R$-8Rw;@%-DH|3A z$nEcZ9@AWi!v4O4>*j}p==kAFiiga!3o^H z12HJPJIcYNY;Oqo4#FxwCUOU$x#l&_TLH*Bb8L{?fEYm6?wTKZKgrE~!TSHgN%`bY z1Cn}I-=Y{*rTaR}a#$b1k1fEz_q*>N&?sc@5i{Ezn8Vb%KK}vciz4*9zn_64gGx6J zA|kUq{XIV+fB<}6EU?C~RJ_Mnk8SQi=I;8&|NHA!J-XvZNQDBAi!EY)Y_fq9u6|7C z-8r-BNZ#(tA54)?f&IW3@UD?1>WMiD;Dd`HS#(bWADqO{d!3(va#tv9*P7D;bZ|1$ zg_8T@e}61-z%O>V2I{|8ugUoRvqmzESQ%9*p0D5WqH?4cl$k#rJWk3pl?I*)=i%@F zhsgM6%B&VOQe)=-GyBLtDv={9Uo~~DA4u%nB=?6|78tTN|K}PK5_EmMLAu$y3R*_> z;KErI=Gzq1xJ6nGioD9qolBGB*!EHXzbHfgvCv^h2WmXbqQa2deZ}yP$n9}HJn01% z_#QFbpFK1JBDbPO`BET?cum^d{ubN}axi$w_QQZEg7T%DMlcXX;1lcL^?d=>d)(e0 z6X_lRz5Cd{g|WZ-A59$Ef10@e40r!|1^-hb{wJdR&!PFB{`3D{>8k$+%B)*ZA$$*X z0p6vzmkqZ)w4lLkM!-@2@}w9pUSNWt1og{*Zy~RAfL=(63|OW3hD_gCfjZ4JLx=4{ z^aJ_Krpt67qapqs2-lK0a7sLWXz{bNO4B0nd;=4>T_pb8JrueJE}Jqx72=KK@q$q5 zqtXXYA7-lN)+%3^qu zNRPwtR;^XsW?)3Q6$spCUReG6w-kB3<4id$t3`4$6zRnmzTqg9_8IyL%kkGAKE?Sy zAbMHd0&(hug#jSaNaU!TFsj&WU~>kJfrf`W^w$C8deyH^KsC7Q(fseM+4l_i%;|KV zO3#{*7zFHtk9Ut|xPSsAJsf9>V$FE(a`D3(rSCTP#7Z|lz<1@72%ilw}D2E+KEyhmp9jZMrVzu1U}0>uC~%G z!4v94?=SOCK2t%m2q+oaGApmu|M1)T7KjaIgHLeE(P%S2;G8Mt{Gr{zfw7|_gjhyHXi5yZ<8~)0{a1@72hzmVT?D+E$I_(Ah z>^!(>D{&FWAY*QiqRVv)vUX$+`*6xWOwX){;sF!4E$%mI{ZG-d5Adf3N_%>cEpi6$ z4n`{V!@cgf0ENvV6=m)lDtU`|;~>WadC3n9Fb-FXQ0oLQ&uKo&2r&HiA6Ia8r}(mD ztTZrI7xfc?#QeKoZln2naogZiHvNvgKM#fxbfSb2TNj%}P}kpG%*pSIJhv^%M%A^g zmR(09BR#i_CzH%llL{-w-c5pDgTTHqaY_V$_V`2(IvG2{HWWE3-Z}yD*9_%{$p5lj z`-F}zq_Il+LZjhA%?ULtH4VrBI$o3<4J(>m?lyQ=HsMf({f@!attOC}Ca>QM*jkQJ zrCp$PsRCXKlVqFvU+W}_?@lTdr{=Fg+WQ})%B1+|%$sL~#xtOYm9PyaOSIGJ*A-jC zT$c*U`X9DzqxfYopFz}2)%#+^!g;wc_ng-V5Hsodo%5%hwOdAdh1H88ri*Wq?D9j| zXF!K_66Bi%$8MyEPQffgOQ4D2uzC)&eIxLMptKlF#WLM2YVi8WJ_GFKlRzDxpbIkI z#w6db{b)5oKDc9UUz#67X8D6-aM@Nnl}&Gi$VM)yX9NuVP3ua~x-mmd2Yiva)-99e z3DUWyNH9g``LL8b29XV*0)K4d<9J(x`DPF@5m;^+P)K~0&`2s^^!;ZL7zmeIT*R8o zaQia)14+-GbxN6e#{EY+Z4aaW!MukDocBApF6)FHVP##_n-hGQ5%UYfplJ<1fXnc)IgFhPx8 z3X}LOosIA#T?=B2ph)T*Q!5%%7IpOIJ{VJDnLj{HH}?eew_wr!Hry+t$MIa^nTYKz;WfUK8_;&_>7%u zkb2JwtYQ1aPI++}dRpQu9Hi#(e})fi@AW*T$Z7ziqD*YSm?ybUSibt;lj)^H>FNaq z9^a95nD@nvApBwoyG=BXpbYN0@wElx=##Epwghpo_L}^Ou){imkHTZfl@`R}8ZGrH z#LA`nS9WQ3UEu3MwR8KE4kRS9gGY=ttj-|z99ag~w8HLC*DCPMGC{S4+N(ia0JO)N zi$ijI7mRO#A&Q!E{%(WraQpXLFncu>67!;)T0#o-m(5W2qC|2B9Mr(4lGO`z5hzL& z(*YatazRRhc1}70HpI)&2x}P&@gmJRIzWUhpB7BhPU<3`;FlJqXoDGc3*7l2S?%4< zn;Px8=Le-uj>2A|!Et34F0V+Wd#VBTP2VriTRtmpS*}HmHB*}_Ep;kjBaYqyKAv|; z0(z-nppJ3OCCsM=Jhdac27#iXbBiqP>{(^=9k#Hx(1VPDAcgm+iA73K>)x0g+>!ZL zFsb)DBT*7eytGSy2tvR3x zv^|<-5iU$FU$A;DbWJN)gX)I0wI(Cn)H?buKVlgzS!r2=Y<}t1pbRmGUIL|9jR(|7 z2h+1X?P{4tRs@lZ8UZ#Ls&~XNo?l{SZci+EWy|Xd<@yj+KW?yWFJ=Tex{{8m{MF-3 zvOzAg2OLi2Y*cM!KVaE=(9Ps9?(4k{5~si(Q_$1iZ-c>?=F>4h1s+S+RaIbk`)Aqx zAW>`B0|-b#Cu*K>0IBn&NdkZOhaYk354$=+BP{hd`1(M(s}0rrMp948n~@wkPRZ3%OwcnF(+vfd&D zkGS~M!@)AS;Mk29#ISda9yF?{S@8o`_0=tvb+zFMm_GAqtED$Jb`UH=)F=DEm6TNb*0qn7T1 z;O7WIJ8%2=v7kCI?1LFq9QQolWRw7o7k9AncEz|rJF}KFqutxWEK_m=vm8_e}C5NT>4o1+G=C3G9I5peGevEXciT4@k;>7`}YK!j@q-)22~>5J!6M z6HVzFr=|uoP_H0N#h2{OJDx!zLn36J50zfGWnmU%k3;}*Nw~|7=i%>AFEm!&Goo2$wiGPGH7cc4 zRN`IkVsen*NU8ml`XT z`fh_CHh2>vqaD69MtghK(UUp63HGWF>Q14!wkd2`W$pRB*bO4%%vSaZyL8KK2>q?{ z&t5bKKEdlXx(O0l#Nt}GxEGYP81=^$;Uq58@5MBmm!@g1P0vj~t()y{J|svUqsUnH z)nIsui=K8c)=E)uSgBZlMqG+L{zIR5G9G_j(?;b?Dw03>ZzLICJO9 z^Q?`6`Nu~2#I^(~#9q!Th~F(fed6vU#O=nAt!77Ms=D?{Z6mxg4IaN;O@2;4yBadz zqvMa{5Oah4YZi(9U>6e!Jwvo6B@3bX4W7q|30LEa01!$i@VD_;qB70*xbFWkP}_+i zQjrJ?xc}BRQ4^cfxYoe#WaERae&s-=Gk#+Prkf~3xu>S@0pOxWp5Zc5Gh5Cpu~wrl zHEorZoY$D&4EG)g`w!uZ67fww{qrbxtpOEGKc4hsn5UZ}TcGUE7rQz%LC*0Cy|+p98_FVKr;`R9g*TP*Rl@dDpjI5Mh()6J3jKJxIH@nRvt3u;AQe9;qY zOHRM%3A-}Wu;BVeFsS!cIq5wAMc#pKzD8ZmLAV(r*w|d#Jc`I73NbCmhV}k7&ZP*Vq8>#VwyA*8`!y@oUgm8*18fdqpsog(U;t|m77xdCw zoy&0^wyZw;PK3b#OtItAJqsOG((j1H3{4(MEap>-lnA9!s(4?a#1}zNiO}ghE8BfgCD?};vlMWLlpY&z@bY_BEM=x zVb7Kt(XjA#v+isn1~;S{7|ZI7=TT|kKpU5I4KpVND!X+RzDkC6x)choJzApt=LT1w zM*{iWLphV4Scyp-5l>h*T%WWxhEmX#L+4IW*}k=>;9xgv;RHg*HYqNg1_QkIEYd>n z+Ro3ZnrdS=bl#dYKC{B}#Q{Q7)IuC-CZgyD#W>I94J!G&>DY<~4Lc~kN;l9}0ChIK z?%S1j(o58VOwuC6qV^~!=M>9nd!sRRku-;K?}9qtY@1lN_V*>YCw((q4M&LGgBVno zu-w}a+fY#AdGe}?$?2BBDvKiDYOd!Q$t>r3xd-xc%o+Gz-XYT^Luvwdh7n4u=8~Vd zjy0Z-zep@)gCHmD@cI#|_%fc%@~!U2UCs*{RM%+!HG8u=W}*FM(c^(j*)b8vDl%>? znFzPhenxLqIXdRKnon%kvPYQo#1pUX#1O6|ziytWvpVn$659Li*mhqdajm;KBRoo> ztCQFz%-1M^jI$*w!q;5rtSy3?Po6l_`zImN#8ci@E~0M)$-~({G0=UKwH?_o0+9H6 zoR2^&SrfVN6gf7q*m0Bn_3!^IEpi~W5_qDk6x$(G%%0n*wNq-V(4&*QJAn)JfK8hw zTlJoO-*Hy$CPR|>BL00P-&H{3d=N(q*;YUe@(ZWH-?B8q=7nfXG~1;(j&Yayb8E{w zzpiLfhCgS)&ZbMWU< z_k4*l{d8|l@`JXT(AU2?EgVz%-qpk0$p+|`Do3=%KFOwss~qp9@0HiYW|D<%sa=Q^%$X`e0(D(;P4GM! z3qnT8K93odQcRdgK+H?PTT6g|^s?~7k z2KE4FHn66ngbPuhsvFNL{^4?E*8#wLlJhyVY?aaMn>HH~fiyS`R@dxa4phXhiU0fB zQIA7#gr0mRGN!ksPqWPz-gYb)QiL~)6S7(+dntrl)rRA;`!N}Ie zSWC9`?!%MR3cDTwY6B|vtEL4^$h2D5oyt-oysHgg?n07%dLMLgA?rf}gP^}@k1_NC zDd-s-7dkazK|W@!IV9`}rXA~e9JP4A*;)Md7X(-*AE}xA84c&G4wpv%=E;IdWHsE5 zMNlx&TEO2LOoOZAk})$i&m2g^5lZoGQ2Xas4DlmX;%EOa$;-)$7vDM{_05wPbrw{g zea*FoG)$$WYuw_b^}kUer!~SQRl3{S{e;>%BT{UL-=v2>;^|P}8+Ru1 z?v;1+9Bi(SZaI^N)-QnK1yyRP)opYAe)8;rI9kDRTzG&ki(1VX(dI?rC5}nim|X!; z7}R#8Kt{vsyf++0kPZ=d>XO&Xz}L_}y1#_%PhXVn%s*HrudVL1Q<>l)K}Ii5)Dzqt zscmo7*8NyZ9K;wlsFHb$Z$>4?x0>t)&XW4I1hqj-INDkXoaAjUs*zd4# z!}E_y1JuGQ^V+s;GlTZSS`SO#Zf-^R7A0k1w)VIpW7MJw|c_i6M^>y#bBWvWe9mldR)7I=H}?MWE2@AY?sm!)-DMnYEaL!5Y8+9R6uVjQSNKL+ zs$;mX2*uEGNKEPIXwXxe@z?y15nq<9R8ibbO=szSuGFqdy9wq!{vy}#ebdcDgjFYs z{d4%5kCRbB)aXMfGQhc1#!0YK@`D~+#XMN6c^Jc8*U#Wimp~YonZ)Ne4tr;uEL-D- z!n@SuG|EXY)=0}$6JaZ#+?WhvMo)BIg07l^Aej}_D6wTWVVkHDUbOEy2yjjxRqat@ zmY(^=1gpBumv`@RuAkKeE=KpKjd53|j@-cTm~qg>^g#+Tj3~x_+fb@;AKG|F1sZKk zD|S@$6ESMovvW*`e)Zj^tb^A5y&`*we;0B8YRd+j9qd88vH^)?oeI?V!=CO7wI9&= z95!S{zl_J(*fdbMDyNZqzFq4H<*dOg3iInH)%s$FU}Mf~!Xq?O{o-`)EWVkcp}YU% zhMjrtg{}|sf{LiUc~yMZl`$s7$`Ah6a%5MgoW>jqdj-Zhgn6vn2#@3;t53_ zj&n1A#_vJBS`Fq!Rbsl47sd3vi zn+Q`#hV}1@!5GJpj0P`yk{4clcN{NAMZyZHP+Q-EjXHpmk^WyK!R!n4&d+UfhrC?c|U! z*h{Ymk?JI?nglStF8Z{F%xa*UdOz`Y5K~vp&k;{!yy#}FY{dTB3lvh*P%HpK!$W`x z^-_Szk9YAfD;hA7BWz($4eyhPWEkDEZqc=haw5c%pVOf+wu-WjsYJ;`UYJwbQD)_b zVZ5t<1Fep_pzh}Pr#8yLfMj)bdqN;Z<-;%HE_Cb*^4UApXUwZC&8i$t>N@grM^q(e zAsJwH-7ID0hkJ0X?`w$(DI>VvgS-@UaQy<)Q5s97#O4=c0{QnI5&zVMH;*Xz5x-OI zQJ+E7v@01YW&7lRNkE9zZC6h7Kuj43Dd^jTLL7i#!P(xaMoGQy_U1CQ>1ACN%@omO zw3PaMJf+rlalIFOK02kU=33pq1xs1!?NIg9{=zBBU}{*arbIM~2uF-ANp5U8VWBk^rI~_{ z<4nzUepK`j;@E z{Tqeof|KBUc#p09b-uR|mFFe14-j7fK zrrm~eb~6_p5c|2KzTqn@MQ`M!?ltj2hQUx%Kdsr^(8t<-4l4)&d5ywe2gk4q>6-8v zbHAgkE}D08IyfKP>12&Zu^4G0PWOT4mZ-`8H{rD?@?6Cp3o9yjcvV^GZwPL?O#y_Y zCBmYOR-JgOd_<*<)nvJAE|qLx9;OLLr+~0d5|!~AzC>I^{h6kiTqp^}2orKRMp5$l zLYREkb^CH<2gIj|FYPvd=6tm(-P8Vd;%8J)N2JJ(+rZ%P+hVcb+p;?>5z9Ns++X1#UFcyi*`KO=Hy_E#_F1pcDHEiz6 z*MW$ipE^V5M$;|xjWwuskMr16B$DA^jf@_LD+JDqSAM~Qmk&+cM3gqvI)Or!YrtD) zll?W`v}jId_&SXz3DGu;Sv{nz0o#%G2&mBaR|DxG^SgIZRK6YSJp@8FF-YF> zh>Cj2w{j+Ra7pAwYMi%wSY36)#YIx*ABD%0*^_CJ{uL;=wtq~zEnTJWAnB^^8- zeFiq06JXkIW@ksAGFKhUX(!U+#1*zUqzScM<4pk>bJ=ov0y4?sm~E8n1R^^Bk;VA* zf^s)lit67b<)=r>94q~<^l%z^GxlvZOj?y<`n`|-+-5$7W3tBt-}>7>$N7@g-+Sl3 zFAsho&8bppE~}w=h(D085B3~?K6xbg_O^p!r3dgsKilXTO}}q@ z7Jg@lkY!vQU{FnABv0!HkwZkH7>&i7Jo8Q~^b&a7Y?RQ9uN@Tgtv2KSM4cU=YWTWW zqAmW~qUg61x3A3dz1qi(E`;y{R1tR)g&^J|>}Z!#d7$+^dQoef3Muw!CFjM!hud5W z%dYVH%6WXx0{}lGk7`SjF~6-*Uncrg)~K(hZ_(yU!x(A5$y}Tfq2U4npz$FggV{l_ zM2j6xE>}%830~hRGpg6H0@2wcx$og zcupD=TtzH#W?;w3_30-Ny1w5VG$vE?tS@yb9u;85?h=Ar6qrY9=-9Pw0Rx$*)0mc7 zI0wTZTatsezply=DZlc?OlAddoqqlKSf!QqYnB>o6EQ`|a4!A&n|YyH6!R{7OHf0m z(~6}lWSiGLF(|A073<7q4*)h$as$qKRi3}`>uMTT2(uBeS-r*4s6S)30u4s0v7w}+76yf-;LSM~5!$mb2i`~=g-{ppHV(wR-!tpI7 zm_w0U$O)jV;dKw%e9+}5PbgBfdmI0hxj53z{!A?ID?VYPu`bMgq<1|8H~WN0uS?kE zAJ;LK_`64S&aSQY=*E>0OgH`vHbg$1M1C*OLkqiymR}C5eW8A`WHL=GwXnku8U9jv za~5mHc`hYf5%ztkY9IZcJy;b}tU<6ro)C-eNttLfEetNm&84ey{#w54YN_6CFxvD8?qR6NXesCh zSh)vtL#Z31>1_maVW_1UalhXU%@`La&V*#jP5glDnu5YT68J2lBdbYOiLXK9t2`f; zYSbLOtbF0)C`n}4+TM@pMsiP%{bv8YYb7ThhbcGga-#$)H7 zyVfUh1<5su$IX1;M8u6EoOEp(P3U-puf!1Jo1d2{8g;|nL2V4-u72)K@tmaGPWSj@ zG9R3l`N5pgmxMXyIsSbdwycJeilQXe5*BIm{wi*H#^Jn^p*GCPhtz=%M;+<;=`Gy! zZ+7p%XXRnRcsMU8^115IjO-oTgpbT5&c}XO?Of1gbzr?TbAz+$!iR}t%uc$!TqE+i z#D6X=Ul)UmucS%mpKXoJJuAZD5o#HBs zsRa$&cj~X!zWI&gQrr4WmUi!4@h|v?*1}#IGE>fQo`=XoM5@2da<_N$6l~@8JlB|7 zoBqiB|F{4Ku_@&JFn3FSTO>g&D4WLoJM(EB+CL6}tp*u)tW-n-2Iexr$+Gn%j+o#A z4TiZQ0PE`WC!REY&>`J9CN@uMy3=A<(E(Z(;|dR+A)<-1e9<3F(mhjab^kxPJ8J#q+1lTzEyYbYD@=mi*N=QUus0W^%Z$#MY~ir#K8h86tZl><*tQN z(^0nUmAmFvamm)_G4rl_$auXUtFVQZey^J9P}hA7oyrGQgl4Rwjgj@U&6&%^S8DGZ zFA7h7rJ3Mx8#tXUz>^PaqnXtema5UV4j9h(Mk|1E?w#66U$?U`*InA4O8F7L)jh!v zo2qB&$($%4OqU_S%ZFYm&3@W{caRd*-r}WpM29=oS|0eti=S~&RS&bN4w;miD(CC#B1K$K-tT+9m$CglEDD-j6^Ko(cXzZte7LaFm(0q%4><%EM>cS zehAX-X=Ysur<6J7duKXsFw#lFmO3V>@zuGUKg1v-T4-$-HISqIad>8b7Ls!p?s42E zcuAEG>L16V@>E&rEIsw3(W=xI4&c`Q^&^MHlFV8c{o&)$((^BAtXB@xdZ)>a@f~@= z&07(l*2 z*qL8OOW0B=aas)x$@M~j?>mT2^819LgMAjD}8rGX+Vv*r9gH`mVzr?pJjYb3$^ zE00S;a@CWMIj< zF;GLWPPC>(yqX9HzT3lIekUBB+Rbub)3ij_UvY4wcv&<>8-7u6r)#p|5LJRR1oAR2 z=5PEfqRi5p!D%t|`{n6BEazWr(zsVWs2!`>P!pB7Nez=?uS5ALo~AEYMiA8d z=AAdRS?Gi4{O3_c&0pbsC{o-w3}?XPIgE0Akh*H==S6r5_TbJK4Lc$vp9`3Btj3Vi ziPfBBj|ZJH)6@h`($DEViF%Ohbn}W{c_jHGMU^en2byEhDBCg$neq*MNvo97-cbKzwI7yr*14AyVCNdSE5^g3zI9$o&8{Ksva(v1qwEnOnu6kBn(zn3 zC+9^fZ`%MkSa5o-j7+yJ@22jM2_D5LPBMdqPN4v^%L-+u^Q73Z4bYJ;sus%o#hzbo zE7!+)9)WHPuKc=>^W}SGj=?Z7iY&XEhfWkeBdd#f25s9b3HsJy3NBK94(L6t{}_;@ z)AN56BvSj{SFFVBaFl$ZUZn%pexWO#)}Wd2hoxdR&w{Zp_iJKsTuEqM<0<>kL8@G1F#ZzoP#tI4Ful zVH#R^hyDl0G~#XU#OuieGuf$1HLGXcoK{*U)0WM{uhXw|Ka9V)SyruPx^0;|Enl7F zwKq#eUZtA-J@32v>#0}do@VwpN%%13^gNaKP&CcH9=_*BzkK3wopL&57vJvMM4%V- zgak*8ampY4kD-t0-|yze-<Gw@$5u9XH<_klPBeLIEvUy@7N};ddK!A>w?6u(Cfu_R$u1LX_Exq_&V@q zRZzzF95o?}YCji^KXqd^-*;yBbbPkc-H?w<`)6s;yRklFRZVD275^<0$wu^N2Q{N# zOB?sH4!ORWJpE*eL6dDbOMe0n^ySZ%k*_F~W9Rb0HDvFXywN+x&f0Lp-6!aHo5D~+ z<5iRpm*>kA&ch3B;)msb^HFTOBCjLyrVU#QIw;ELP@S@f5oBq+xP(W z;BjQorYU=NOP;yZi&U%0>mP!Dy;B%pnu$LX%D^O&7E0SI0=IN#!lXW%tCEhdPFcU~ zSF>;1e-f0KzZpw!Ka804E#OzUGk_4Xw4F&$ppCucN+m_j*~(cw05(%@7hkSgfytK% zi?DN(&Ds^t^}j|KWo@cCti5!DpLCL3DB!Qckj9IWkDl+#j5Ua@#J+h=rq%MbcuMw( zSLBlO(*Ohj?PcLaCjl^*XA=g@8s?16*AMWA?S4ZX9itY4^f!(&dC2nWs@jKwJIyB0 ze5!R?8o9d-zExKCI-PW!Ea}&g7n|C=3h~VDMiR@qRu>6lI9|BxjEz`9HRDlM@D_t# zA?p{Sn7=e@Q)6vpjNHVQlD3_JLOZKA6z9X=TOtUC-Z#}NafEkfdA^;VSCQOz4zHeG zuT&XXZ^cCm$oEBIN*qBtFH4|(_|R#MQ%hDON~ETLa{6Wn36BbCyT|YjW%*G=s{@A_ z?!bnNl!PaL=mU<2Virqe>u7()Kcka9BVD}7MV24VkUjNCd!2G45aW%za>>|i(B`4_ z7bzK%@ld5IrB}aY`-UX9>?ZbAC{i)>M(?pmWW%o|f%2{0AP>p$N0%g_TTW?Mfu!bn z^{^q zcTn)M%B$%;&a3x%>zdT)BsVemODaUR$pL<=9E)0vBw737V@7|8r9Hmz_fsnC@rQ5L z?z>Ti$(hPwH`~aU(Dl}z{cxGF=tv=5R?flLJPvqv17?z)erJTGw#AaKX{PZsAaJ=L zhAG?=@r4Ta5vyiZcz?8rb7~IHe(>xF5v+#4AvcN+>#sniClrI;mvD`gC?)Fnb8kqC z8Hd=O__y{sKW*pzSt4AJ^pL=8|Hf8-A*Og<3{!?x8_9FEvwBOG$l=vZGo;YBWi+R7 zb~>C;&qw%Vz{alneJWF(MH@Z&;qI&buq(T3*aN*iPlhm(Yi1Rlw5Y@0dWQRx6wraw zYOfVhc|W>7yMlpVKybFlPg6%arqUj7NMATY#(E=&FPV2Rcc;UJ`93w}cVU~ky55xK zG-P^T7xmj>ZZ++mCljvVyv@lRA!X15vAG=Kw#>On=~e1owEZo|lU1aJ<-qr0#M_*P z$Po#4kZdwOch||G(@`g0H1n7Y`y=#1A+ABD!%Aa%g><$!o5PDr(mk|uD5B%@^C7e# zyBi7ihiH^lEmwU#^CTXzd<8N>Hr_KyI_eq+tG#2}BG*=|a&N?wJI+OeEIRzCT#Dvr zpFlsX{&}OS%$R5AAts-)9hE(;5_ovE1@%?_#zm+jZ00*H}ig)~f0KRcs&e!rV$x)Io8Q7__<$kSS^yt{bE z^3pY|B{O!81j7!?BR?r`zAt?8S9Y1*)JtI3sfKNf{TPX*(YXbwRcpdKZDcLopBt8h+?BmBT-TPlXH4C7P<@ znhjYFo=th##Q(b@jU}5tURAQU%2%_=-5wMZ^45YK@(LP-SB3Y^zaeMjBsVkSPJ;4y z0#lvM6^v$e%Jo$e0XGE}{Q@erdN9;xxW8UbH?-a;GF+lbYl`@R%YGAC(*SC?IUNk& z_dBfQ&o5|CE+=&{9LHLIK5jiOFA#@TaPApV!;jL5hX0bW-a{vmG~H8^cQs^BP3hwn zlUy^;LeLG;(FGn`o~J~l787xfN3Wii%mOEg66((53=f2`5|7n*Gw>yw7)Rr zbQkOH_C>)6vcn46zVAF|?|STL}$4cZqnb zP`(rdJG$QEY@#bWvuR;Ci(E~xQj>6 z=X%ql2G%K~W`Q2jz&m-x(waqyI+j^<0}iiZ8y)cd-LmM!bwAxYd(3|3n;gd5hkKGB z@)FhW4Pz~QZD;Z?V(nomnAJLQpMW+zip8f`(3Dsj+TXvqI%SL$U;q`G$Ovz6D)V)|egi+O8Y0usWgvrL49SV8l+HL1;AJMvRMb~ZW z?sh|>Ram%P>pkoVbQPfw3dMy%{f&uy_Ea@^Wp(cr2Xs_(%+=A*!$b5 z+r_p^Q6!6Kyly@_&+EzkorFdhMmp^ikT~I6u42ae!1>&`5z5B`0zXmtw_Z3*Wu}R3 zq|R&b7`!5>=V&Rqvg_adh+dfK6K}RcR@*RSMky)6zUMF&=8k;UqV0tl={_Fmy^BXE zP4n5|iX^39cSW?b<5*Y32ERq?$iSqXhjBe=T|Kt_w}4}S1^hAEKL47fR9HX!DSpS^ zaKDo1hSe*hw-TE&Um`y^k>-}ss>m{X?NbYE+I_2OFQ_jlsq49}FcCFb`+wYct+hDW)pPoml)Afrck^a)Ij8q^IwLHIK{h=i z3A?W#KI4>P%Fx51tWSW=0d99~n*C z7j0k5f}T5$#VMSTUV*57)jgTGQ}sEmqzWy8D0`5TQD8(A0FZ!tDjk_$USTKSpK+3S z5)~ohQMi_ZgQ<6%r@;j3Pg11-?Io`0fSLtLk^Rq#8L2Gk7x&JOXS#}(hRF_`2|c3U z)}%JfU~ee)o^j$|URwQwHMLeHt3D#vK4ce?y0TFB>Q>_0#_!n2taXQXe;bJe2jTWs z)`Qt;Ba`ya28_@&p>N1;)Z0tC%aZIr*tD-JE~VUQz$0}ua;IpN^2YKWxc9?usw?Aa zMz9uNDdR@z^!LNX^OIlZ3fK`Aicp5i#7D6EzS$evVlZQ58|h78AvC4R4lJDvH&`N= zw3s%K?Ci*V7iePQ&(mh&8#}R{iocGcB{h8W*#QPmFfcl{r+J#bAKCxdzZ@mki<1%I z{(24mq&1cPf@S&Y{BUHi^G#vby)BB>m;{os%VliSfcxt5GOvNeY~aN<*G3k_>bq3Y zhyU&nty!6H(L(zIC+A36``IKKXhE-1qPQ)d6`-Rz~)^c_@-^XJb$ zG?oKJ7FsJ3V%bz!rWWGQW`5mVY>p5KY&3_kArkw|5eHZ4v~=c-6nC4WtTvia^H3i@ zTUGoj;sHu9KMbEyV#!K)+?DVE|GpmRjuSRU*{CXfR%GDrT$@Ykyd+48+f1b{Jy)AE zZa;2$33tI=7M9c0No5fu%hO47H$LH|nd{x+c-YFlb(4Hn*yr_3-XV1s@^qf&!QWW^ z1*wK)<_q zGhZ~x|7!2OgQ9A-w^2ndekPO3+kt_y+fPf?c0m*R$MuOxZIfx>NqGZGX zNOp(M=h3r`RKnQI+DmBdqd_q8jbB63tKU{2IEAK^y}DRYyfFTL zkV!;Kc0c!H4jsC*aPN%!hhw$TMp=bb55e$f^G&Y_F!v*f2AXot`KY_xK>oCEsOoegJhvfvA{|5f zd7P!iarQLLXBQSC$La^f8*h{ZmXj5Ehz4>mr^#s$RZ*ALeGTc=_S1!Z;UdA&u%S?X zDy}&L7l`uU`tf(KmDy|ekQ!0>U;n{YYeuMiN-`)`vH3LRT*R#SWks~h*^+cg6~%gI z(&Axy@GSDO8bhK-q(4(HEO1b;+)B z-XauXu%X=g6vr1$1sS{Y=l*r9dTGD|i02$$aZ)oAk>IYMi)!77zQ0*&M>5ts@>NgP z#8nVsio9bSY_I#2cw<`)pW&-ayfG5?F~b>tobZY|N|r}I^8RKaEiYA~q9AdxOVus$ zq?~^(xQe>|KMVfPg8#F_|1l~5n3R8P_&-kb?>SA6GY12nurVd zHUuH`iuoV6_x~PT(Hblui?U7krH@-B1#}%|}azk)0@>`&> zM;p}6-`-BQNznxIghhu+_-+=i)hG1_y4JqlqEj8nGIxfqoGJ#AYds1zUH7kk4@~0$BdJk+;r-)C>SUt;N#nq8VyEt1c}(_Bb%;mxk6*7^ zbIw+?qOu{w@%6A8onwV2>YYTgE%(1S|6lEdk4FbRNBPwBLO0U{s=izyO8BS(PPU!s zMGZUOO1DKUU#>PpW$>jEQs#@{9k5Lb@o?tv()iQz!Gd8LJzl{riFX;mNp|uD+#+6CD4MKzS-+Dzo7Bv>xn9@KRx&} ziYSoANXAIK;@fTTVEl!D9{eZ&`Oi}Sf4{kOZ^j>jp5!FC!<{KC(764wF+Td%J?UAB z$%|J(kInwA&0_%a`NBxeMUZsd6*t^)vy4L7`{MQoEO!>tv4qvgRr6Vo)H*1zuNpTX3RC zHW#$)Cn0*|5M6GdMMd|Q8k)0lrM-bk;cRDmQgLY``6c6#7^fVdP%&+BIAf6rxI?6k z0TewcaBG+^k4@~if#N20TK-2Rj!lS>VHzl;vdHYl9GdTy0o~c}w?P?=?R{Jo`<1Wv z^7PgLp@z=#hxP6ab|_z6=~D4+m>~T^Fl6J~dTzqO1V^W45aF{m7CpAN$aL|(CRraa z=$>m+97j^dkV6gU2$F&bVvn20{7U)U0 zfV#>HmBc5-spOJ=7hma91#6NEK)B(10Au+qsqlqKPyQRAN5tg|h+Ql;lbPgW6}kWe zyii^b;|P`Xbo}kH559;yhAhHk^r*eeQ!bgsb$$Iw>g@hpZ=2~L!xvxo1q*Bu-&Noov2$%Yn^rqh+&XVP70+`@Zlb~-F%Gd35|ZP##FLd zMg!*PWs}9ETpH6WnEZs&#=XBjxD`1cxk>2vUO=obdRp;kNIq&$F#y<_WkppkdEeKE z1*bzc1{O;aS?dRRqxM%*FSGk?;HSHCvk4*Me&h+kQ15|OXKU`cV)B_?hI$okg z>QXA%rP2h?IPF%hyUm`_0%?k}=b`nQiSW52{Yn&-A;JVvx10=F2SiahVPobsu9mH< zfGGqn{p0?LK7&&er<%J~sUsfr48s5}8nH;P;Nsh1N?YS0Xdqe-Xm@zf+urEZ3 zSk{K@lXjmaEj0q6Y-Kwe4#>I&gf%sDXMs>y5~y>sIebx1LA7`prhL?<=vz-Q<=vf> zeWP(`Kl8T8GB6#^M$xD8@$|%cc-OScQy4)Ky)KD`dLJv7jP7|~p}P#uv8`k0?KjMH z`Nuzz67^lJpiZyCmWdbS6Sl{ZzWXENIYGJ3As&8)YzJ|hUNm=vfil805IHk(w#;8A z;!@fM;@%&axKxxQg=g)SdoZvV*MMdk^?U&!T9}5RQJu;M=xvc~Gq$;2Pn2H)fyWm2 z+W_~+HZkw{(rFS0C6W?gFQ2L6SB?%>u=R(F^=E?YCWqW}*0UO_E#7I};w8py|13u} zX7nDI+B}es;(J6u)+>7U119Ns*+Aij*9Fy zArG3$m-@llpwVlPZt-r((O!uM%2Q269+)9riSHi$;@pY>Yfz9cU{cBdU3CUq(sn<- zeK$aC;SLaeH|NYcrnK*Z-X9UC>gMBEo5|4tSD1sxoC?4r;$+&FsM-zz^hq-a0DgHv z6wmO!-_bRf@Acm#d$l&nP%p*yy=CdERKq-|g=xG7nxP&TmIEeS_3msY)v~ZcQ1VJH z(1lC_gk^$kD#tIjhg>?*dM>|k%72uvaR*nJtC02}=m6hVXmBED?@M8<_*%@na=;B% zpm1E0_Jk_vW63TXw6W8fyIAr;Y=XTgN>2{2QVw|0xYy@;gatzMg;$Y{@#~R2lZ$zE z2fZ8wgFRZt5{UutW_Y}!K_mjb=IXU#{m|JwY}&Wk{n-4~Uik#zA@<(2dDd*+ec zOndE9>G2!bB#Y0)^DK6W^nuYEfpJaubG+#I&NM$X8Zjhxw zy1A`9MbIlT#QeSx?VdQ9+s)+pr?pGv9f_tcwU>VS&-g`zKvI7%)TetI4gq_H?Dwu{ z$K^c!maWfxxhotkLVG`Pb9{P?S5B%l3TC`A_lS|%(lLq8dB4=3=#H#0TidY7F|iM_ zAi*)7tk}iZ2fVnT5ogj?!@k#Kn6s9A@T|Wss1mVYzY}h|3YcspzJ8GkCJV6-{}Ls3 z+A=a)eN+^?bx(!P5i)-==AjHUq^MWVe>9ni>~8_eG5c@N5z1bmRI0;riTQPD*oGE> zTTWjq@w>)6DV@cDrX5J5KDN8~qqLY#>(C~$wD%^Tcs_EkH?A*%g;g)KC*pkb%Xrs# zkrP>g&F^|{TqxLvw9|C;q=B|pe^o`gS*O$Bfi#9}*u6)-pAeB7F^eV)qOJ#~m< zD|q%}`J=g9bdVo0p>kt=j?V_qH7S&U2)%X4hhF1z$mJ!(S`ulSd$etV?;-it)h)TR z93ww}5p`ms#^~(yA&3~_&MsU8F|tQvGk14axTP&EOpDt}*}y9CO!WFYo!+vkyMYJ%v!cC4U=74ZSz9q6S;0<9pXX=Dt48 zw&-)9SX-EbcpKBKNXI)w(_PO`BOhG-7%Pt5D#z}pU07))#(lV@bz&EgWCleVpbVK9 zi5*lf*}l+yWKZcZs`P|L4uEJ9OF)!oc>~86<7V&bJHJ}`xL3WBGeGR=d8LO<=POpA zF2-`8{)@@&XG)NgITyC>5Kl8Zxo(w!=y8lUz@~mU7E7&08XWK(m)Kt@SlSqT3Lbe9 z)2oZQ&KGmx&UG3_>=EGX)Zn-mz>#8KNlmmqIa%u7=#ngXf|mM&vM(3w74!U>;znu1 zz}N-P0N4v?I#5Gg@|uCS8ugrFZUSnUfO&^btE+GS#c@x zXU_hd3xF*Nk;;!y?PtH;=5?UGH=3F`7-B94?0 z7+WKyyFdjcQ)Kh=2cR8LKAVXpsLic@J$r@QeYR7xLVo4Ldf!Reo1w;EFuA-pCGtug z1eyeFW8t^OL)c<{KOR3tsiuly>Sk?nL4CH$RC%xmF?-qTlT8GF)On~{ZxkJ++RX`% zi9d#swE*4NNe}}ct_jxVibuN{xi3u|XKpr(g$o@4zPUAzx+}-KX&VVG3Z0}k60$o7aidwY?O1s6{MCh_mB!;`! zKE>(n(3t0_g*VSLV$|3-raI%~aOy^bn6h~O zjSrLOu+S}5A_qb@{lOl@=l1nd9|yxxTkSohPC+_#{`&U% z;SHpu?-YG~T>P*)Duby{<%F#j+r+Zwj=;N7lV0vumUZ4>A~9FnYUu0QKE{dszyxzc zin;yRa_!P6F3P8TG}8BnNA0g^JDpA-BOUBo3i5d2Q+{FaxvWlkZSlw!Zh9~c7DMCf z#^=JQboz-P7cXgl*L+q$J4K&(3Z_3o9S0kuiIwTJ<&~4Pk~|ZBj7?4U^AAySzT8Qs z{4yW42k^5b=M_?Eu12_^Zcc9d@bZn6NuBHY7TW?0dN+l`O)9tmeX;#VD)|ll@}7uM z-(GsltkPz;5Hcla4SZEo9WJ1CE0*(4m?K_uV6)T-o2KEV00q`0FJZM$_R z=x2=77cX;e*4yIK9e^fRnlz4`*!fJ{&kUgwx4^hXgnMdOV)9(#a@HhrfC8RHar*pC zYCm5lrZ-D3c31|7z?J1>jCZH->l34mg$kQRw*ki})97gh)LTO#?gfF(VDU%w&D*U} zFvn&DZB)3Lh8uestSdtR(?}J{MLisv#?jrS&Kcp%MNV|WL_@$}6@s>Br39_PZkJO0 zJUb~h6LsI^w|oB@g~!Y)qG5#lZcoPJNo12MasugK16*ZVk` z3TRk!J#i(ysB00(ioG~lzy?09C^n^y=fIhxJ5a}1Z zH%h#e6F|>#W6+xfCxGoh;*aVw3D3p^Q&wx|pG5U(hr+VAZ5GH+oL@y=NneREZTlqq z+RkapA0p68g1CxLiBZ!XPcDXUm{bZF*(&e48So7GH6HhXG-%7_w646iz^ zWPQVybf3vt@kF#e{S^U?spt6UW>?Bs+8$fg%4P#2Zz=J*CSsThZ{wx#_#YDoMxzf^ z2Yt|`!FudsqbIhSLzrXkl9EwJxs_=!%rQkxx*e82ZfNZ`Iu=KAjo9ac=W~^b04FQ@ z1;Aqm`o3RJ;4<|GFj+{F?4@Zmc*NbmJ~;ic#=ro(IW4 zLHU@&_b`nLYrt)6YSl>oM1t^?wPSZ9hV#yxp%Y!(1LGllP&XD3vR(|2cwP31WkfB= zGRz}DZjUVRr|ROBwn?{u?_vfbb-Cq^ZQCI_AdBWw4$z2gg$03mmd@stNjR0G&f8br zlu3mo!hOitfymoT2H7CG4L&rXK)%2D?KD+1=_$joA91N zy1<+B?k#4^_I1 zsFk1F5JI0MBay{DtUYNeHROmArk}wPtqMwX;l^Jq*&Mo+6Eik*UR`> zDID;{9YbSjs-@wp460TE0p>gGJwKvL*n)DQk8k|;Dpt5hq57rv&c$}gS(8>_w0Tg0 zKV!s4x2C1`Im1f%*DDEj0eYgTPZnpkNjPkf6*I;R@Q7THKFXmGwvQHSAGBlkV3)8A zb6euV2cGMiZJQNiSs(0ikL+QQkm9Oj`0}(g%)^O6I0Q3SAk;<{7XA2kvW)_#a)83z zDrb8XujPBP_ZHlD+kE%Uep4l>cyNs1kzY;ThuN?t8U!HJQ=f4Dlp*3o7irF>$I})X zsZfN7=Dn1b)ZK`ql}OXP!L8&M{=8sAIh^{NZ?Ej3V2(l78$r@O5ZQ0t`f19$M??RX zzh!RSpL%3+-?EXOE>j74?-QSbBz+SI$yl{~U8;v|arw%XQJQ?<$m7%L^YLsO)!=3* z3fi2ll;AY69Rb2)$UAIPR=X%h(e&@$rzIZHb0(VRAlEOqA&~=)Pv6aIguv)5%Hd zASX5DPgPNgMdVrqOV)WE)?64Vt1TNcni<_mD=(i)+hK09oxJBH*YEqnS~_P@EdD;z zHaGhZOS2h|w#g%(ov^ zeZFNf)i38|g>OW3QVON(l6!`p(tWi5utQ<1#PTpi9`9>;Ut_FWDo#Jn-krLwXsTZm zzf1b{%eGW9I*Y;acE$8Zkea__G^KF(edRZiN17nE+ILB&p50RNAjHK)kkIiduA%DkuWV(WyG$ zl^+GL(B(S}?W#{{Je3ik5zA!C!rVS{9%C1)I%Jea-iBwQ&~`e77ox8VBdf}y?+4Q%cww^>!PIH1itfIhReHZ9FB}sn2`1)w^yz+k;+;i0^zSOh=Obh{1wy z2)O__AHpv5B-D zghCFXxTNa@gTIo@WCYjAiAEY9U)MFUQqVhn#`Z(F^?I(Gblif!8~e46i#>FCk5U;I z3^XFJ@Ffa`COq)w~apYa#-oGWS5($Ke%G|C`Fl;|k(=G!Mw46dWax-4sZd{H{`ONu6)q zE7{GLlfb%?yC6&G=w#*1%lvG&56HEjjli8G3ERb++Ez?Tdl%nwTuFBZ@kd{>_VbHc z__7k8mWzqtonCvS+{rp+zzrp>3m304xV@cxc=5`2u3~GpT$Z|iy)J^tR24QKmi=tx zB#Jr8NGK`N9S(9;<~Z(mbb4~4-_KEnfrhLHi?A>b-{}NP1VLqxYfn+3#WQ*w^vGgb z$M34d$120Q`uaXk=r_^Eh{T9lzSczDf2kEOL~**a%2k~G80r0dBgLDbe8eo4lMa@-Mtlxe^lW9a%YR}ca6Q30z^O)ktBuGZJ)XWI;z6Z|az@~Et_33X zKoi5OrpVVasOzo0UOzOZN!n+l9Wo3_S|lk`$%}u_y8L1G@z7zs`lFr?$BeynZ+1W3 zGtW~0y4IK)icB89UY*-OZn>&DEc(TH;k>~y4NMhpv374qD`@e_W)F?fn`epTy7soD zCcx^becU2PE5JOxr`fl8lmG4sQY>NNM!nzal{98{0>g3)gNQkIQe+&8{ z`i-{+Ezp5G4y)Lu14zg`)VcmQu&P_t)R32UK)urtdDWgA)Ko<5zN5%Abt8&=?`C1sa(xq6q;<( zb6DW(&VkehUZf5}N+==u8}|TXc^&buBB9x2yj;d*fK@1Wrpd?G)9FgV--7$T;R&X+ zkIjwL^3wGAi!ZEwbE$5pDP~$AGsY(Yzki7M*#(^#(muSvW%6y7@g24DTMZ$3DTYI3 z@${GiBTUSLBB_dU_o+)spbAh=9Q=YG9!B?i7ig3C?zz`UuuSXNM{5baD301 zO;O0+WLsV=$h>>`B2^oreCiZ(2PISfoS*exI^zvhjVR-0C6lzgu1)Ka;n;pi)8e&h zL!D(?%Up6`+)u%aso+rr8=E#!H^$|n*9}ohX`An%hQCF0^B@)-_p|3n!s-1Bm|6JB zquq9q{U6fp+7@fYoEmc-jxY3QD@nK;D=-W(7q-u(>fPMhU7RCGDY(dlh;waNy)R(? zLcL6ZCUsP*enUv_3E&+D8QiI+1EJqUUB;;UK{9<#bon&V zxFqf}HL-*%>q*z3J6X8Cjs=VmzMI}q4>VfnQYd)x@>l~_8?d0zk-8;Z9&^3%c76Oj zgCK2(vB?HRZturPcuqQ^dLDUEHUb=G9S+2-l(PQsHZ{62(OAo(dKy>J#n*Dvob>iX$Y;oP;EmSZtcHg>nE@28Jikbu{Xw6tV21huj=)TWTK#pgZ>HP~&jgjvtefs_j}9n`Vq9V`%pG0Uxc38kHQ z)esMGs5y3fTRIT*4zT1lNNHtbtxO*8H&DjU2sBriCOS=c+=Mvg0;lmyO9#=*8$Vi( zTHr}ji(%u7hgajfX`Pc`F*cTL?j8?C-cr;nW=buUHeE3*h?Rj7wu%)obmciBk6`&m_sRFICQ{`lUF#yAeFc zM-4HyIONKk5YG`O#45A_Nt0B=Q<39Q#5kWVu~QXc;uAGf&2Lc$wrExvmWH%vnxU?3 z%}@uey{k;pyLtaMwLQgMO0a>#O2E!1GvHe%bZX0RT}4PpDf`{`w6gfdtASvO-)qW$ zC)E-PUw!1Zz&O`7(aN=;^R&e``*i3g+Bh|11e9Gql-CYz2bqytSkOe5#e$ zfmqu1RJifWp+*_9Vq}MML~9gUz$Z?MxpC;;O;#aEdP{4|hf_+823B|xdQ&|lVPkq{ zDvm0=pn`FHx7)kmDaNS({^|&jO~U`!hUAK{jSnbJjRZ9463>e$MFwJehCmu@H=_W! zAYspiQZwG@lt{O0n94L&0S&`Q2u~rNz03SMZZ)=aA4tT@1nNIX@159AGZ>Q0?im^@ zzgLvO(MSMN6WQ!g!(gFJWw*>Ccc(&E)X#{3=ryZsr^etc&jI65{qMIwx=>zVlsvs& z^ujl8(ch--%I2O;Ta2lf>fu%%RUrTH-SEpB^c-@2fxBXSSUZLI2t#F}1tF z;veqgiPS&gp>iVGHq!#F=PFbfCN#D3>FwNE?NgiMpwGV_H}B3Ogu-;?r-nr zw2;>yA$C}fB$M4Bgf*`P&Yx0wdi%+lMdh}48pGeZ%NSXk=f!$c4i`94%q;VEA3!}W zM4GIZqu2Hm1uD(Bs7zkv&GsH4MfdE~8na~+5TX77D!&Z!8+vKI^ z*u^UFwQk|G8^gG+hhw^%X`frdR6kV9);j|PVbS;%jtuQ2C*jNwaYbu)wc}?SI|XcK z?;5G!x?sJ-hN3N#>h9&Bi`14|aK!n49Y0^Tbt7;FeJ~MrvD4$y3 zmsP^9-lJ(AE_a+LEH0EsA09NouPr+Qw|2mz;F1Po`xX@-pP`#R!$s4)>F!#=V=;-6 zXnlH{a!L(SDS6d%OKcotV2(T2c0}aVZTr^w%8(ew@n^8&b`c zpCggCURCb00BBIf5q=G8I1RCpi8wbg4#c+}k15L0$ueF5jl~OTcAX04e`vehmN)yh z`;6>T{8G(SY(N*LP|q81A-Il1_>V?guH3xSX)6B1pH5%xtTX_dDs8v3v!PT01uC35 zYKoHxb~s%R`52(ozfvY6EY-(|Xi7;?%!l%ISkO``QggPR>ke(o6Mpz*(QCP_bpkDx z58V`%NcxY3H#Z5L8P;N)hTty~a}9jmL4c2~aHN>$J>bDC7`KMUgr)Cn>=J9KNx)?c zQ9S_Pv4LQ1o9DLm;mT=4bkm#wVB;SiS7|FGG^fb>%8vB}(k4n<2;m-FI0%15ijmt< z`i4FtB)tKeRh9?{bCeW%Muy+rB9wyxZOLX$+-Kk%u|6pa%63`4v*|cJ-`sW%i)#7U zl@>>lIc39Cvy%3p_E-a7SK*h2*Va(?XH@wx-+FQ@K;__E-R)-2$I*_gyt&~GkU|M+ z_{@5$kNi%#pGvyO0;piEGA+${vwNwt``#XUw0je9h0`w31L`&>Hn{LeoZ%sHyk6$RJd+fQsNA{*&GAOsa6#>{^Gg z-ad_T&Ek&Y-l0*Wcx*ZI5qq5l2;@U~4yD3}GhP;#U*7Rum44)$r-u-@BqaqBukn%z zsvY9goG985+1$^%X>w{uazs`+6oZiKOM);e=!ILE=>;x9X%cuyh4SDyiN(tEF) z!oDLN1G+2AdFmW`V+X@pi57s~{^YXPf&d?nMq5Q<$H{BW1FfDZgx&P^i6PuTS(2WD zw56E`t@H8C$PZJ=93O-A=$Iby7Y((jR03##ziWFbiYGL*^*{{N?6nQsWNO_|GDhJ( zs-H{?rsytMb!SOCOq910O{7C)p|1AUxtNczPU4D4vZqm@uc~}r$UE|W;khkgdmt`0 z3s6-rWjwG8?5Dzs8czOv#d7&h&PR)>4|%CVEFC9Bm!Ui#KARMzu>{9R92Jy@ z2Wjt(DL0$$c{2zY={s1R4r~Ja#>(GPFDtmB(3X?1z@4Pa&eZvQo+Z~_BhI7VJrsP( zj-d05{#1&3sbtaNcpI)35i?=L@bQ74Q^8l;A;wj2%<=NtBGgdWHKh?DmGhs)Z8u(%ZQl zT((G5l4}!yx7?fUHgd_>e5BcViziyG|EY}F$r|`yUvqx_wiX7VyBQt~=VgKrls@IZ z0l0;h40#WXO*1}Yxos6We0~ID)mWU9M*#qnY!P`AR7XQu;{b}vBX6tW% z!wEfy_ol5O9e|(!%>bslIYOluMeR)c^|22?YlkpuH8IzbX26#;GwPo-6_kHiE z3~gtR|K^MSYH$i>g%;@Th?jd9v_KR9#NYAsl_^;LbNM3+!CXTvlsG^&F24)JK0h=M zk2qE6Fc0_xf(6q_N$=m>=l?b1g0({UMRp>ZAld)zyze~G*M-vd4lg*LHAsl9C# zmb`Cx^4kBw7i*E=s{I~&{U#6fuNRWhcq~k$bt=mCdS)>!ThRQU2mk+ZsbQo76bwSz zP?yh{v0z^B1kmYK{pDZXD4Rg}lUMS)hvA)X-yBQ6|Lv9(KyaNXw>4yq4I!aO1QdMN zVYF$a(B`#;_K?I~c?cf|_(4+yYB&0@|F61T!2K+H6ods>hy?=}dcFVK(BFYEfclUU z0Y#&NG1LHMZ{;j;USlwyr_1flKgB{cPhq&$9KaaJ`x0bHv@<0V7B6b(5mzuI{K@2O#3`no|6VV<9m}Wl zBZiOQ)R*eCx!FDHQhR-5(0gi63?Y+T5#j-xDE!ljP$a6NyQPBznzG1=b%64JDUU`Z zAA^=P=rJsNrZ-G5Mda2i`{w!KI$MvNHz6K55hH&x-T(1Qfb4(-XCjgj`RB*~pTVYq zrJswe5&X{pe`>0!0-YGINuH+v@r(R>D=FrH^YYKc|Gggn+E)Lp_+RX>f40hB*~@>n f%3p4kk4Hp{eMJ%r+Q&DKfj^q6x+<@gZiW0W80(!d literal 0 HcmV?d00001 diff --git a/resources/summary_taxonomy.png b/resources/summary_taxonomy.png new file mode 100644 index 0000000000000000000000000000000000000000..aa0ce1965f4ea0cde46b4a055e4114694a747daf GIT binary patch literal 130220 zcmeFZcT`hf)&`8Ibg&>G9YsNuB2A=&bZH{en{=rGLJeI7QL56UBtekgq=ptyEObIB z2_2P^(1nB++IN|mcix%x@tb#jYkhwXYeB-zz2}^}&o0k?_P%-jNKb>FhK+`djEr7O zQ}rI-I0t;^L1((<&)$t<__Hc zAiL1THz@;IzL8{)A6&>G-oAZ}`r^YlYUS_Ioxf?y&NE$l!t7Z+bLJ`8w}qIf-lQa+h-dx>%?dsj4sKD#Zg==Mk4`@^yg5D%MH@LlFbT*aYWW2Nx^(UC@kHbBS z6gsjXS0M;9KWmpt0k6Bz&&~5x`sK?%v~0nbrX&9x#KkcgPQLl1_1k9i#<7rdt{{IF zRB$!}sYAQo$3i zgQduO;Iw51+N>qWvtwgCEBwwN?fQXCZnRb#KSCjmLrK=EP|?xeEBn9(gm6?44)`dB55AcCq&Ht zyzz{@{O9!sa?c1ZFG@MG$9L(hpBwx+qoZ{3<%?SvnI6CLuU#VXAvME6?w13^+y*f!{^Ahwq;HkjDWiFL7SE$ug7IOt3(WS85zRL9K z;e*$Y*dLuQy8MKxglpvalIqk0ErZHO@Bvc^CS47S9IJsNyru*t@-p&_)k|R&Ze^)l z*#X4B3%mhQitc>gYtfGT_NMQz>WDcp@o^hIFaDDK#q!7G7dm@|r&XqGn5)Y%TOB{_ z46EF#)JD&aQn<6%v&g>W{QApl={`97j_}ovACA8_z4yI3yjZ+K8*C>vmJ5A`uU8_p1GQN?K%Cf znUwH+rAK!k|9SlMj{BoqCihG4=G-mNG^#bAGwyvP_*kwaPFm&WVTl)@+F zzFICZZ*rFmkwqL!PD|I89G5XQn-{g~~I zld3&>&}G7f-{r6tRbpPEV+30=9)XM~jCj`txpKM6)sfdx)XBQSM;4b9mRy!(N3w>w zU2-IQB_2o`yKoFQlx?`eHs#WTvV+bO^!l4CsogSNqFpLR$}lT~97BVc&7sS#t3yp6 zw;pB{tbTx&AT9P=wqqEKI&@!E)>z=4_tQ4fK(+J>(+6eoc}^|DnNI&KGJF%XCY0YwVZlSfd4^gXv}IJL2QwbK~o;O0vpJ z8H+oyIC>CqeVd9rcsj^_<`Pv7UKWHB(vV7ia@%8H5|$^y_RK+P=3=9hJVwd(rt}+V&gz zv*;J^wplWjj7#me>@5A-?+3|v_`3R$=2m`YFNO^6>9f$LOQh!sqgdEP=7i*Gy*iCh zsjKFTxBc>(Z#Ep_`TVec&dnx`iW>tvKOw_`a`u^Gh8Z32E9J}O)nLwY9ms4XCb%vr zujR0Xwxu~VCFFW&cL>-1(jMPFW-oy>wqL&GM(Eh3B&`#}N7h4UfU2p6h`IpL4BZxrFao3Ytz{p?hxjrTIB`)YVsIbbB|iu(Mq@=ORh; z^0`}?I^UNJ3ED;fxo`<~X@ZwaHByx)1Qc|Y=yd9iuh~}4FY~BvM!&4w z-Zs5{$2n2hVZdsWmCHM&FTOS)k3o12tJQlfF%JWhCa> z#$#`Af!N@#ua?e@87+#M$?EPJg^D-key(-DUB4_JkHuj9+A71u zg|*LX7gz8zi>(CBDm!ogje!caX10K#0G5@oHs?K<+fCYsx3@3vJluY${o-NP4(rN9 z)w;IX!!f82YBTyUb04wBt@v4fAYfqjX=s$On(cQS_nzW(IkD8eOswQ~@egBXBSrZu zenkZSANqBYY?4uuHWz3av=d))E*ANfmCKg|`37@Z@)xs9Gl!Sq8g@1oAhD!w3UifT z)LsvKet$<%EAGJQ5^B}m;?CZVnd%ZknNyg&JDrFvb4PVd)?j;A7b&n#N4P2qM1*O85IzwqD6{VKg*pKH)0KIC#!s37$b5fsHQ zh?6-xPqE2=_%B4?R}l$kIX-f{zb-KE(j^Xcu0wgi5ed5q#1_*{yWRXh^WRDj6t5hQ z9*@s$Eh@?%t+2(ja)$9j#P{m)P*U^Pb(R(oH!W-M!L`}1-vYmAY$a+ah${GnB^({N z+l{bHrVmyY*jTil4-3AZAu2845IZ_lPDUeoUw}FSp$S)deLiCRESYzgPMe(2vw{vd z-ye8jK_M*dEZK+$nd%(b#g}pWNoXq3pbKOVF2?>L`visd9tn8AgRbfbKV}@vOwrM6 zRUxTn3y|4R^6~R$^6|G}c)m|l=B$3zfh*jMvL_47wwEED-&)KjKQ0L;^O&QU;yA)I z14x$IOVbQYM#g;egveYgFJ+79YA)D!hs%Mz}aMEa)C0y zTMtKHTb@7Z`75V4bz@>60M`a$l1UkB#s=9bMdV+yD6hx)&-Q@krVl+@D*tCE-)|y`@!L&s{aIdB|q65 z-~|Evx%Kx~;QbjIgnU<>ZlfW}8Q}iKMMv%uF@H+KIpSprvgKG-spM*Rs z^Z53rHuuU~wvW#(Up#qx`|72)wI#-2Fh>H51yQR^DWlyQgPa`(S`tq&0s^o zoL(W~Le;ZJ>>^Xgdmdt0V`CX(T~5g>{b37R?Nd;wG`N4iSFm-VN4m!Fn_&BMGIA=O zi2v}1Rp1k2q_z4sZR!KEGv_WU{pBB?+e$edum96fz(h(Ev={M?Ubsh+|7j>-4l3e( z%KtFg$tpUZo*_rlt#On@|A*zD+*~9V?*BN0oK;XMC;balW#s>ulV@O-p`d#nnm&{)>{buk4;T)si~a!*GgH!>TyH^szvl1u!&>p*ym`|_Ao;;xs&hN9QVt8O_2W${-x#t;n5>)3S@~ru z+11+Q?9lD8+~a4zf4;a-Z%lX-QTn+(igw=Sm}Jr(5K1Dx9nx2nx0Szh`p7)Nfbv%( z){CUcq1TmiaQ%~)B4K_XtpcWuU|}Q|0b${K4r{$^eFn480+?ApoSf{m&6!J5dKfwV^@5^c z_z?k~EaoxOYQ-#MKG!&fN9WB?%pBF@b}%e2C@(AoDKS%2Qu$V&$g{yF$K=VA8!R>< zRm%xB;fHnZ(=BGxAq3sMWt-#M$2;N2xF%@DWDpKIAH`yw#G5EL2xf2Xv;th(H@6QnU`c$a7g2QOe%32sB-TctK#TUeWQ z5)}Jz3p>MbSkoii+!?mN%D=a_XPs3T8fs{m+yWS4^?K`m{T}HM+jhiMj!=;G0<`We z)PG!Hbt_i&dM>t!gx?@?!|+wUst(SAqyWtRdK>p)`5x-{0F`n90P;#F<;oyM#!3@NugYQH%hy#9JRr!LKNs!8o@;n@pvj~;4k&$k^dx8+K?m9I}( zgBs_V_jYF!r&`}s$l|iWbDzF45Du&huZ04ZE7zt-=oQazXc#2~FVhO)03&%@=Z00E za4bi(Ezz&7hu~zz96B$u%KDcP*QO?p>elzq(=w~R5XY&{9IgfA88=xAts{4=Go(PU z7Ql;$rk_|IgFJBnzYzxPXODi^CZn@xq@r64!gukp84}{>dm}lT%`?pFKfpwH+Vr_W%R%&m14^IJUo}ZvC=cW>%A{?D622)Az*igIPQ` zVm*7=vuUy5S>SKWO1MbNp9eDpj0ZQaDJOE;P+$Hgn~(g_?(F6lO76}CPTAZupD1b+ zN$AA6vYP&PzrMcOkIoO62}KNJFfyeV56f_{ObRouz@KM=0LNe@HG&2g!o!-D13b(! zDgbv8G#f9~og!dpc|p+^KcHmD;da&9$cRZ^WDB8LDY~DFUEk>77U9)Mh}({e4pCOlb-EoJ9oLg46kD&hj6di@FCYE+dLePV2yLLj$%MZv(soc?X4yFC zXR$gYzdg!Jf>LCYEb{V1C0j;F_}mYLN6~PvcIwC0)?A0L=+GjTM}(!)$~Q+z%f4pAvb`5ndIF}&9o z3QBQDr0=mJtyiVDh7IL=yxh_&#PdMcllk=%BqStu(?FqP2#^id{(XdS)9XfQPEo09 zD}*=Z*T-bNH*$x>A!Br;%{rhRns9|sa?Y<|I)s+*G1Lav`E;})Wygmz$6JCkFF&IX z!}lj<)ODWzY=ru`Z`FzL3C6wuB(fOB7ZQgLnyffS#?FScN(Gyc4K-C%I3p&=(_VUM8E{&hL7QFt@`=s`=|sVfbDD1}TS?tu zn|&6=-7gp9dPGs>HK5GRV8*~;uCMDm?W+-dy_*$`{ngUR_XVj;58h}HJJSa z0xA)|{=_0}z9(ISL1Fjj=MMC2Je%ZgJM}*|<>RP%<$ENrS^FL@4i#$Xg4yRHAHF{XH&wv#bYj-%$4*rJ4Qn5J-F$Iv3{WwQNE^ z+DG*WYoCQSgPqAw%f~*fR_hs9?q3~sdSb46Y^x-5axW12#t{>2aXQvcok>H&bZ1;@ z46@qXmn9X<#BBu^93arzBFW|HGb!oWQhbnGO-+Z}6QRrHHmC{t~{i`qSmpplM|G#m-En_39pBH-fGKB5Ta4sk_tWXp;roFFACM zl)#LBE7pJMfsA<%C?!2QG%Pk+Mp@mnq3(NQzmC>bQA14GE=lV+jyYLQWInGvlDSPu|Ey=* zj0i$WU&Aj`z-7V;&GJpFFVi&i{Uyo60Q$p!fWo&Nr)ecg7@D6D6 z*q%Q%wUOpcVv2+X)n}|1akgbudCp`wGX?p73W`o&ryq5zMBekXA-KzOFjSCXPY@ynAT1;X}yu5ywjuTF;MTFR1KeZ_rI65MRjx-9){^xVUW2O?cA=HUN0?_&;yMNHN%uKO znoQ-X);S0JtT*leCVWz1W;E4OR*rNYTVRFQsmle0fkJIz>wF78K5dDvjmROidg<*% ze?<^i#tiE{Cit9gq`r4f@2Wv5up`R1zQheC1Ca>7jgi?eZEO^B`W6>zw1Q;yxLMhD z1gW)J*z>k)|1uh|Ew!LtF+4o1y6k8J3RkrIMkQ)^Vcg_9QYsJeO-Gx*gEPRgw!+C= zA!w};_bu-36~>p}Jlu{S85!MNkT%>ls@hrdP#^iG(2Nw#!+wjyBy%6)HFEtPX%G&S zMThnqJ-7e?oAK$(ZM2E~IvFFm+IiRfoR)He5x@q5L%gp6r1h>keO_%agU~`_oSl078(5`hPZp?E07$PqZC+FVlB;CJa)uaZ zM(8k$Sg+Km5lkTcSwB^JYt!rse#g~gb%OBCaM-aE%}9esFM&^O!n43J&H@yA7p2e0 zsAIv+XdS$@baP?Mk$PEoR{$_N>SaSKTXJ5}A%UhfPj%rp871f~S=>W$wP&^Rt_$_q zA)8%x>f%2_9n}k7?{%E>US8p@`%d2Lea~z~k9l}J zp^1MG7AtjY|WFC$B9C6595soi?|v#_5So86A$D zF}fSbR%VTtLGeL)h3|31?*NeXU7xlJ+pdADh2wN~0pmUd0INQ6Wc8&Am{2Xxx-6l?4=RVy3vb=uF&E~Ki+jh2WzPJ$f24V{Dqw*5{ zg4`0_c2(Ey0TL6I{j#>%g$!sFszv!!av@Ui3ciz0+zK@y3*@#|8s_*X>7+?1gj%6E zhg{&N<*8>OX{8%8tLg?Y z);OcKpi9)bKZitW+FAdROCEgZHp)xanmf3H8`kz`xsOK!Y`|v~*8)k( z8bv|S8HixpB}c@h4}f<7=--sa!%Ou2_<_)ZMvWuJ87dX|@P45MP-+XgoelO3m!r24 zxUjapKG2}rWg&h};9R12wR6{Eksxk!YCQ~F1C{CfI6+`hB;oTkU0jNBVKU?W9vf^Q zaF{~Uibi>sbvlWz!*3b$ovGMxzG<~^+1J$^x7}28^kZLFsD$?evxpodR$F2%_B}&<9J=Z1^-BtxrJ&L4u|Z4hElQ1H?V7E(@P#Uf48+|flp$EZq<>lm!1;9< z#~kF$%6eZX{AFnNo!fWr$nRjCtAMmHxZmn}SR}0eSE`A%)~JRFUi|VQEV*zWBLBjB ze|xnR^;Cj4!ZI=FJCjLZy*^wPUl$m~>ookqIcM1@ZHD9!IW38`oJ9ny!g*cR!MI=q zcniQPo0B*IP;Sb>SalZ~;jB^fjW)M!cF#jJIJ{NA#ijTig7;Su8U^}rF8V}CGBD)6 zVivlw>H!Hy2#}Z%Xcge3SxA(do?TlFXQ)K z6F5%|jAH^x8tl~dv=qjD<_Rd43rhJnL7pdWr?nKvpAOvN6LfY)+@LIRP zv>in>HP}f}7spZk-$e$*ho+^a68BeFlon%vU*KK2nVH7H*uo>|8|+-{PhU+`|`vaKBmb8O8RYDtbcN$B_}( z4dTu>(6s@=&@b6j>EiaAfLyIhCfzV)8+7N03oc1Y`k<9e+?}9lcfV%pQbScB>=W>E zJ;Ufw<#d3HLDz5)TKKR6(*Q^y#34Su!W0uH$IF)|)hiCS5p7$O(?XpaB@r{kch0aN zr*=<3cZ2xs+qbuw5L5nH&QN5*Ztb=dYHV}Tq-V=q;+8LX1fAo_d-3oAEumMm^6SUi zX^{bo1~1zjvBL+~pcI21Xtb6mUsJyvuedD>XNDuJd7&vWsNcMOd({e!j)WyR1p}lC zV~Gn4g&S9=mw9o{ZDG%+V!yQ1;^{m#fbCX>vjg8S+9N8VXnRSYGb+nn6eSst_wDcu z?-i%8Z?*~D8i947+gP3pF0j6=aKztoqR(251)!y22cLy6NneEJkn&0xZ6plNFmo!y zdQmvC>;e(sl-Q7q<+fdbp|Y|ngam#xskDYkX_m7WDwE5vy0*Ev#VfSJg0O|+ac%W8m|BEkgve6aOIQU@d!UN)@=DRBM( z`>-fZzRKIb(lLUzwZ>`5V3t$9oVX0Pp7m7hGqG|6f#iqzAO!cL8Spg?Ox^g#sQ=BV z1CUJk#dq!-!Ful1U~Er{GybL_F8EZltk&moBS!)hhnQHRpv_2Iu z6Ti}kgSAS%4nN+XppAJ6`#jg6=K%*t6 zVoh>P9z7Z;P;sHcVHB(iJ$x)Aa){#^aMUv!5^-_1Y4u=_u$q;>dXfupss#cBT$5gv zOXZ(e++p}}b&pXjaIp zd}46{0P!|1DTX%C{h`j;` zTX1JH^Jyj%%U?NLM@2)=AtODj8D`Tr)vnwBh}#hCDUY|7YWDkPl9XQ_Ic*)hI&aoi zP*A}0D$Zk8Ds>5f!>ki}GY)n+0l-ke{_ZKi;IAaut&Z1K^_7;CSR!cIx_{8n?Ebhj zFho`^6q`W4sGPXnT% zrIk+{F{VYVLOr&D0c%0kQA#2i7iV}+qg5j!XdFUv3WwI{*(7ca(3^A8-vcN+y!aAv z&l@s3vKn1hG2|?8-by`@Yt<~lsFi|JQc^PV4F^yfaSmd`)H+J<%_YnCnAf=)JurZB z;yEGs53sGFi+uQ8-jG%Rz(LaTBO^n*ekkd`0QjIXaQ9IOO1PFe)HCByb{VPgs*;!a zBoWoAcSOI9Hnv)=?1Ie{Dd&dp7$v_J&pnlyWzQP)uekse|lLnFQ=(4u zE@b4^L9|x%XU>BHvgpsRIV+;N= zm4{+bO^a^f@^eWlljDpCPk_L#*mspyZchcsfC+GTu+_@CU+pMB;xU?Bz)^-yXN7X_ z2h;NrGaf24w>|w6!<*nGlnV&LuO5LqIs)9dZ+YIt!?veh03%P`?BJHO1F&*xCuKxe z|J6FI`q6&d@x+!aeY%V*VEDo_qC6~S|&NTor69gU`e{v`JKxhS?|a4!ve3@AD^K4 zMk^qs%m7=f~Sl)wwa6~5P)T9`aNzG z9qy7sR4Q>e7mKyleb4=ciggx2)1(2j-lMRVgOV}GL@9E<7UuM6Rt z<8shUzlGk6ittJDN?!oF&xF*tDY__z;bdnvpcSSl(MsoMOEr5dhMdcwHw3mSg=NJ- z&3b%FX4~N^$SQQWz45Q>bY$e5*OCDIr~vP2y0jd^DdrGU*`abl{>t7Dsn%bOZ8kXw zz*Bbu<*3!h_4Tlw=1!m#6EL$`s0UrLP;ASZlez7ENZNw!FN24>dwS%T3sIw+ne7!P zX7lZ&NQ7$Q@*6fl7ZY39N^O&D?oI%Cb|=;*9QrBvL~Mmuw;-N*6al1;AR#>XhO7^u zFtx(`P~UgBqCucI-Hte>rKQa?bmA)wuU6`C$>p^I3KcyL-|Lt6D`<$m=RVaSG0xEE zJ6-&6qIDI(!NzTfN7pSAShv{?OU*-y4xrBae;n_ng z(sFSRK>e!#3!(1lm_Jd0_5)yl0j^c1x}S}HlK?-S1k2J}6N8+sW1~|&QHRw_g;K3s zKWaj0h*^G_>w5P&Ow`=-@TOybI^-`0{1oxR%`5*aG^HT1k7Xey7 zalI956=3Dgy`SaIKqMZJFo@Rq3D0Kxfw$rQ@cI^gX1t4)Z!JDk(#;N68to$UxZABn zr}T(`LtU_BlCLa3e1|+*aaN?Y^eh3AJe{+Y3_5kAO8bX@UMUi5Z{4~TvmI5FvojN} zm>Zdr4n1=6m~I(sw76jv31bdHtFZ)e*&JVco}l1+Wd9N7(J;71#OL(@B#}6 zS1o)p#QxP<3S7P=69u2h9Xd9fXh4n^1`NLqVH0ffC|s79`_!(8uotpy7y#P@XHaql zK9#t-A)8i*R0!8qQLN0rLoQ$5Q)H0$uHNYEdCsbUN$(CdUpDztUF*tmW|0{kI^tTx zEJLNImZ_rWWW&c*6Bf?5`Mr_Gs9cZfuipI}Fm5=7lWNokMhD*qpgDl5cz5O=M;kzgHOEhF9zza28!_UTv9|xn@ zOUx62<_m1A^Gm(-s~=mH5sixgua<~4ik$A?4(C9>RZ*UJ>n_XrWfurqkopmkKMg?T zSAJ(mM51;}=BOMoz0_Q(5ZvQ70}!-B0XF;TUFwqN9aj}X8bT2aLF-I-7c%x6a)_m+ zkP){+p`MfCKKk>xSpuOZVb?b+x=yHrrrHCzFLT8%@;V9 z7`pM5>L;ylSq2{M;mYk8t+C}6xc!wro{mrT=u0&~yRi}lo~g)bet5`b>4o?9<3=EQqF?5;Lr=A1&vl>xY|)&MkD48tVFVQTEV8ts>Gq=u zDq;&HaqCoa&LL6h2PNd;-a;0Ll#mUc{)7>@UH+E+6&IvvnO>jM+qO-s6m<=pW`8Va z+kOsZJyNW&Iw3Q|9k%<68s%2aQox(oe}9&4Ml9QLT+!{bB+xh%{1&#}EH*IoaM3qs z$+j}wVtN^03Jlm;6N+KUxQd?w2x;Rja-_BYm}9FRiS9?e4$#7oBg_skOC-w6D1Yc*zF0*Z3x!rWJjf|r9R|yfM6Apu|GnDllP^0k^und6FpnIH zQ%^$4yn)Pjr?&dlhwou5KxzlD*rfoS!)Ac^$5>mo?*oR%#?F5B5Ox`V)0h49{-I8p z$TBM8lP#dzCQgA8&pxvojnjQfUk`wN&OLlyq8+FAi8J%Gv9#ov(t|I5%)8s-xw1s> z02Lbq{jDawgZ1g@={fXI3@cPloetb8c?CwA$8kuDJvK2(uXT5OQNcj0<&xpdRrvZz z$j}Q2=WB28R5V<#_L#U=D$rU9NNG|0=Xf_psAC5?Z^o@WTlsD1s!ud;dw@8eoO++~8!B-di-H zQm*-BWjZJRu*@aaL`_$TpKmf5P~yiYeMEdYSHv%?^!7nSd52FZAD?c4!kC~VYhS2| zbVlp+Igw37+o8}nhQ&JY+PI!aDK&rYs)V7;L!f@|@aN|jv8SKO#sH-fM{2oL!t0OY zrKY`vu;;Fz!JoH!giVVNi~S%#3jJN@*Db!6EURD7GTc|{)x3LB=NNi?hjFlH6*04B zo))B#+Y6JQ*lM;kby0VJbEIw_ZXLEaZ>op~bpQ<&cM75YnH)eC!}|3Dw)qIN*qGOL zc7a=8_4s{w&NZj;F+4Zn;4$kxchlzZ^(l6&EN;LX z1EglNL!3dnF;tHSm1@M1LxSOXX0cggFmkUDB+( zh`)G7+$iV03m;?my*%%4ae_?Z55<2qf2wQ%9P>9FjivEk6YC(g-js@pnW|HZ%zrC9 zN4hfs4Vf5N-t-5S(bmvlU*C5@KkOb@^j)dg1p2QOY(s_12GGUJ*h>9pOFM1Hp~c0; zTBazP)5FM#VpLlJeQp!MNu*cCPy4f_a}70R(t%DVE#DiNK@6FM(t+@>rQ$->LKRZOq2u<9eEG%phk6dwUVw`oogz-W~;sRg!#!u(a=@vz~sz`V-Uep9qZqs z%S!`57IDajS=D+x&vF8W4K%ub#IvgvPSNdOmKXqBL^6QK4I$ertp1nBU!9(V0?Ww* zmLomBAt76H?l}cyXDR?r$9_++=Jt$o9W@*Na5KFvg&ovV^}aW-0iv-#Wu{&oZ zm6V>JgQQzSihJRTiq5sbKL7@gRnSjz#?AM-D65=m-b!SV*;fEf>GCW@XYl=G!mk2- zr9LZF9o_U&lRRfB=sIg%1D=Hf9F;W^($$+GKL4CnxbyX*hU}Hh_P-eM%sH`>hRNCH z7@CFWp8>w>)(IUq58${Y%^TNG^6M+i%-v@wIe2Cc7No$DJRjn9b#*rZ5B$*HK5u2T zN@aTztpB%;)~_u1gKxa4$29|I2*CIOEvkw<}258l!2C4p9!vTOF`3Y!W zjH+{XVL9DU|A8%(ZUHUi576-vgkVsZ9Gn*{+ul0NG!e(&RloU-_R}>wm@ePl^5Ar2i|nf9matj{H~K z{@rc=*GT_OJ(T|I+x|U5{C^7xV;nBnNIhy<1=r zTEOJDowWr8hyIXyL&Ha98d_{K0H>BK``@_qFYlCq2dk*7^*%RkXunVQv%)2Tl<2efN# zbxR|FhJ`aQziCsr1!B(X9@YJQ)Sfi^xDsbF?LcK${ODrokE?XzYQTFv59?OuI|MV1O5Glw4fTK-@-tS8mQX$kt zpQ@b~hzuo>2BUlKE>=5$6bCGdvFI^War!sdsay3@8wkgihZ&6JRi3+-@$;$yg_D}( z$dpAfAC2WE{(+v(H7$$$?8EH(=K@s!Zeo8I&VQG1vM>LY!hfakKThKRXI*ge$=O*W z?fI;}F@HOikRrfjIG5C-htK5P@|j36tKPWt_N#VbSH4QD%&(k`;20fRVkR5ALr(|& z;I5LkrG9;_0`l z9ZMHcB6OeouTQlZ@toghiO~-5k9jmS;pVuRIx<*m(Hi$&(juDpP%cqs?lY%lQ4L&n z*XzpZT_PAN;AvM~69WV7&rQE3fL^7%G7d${G|&13_wc@CB!sE^*Nm)MKZn8XSF23n z;-RzeynRMCAvG!=ERjBMIcl0iXBZ%DNMm76GvW2j-#cv9*Nj-00|p|i^G18Ah?x#U zyxRG$-gU!a!yI$cTbqz8+KbY>j-x*>3p|sKXLBoc2;8g27x3OT?%K5@mtSsLA6Ke0 zaOF0=O#oGKV+W1TlrnT$9Lk7&0mlkfZtOOqxXzD%puGKIdg&~um**R3;w=u`1VPe*{$zGK71j0`??n;s1+{kRg7z-q;c0e>4q-P4;s{n@f1 zK)}*dhht-bfPf1rAjlux@~J=pme)>vGC`=?xBIHuo_g%;v|}}~qAIt>jYI*F?WI`A zuyC=t`hi7bJT=m~Z!6D%By(rHEB!TrS*uv%(@<@l@$JIYo~6DZz5xrB92RVBId|D| z>m70=iL#)lA*g&~C5AQD;UJ`R3mt%iohVr3&By?|BkyQq(HKbJyQB$C-Bdcc((>+p1$pD}|BNg@w?0B%`AZ zpa`Il z?Nr&2_g%p~+^_seIpij3@6RQcu3`WXrSGIn=|#9M1@taF$eL>m zzCB;O)0)=uf}&gPs|RXEJaWh*7Mq2RX?`!Go1&stZ30Fq8K1<#J>v|7h1K^t0P4g*R8((Pys`h~z9!PL6M5zWvZ zFd2bp`f4jRnS$8mDZ}taI^x$^98ag1$R)(P&1_o0pin?qh+S-FdwXI!4o7!Pm=9>P{@?_6gMvMs(c8dhVTnNiQ; ztXNq7l;+eg7vSkRd78N8EVznuC*|)XBqm4<>(+zHQqU$(Iy_cMw(Cbe=%SEDk1wv+O27Hy zp|s9?era-ERQbe?8c=D2PQZ>oD$+vO-4tr|J2?3M@E^<6xF$QZ-|E|v3n6B8kd|6i<89C&X}W1mR(8M* zlK(JTubM8p^WCe$8=T%I;h@I2=DM4M%i`7;!K>&H1_?}e!>{=T6O|h%oiXWpjrb=D zIjC`Wt4&l<5>v9oBhWi~0$*ntrFnloM)&gc*nTgm+CQiKST4s>Z?;D@sLc36Ll1LToU#ya zSbf%}dVLE2cd?yF8tHG+Y)%AoY4E}1!t=f-IoiN4I;5X}z>S`U76>n$KzNCInShR& zuql6sHY`*6>Z;$GeYdD><;bjDZZj_U=K$gTk&lkZ+jzHo68rdyd%UF|6CkT4N}v}R zo?zo1->iHmUyQ1ouQ59to8UlCa_;ZT0tzLFkO>Ddc*{<8nYGCfPz3ueu<7+ZY1F_? zcfi#1d_3PMr_Y+EfWmznwwYiRuJFLRVNXx4MHbpu?!S_m-_3Ny9o!MR7ksaiT@ux~ z)L{<0HkPMjEW{3EK9ylpf~*0dgx!{QFept8m*IAQth!uXJ^uZ)+{2pm4YSGL_7!Mq zl^)J(W+ApGKH2`n6YJc%Un!Z?vpi&@eqluj-iAnV`se}7j-q1|n-Wd0^xNrdaA z{;BDYZzhnb78-zae5rl4a-2Q8Matd76kteBb`bojdTZSz86wK9{7mLplSP%K48g>w z#G|Pz0EL(UaRu?e6? z&KZG7YZzT~*#q?pOYH1^+l%4^$CWaSK~ONKA)j~!$DLOz=t((IL*{9p?fXGDWRQ6# zIiuAcY&K0mU`;8Zjqa)L8&7(`7$*48MIzZIhd+Mnv726F>-VTCg_x?0ixrb`WNrzO zZ{`*xY4bt8WNF1F8O0_NodWl^N;Hd1W*68RZI|eM=E6nZT?%cA4ZZPn<2=)2?}P-l z8X+0Z*-)v@?83y^;a3Yq-_#(qm6>?3L`pT3O~e zE2<+d7dP0~U$J;?Rr^xiOx`}FH@s<2s=yuQV%S6AghpChdl&b%c)cgecgB?*RvWM> zc)TMgwEF4TSf&ncei=i#2&A0;jSf_iz#dY`h+;E=gnV`K5`_2TQpH9!mI17PRI0v5 zoP`9D!ab8pURh`q(r0;i#&J)C)U*K+IEB?ob<(?EKsaEy%g9+LDSkXC;gYv5=t<95 z@|~>akqzkkoTuFx$@ArSgwq=oW#1Kep9M*;(WO#9SRD`b91k?mW-tHx#--=VP}(!- z_PrrLHhyQYMWTpUZ=5-MuujCI8~zc))4oPIh~9G$BTiO)qc=Xtg*=@vxpughogbXb zdu}x{SN@scJ!Km;?E##zDM2Q<$TVc*LGk@N3Xe9YYwTOAD)##sh%47jEWH*cdew_1 z&bazXDAjGfkau4;x*h8Yy%img%;(>ixBawU%-rx7!* zevuhwbS+lclfiA(Lr4-ula1dg`}~qE-#MxVK4f@1|8ySa@C513ypqO}{~d^Fr35oT z1rU~lkRhbx=S{Y^PQeT?@mfa4*7vxvsbg<~a)+=4s#Eq8z}Ylk&`;L}xwoRjJNIZE z*T(9T@)_0fjjz1x>jUE)+_!lCANIcVoeiyf`{~?L)gDEQ(vj9&YN)yMU}~#ok{Y9k znCH;ppeS03##n7pHN=>hA}vLYp=yjIH3pGHL=q86-t?UFyw~q{UFXC52fQEh#fP}E z_geS5?|ZGi_mF9z;te!Y$j6nlvec*`o6Zn5K7(m(x+CQ~qSl2-ls+|azVgb4$@h*$ zFB|Aga(aiEf6}c`y%qsFz=}nHYUHncXljwX}D(`>Gav507sNvn!FX}pdT_= zE>JVXPcnP{)#m8`?X+wgy^lY%L$Da0yCd12LcNn3p|4czG#Ox#>IVllt|O`n&&@d& zU^Byhm^FcN;^RaDvGyP4ulTI=8pA*{_9G6T@5}FwJTUXo#_StU#)x&VI-(_*hb+Ij zG+8>G=Zw02m+2c--r6puQnpNP(3oj&`k|-&vpgF6UA^wkoKm0r=Et!ogKf5ew5yjr z*1RtBr=OF{obqHm6*W(4p_f?_2pz zJ-?)2lM-=gZe!_u-{~^-krD}o#fTE)a~WXhD@Rrnp7Y|(6X!@$U6y}l4m9^~dy z_;pHuB|Gl0bO`?LwVC9>u;r3GGI|H++S} zB8x#TMH>b~+=vHck&R%fzKJ(^o*zd?S+F%qzDMBV{Gv&T)_h(5;oXti2Q?Y&ZR^N_jKus`*3J7}!k3I%^L| zyQRXPTDYDcS?l$N1r0=(rC98Ng*zP~(iu|jjMmE<{HKeh>rIq^uLFzhNGPuDE=f-y z3|Dy-K%G9b*rrocS?xgs8*hl03(hT#-NnAi`tesqQyRXQg1DfA+GWVu_>>6sIx)zV zxyb1%$n-+2jsWk9@+{d?Q$6gh1>ysBuL=RBd>J#M*Novb4xauY5Hgr$)xv)tcl~Z7 zuoHdBO)^zT!LnKHLIKdppM2Hfhwm}r_H~c0|Dtz!KZ&wCQ@c>pq_LROFg&oH)ZP2ur|;uQ z?e|p?)RRSKBM6lT{Itl)jb8eCe>~#>Ju>J&W#=Yt`D$f*@mfCIL9_zZ7;tbp(Wme= zgXG;Ge&1&~Z>{@pa;9-+CLZzfPqAgSWZ8np?;r3xc{2LTn!|a!iU)`$?@TPu-j<8Z zKhuCr%~+3OgmswZve&LYHvK6z-^f#e@R5TtezA#f{&#!pzl}>>fqZQrPP;rR^f%(j zTHT5KT6$(klkV3$=|((j#P6NE974_wth-~ADyL|wlPhs~Dkr+x46C^z!*MX`>8nPV z5qt#HbP93}112MX_}G5`HkWR0I(c4;g_si;N??MnRS05bAaejbKsq#!_M;cJlBaZP#bn}2BJlHQ|t<5IneZvbwCg)yqc zw1}>mcUd5rsWcY?(mlP5blfN;WMkLUf?a>6{VP9lee?kFIB<15Z=WyfKySIBX+2LKn1yGzABla?R{?E=!HU zYFy>*a+VKfNqKv0eF`i~lz<3tg#PT?zLWVNcp2{g0;@^wZ_@Phil7Iv9d@Er()zR6 zxk>I*=dSr;Mtv%g(6g?My9~vaD|7uyaK1LyPk)ppyU&)XUYSIgYxuOgPd+k#JXQJ7 zrlP=0{wCOd=iW#WOHB5CO&cBR&kql?lylDqfGn+056uft_Brgdj(Rt~5!rAM^|5y0 z30nh9`{VdT-#K60@OcshZ7yZma{I1mlEr>0FZXw&Z&D*0VhEML5Fb*nHU0a#<_gvo z!8pbs=YW^x9GOt%~7^5#^gYYX>&|LH1oGJ4TkX z``^ehmsLd|#%Giu&hilGWBorrR0?n__Z>vq$D@5Ma5x}vEFEZY{bu3Cds`BVrU0uC zzU*#!`(3u%rKEc+ zebRJX6wmIh7mmLJq)%U+^fUABryqbgOY6K3-F{~6Iqw=|C!u2S=$&BJtu*)k)0+J? zw-U`b47&@{4FWq21^i6G9S)O;dI!?GEvO!u?6JdFf`0Lc7O!6$8$1wVe$VKtbbRlj ztmUy(U&e$UFOnpm<30aZ|K#RxMdgmXcfoiE>1GV*<&dLZOk+hbEdB>PX3P1NiJIM{ z<2<6S>-%$+r`S_Of^ras8Ll|SbZ828Z)){PB?N`XO$WNvROT=Oam#b_7qC(oi_Wdx61|Z*px?Lh7g4p7nW#$_;HnP?fCQ@rSp8Vzq)zk&iLmpXHRCR3#Wo zy$LgcGn&ExQJLT0CwQ6`9Uyu`PIwe_N<2!_wjeEq%)65+NqDKIh3!0FeyHGp@nsu; zuEl2t>*TWQO%EI8*R`_~6RnGezGqGeV?MvSA&G?#Z(fxysJirFW7Q>Qo5i#g5Rzv6 z%U`*%G+p}>@2ZN&t2C_IwG&czM}}JC|8-F4mA!zI!A9kN%0GD$at1AM_%bsR`hMt` z6-TCI7H4|YMm^bDmWSZ1RIMmOr!;N^GN8f>Z~r__m0F0g3eC*IVc$UOY$rt?FzW6H z^1B_p+xj<0gf9DuLaDWHL1E4zi|&(NZF=)EV%sSJyJHJSdsP+|)?d)&`S^1hj2zlJ zWjbI0Og6;-1YNJFG>0f>)G65B5Y-K&C?1D4g1_Alu7m}S1g?AaF>SMZmM#o)YrqgHo^Rck0TcPUi6jr)QFgRY`Ge;9Clqj(O}KmxK5Qa7l)Xd&vGL}KmP-bZi%=Wtq?@P;0JXd&| ztu;Dq*p(CXu|FpD`nYyaNr-h|2V-==s!XqUkYufVCO++r%X8DS=wb{hD?68{rp@=W z{%!G&HT{}Eo-x+rG@VJiG5PPvlp#PSZH7chijbX7w7$_0Dbk57F|V zu+2pc`-6%kR(0mS{VDm{2`CjIzRfReA3+lNchQzuh^-qqO(5mBMp&rky!xt^Dt z6iw&GBFp&iuH=LcWNcIRJQ(VGBmVJZJ|(Dp67%zn)WtFO!Lq*Rh$f8|ZV z5ATp$(t_QOzLtB722+)dqDvhg)7ONwgJzGvef$(4FXdsCUqLdm5^$&5zLI7=&gI+{ z3+I0w_*%LxU|6X?i&qaFsrK89HyXmW+6>AVBPWMwPA!L?ir5$Jj+|M!_q*9CY>U=& zoLdDES<(O2`ZYOe`@3b^K&)%T2`stleUWJc#}$L*ATgAw0|IO8XNDfp-orlH`-N8Wo)f`^C zbNJoz?#LalYQ4n%Y7W1*FfIBlu*iz`hyLp{<;gdKpH{Rw=C9M+JY)J!k`m(wA?@Fo zQhIC8as0hDo($7wpSe|HaJFT{zo*0RsWJr9>Cia#_cvsBC|r3`BDS>0r1!mf1*yP9 zEm=<`?z3S3<4#ZfyKuYrdt|QGu>*IW6tDIa(8y^*Rh}90fj{yT95fQN$YG;u%T*}? z8SHGd@UNq5uPT4b;HjX?PLRL8;ZWi39XS^7B>!_ES-a--wom4%<0i=;$kV+by6}>51JQcq(W_o6Z_5MWB(cTA{6zmo1wGcL+68 zC!NXZKmnmi2_KxwgQdZ3=Upp|X*l4q9?Sk^JdL*MR!v3sfseDBnfB{F5!du`vFYdL zVOHj1i(>}PYUc9!ej5A>E4HWOrm2H@yaRR_TSS|_ZRtf*@~s_V>Hz@S6Tw`+>x(xs z_ir~!z8Uan>9YMSaDY5&AU7XYq|-WKVMj*sdUt!N;1{Es-*dN(xE>pChaXJA&wpQZ zMw+`-zLWx}esw5C2bK1GuYIkt_TpJpx#q1>cTZg_4#&#F_dj7_oX8`@T@D6 z{b6NJiOP{)h@+kZFXG4Kbs@JU|MDCM2mNastXqXo|2i0?84`T|6=Hr-+tJ;gty}gP zT(EXg{P_bh6Z8Hr|540D1a}$@5-?^W8``+bSL6xK*;4o6M{3<^;XMz_=T4uNXwK2)DMNjat1`x&d=iQ7^|)53kUuIz8`9W>J?*kcXjs;Qi)m- zK;aQ+=2V_b!RT&MYt7YDK8A3Z%CAuffTY=?^>fhl32!6)h@hdGcYNU|#BhfbkZn2`> zk_PM@BdBECg!O#(ZHk`~Un=uOC)Tdy{OFfa$#i`uY3S0-$i7kT>A7IswVW>2_FPmd zwm>4s1ajmlU|+74!9SI_-tvhF92&EVyRmaDg`lcukTCFv;E{&ZAO%xBOmWUesqo$X zwoQzn{kfCz@}qqfSLWQGkIQmPzITitq-|*jjq7OL#^qLGrR=i@jUJ=Tk%c3a+A zDlXTz9Apa8SH{h=1IEX{X`M#{Vg0SaA2&i;VsfR5c?0I_<624{lg(2TF}ou#CcP0H z^3pmg_h!CtRowKWyQStRC3VbGM@tJ<7AF0XN0t5<2*~`|X|4ihmI037N<-2PMiBRJ ztnb6TIhW1S0Y6T%P>=?XhmKT9;-)-2LoZ?B7qNB0D3k4oyYI#shF3-YDOe|Af)b^1 zstx0{qaF5=QlMJyRBQ5tUeebrU%YFi@Is9T&Z1}QGD+%9iI6^IS|VS|Mo6|iU8II+ zBMyr-Z+jJMULX%iS`Obqylmb$LR(zE{46311QUE#k+(jYTP@^(6l@5(riyaqk|p+F zV4C2E{ak$a@o~l*(R}5~VfgJXo{{cOL%vVZ{V|}i#bQNWn%%&!>RMZNij{NtG$bXe=(UA%NfqO8W}v_QPW+K#?3fiw|Z5>b58c*3ixD?YL;3T3fE@OgDpQ{&3|x;xxZ*d4vA z|3wQRZr0XJK=AEUNO;3vG{jh6$&^C`TTbp06-zcAs7d-r9flU)zO^5A0DjT{)yfQh z4k+Bnw_xTmLH-LTGDzk2{hFhZ&g+X?zMJ96z7gZw7vUlz18A{`#q9x70p#X-4x#k< zK%t?VWEJZ^s)}(UPg1EpRqLvx6&s+U-ge|m&d{_~l5ZfoL zvfbwz#?#UR9oH5lmb7xv`W2n@F#OaPo;Sx(Qz1ieKCJEj7ZzA(qrN{9=BQ^eHg)r4 zbAt+HDaG+4b6F}PW<>voR~62Hjx0#!W8u`AA826W(al2n(*R;Y$YCt2ML1 zpcX=fN>x7Rh19mNTX-gPzHnTE#9rP2c0IE4rvakA)yw&U{0-Hb0IzHJ*u zU0;dCXoEHRkhRsm^=N14!#n({Now_6F+b7BqJ+B@yR$)9{`K4PgPd+yG(-Fauo}5|OUHQXS>Ih;>%h#HY$Qq zl)R#n%7zCKTp4?3AGr%d4i8tIkynog4tibC_jwl~Z{rJI9mtv*4eX#2O)J6m7OSS% z+*ZIjjb`8am%0t`CXvUE{R2Y**Bm>Z{@to(G=LBDZAj3*(Gd?aY0%NP61%|a&EAXE zY*`ohIO39$NWYQR73!Yb-z(aV=+ecNCcA_~vd$*Xdop~uXJ{hgrJuAoE+<7Af zwl34W2!S!Vs-&9fT1fgzb|7qgiG~?LLfQu+%hwv|$j8YQ+Ca1eo=nyXT?KrO6!%yY1G%cL+o8$eeK83^oy^w)n6Vm?Tc6hNTM4A*Syos-my$b zm(^#dtTlLzV{-WTQey9?<34T)1JaL5s`8Gwuk@;Dgbf{gjH|ot2dKNZRT8;VziJ=< zNaVn12yd^1rNdcqP~-JkeJOYHv&$Oe#MY5Nk})~*nrar?l@0#0gDAg6zMM@iKUN($ zW{h(9oTZ#80!QkRj6B54-F*YfL+bOuA+^4EnKF$tKHRMLJ3KUE`fp>@n~OpPYw2CZ zB0wC%)Bb=l2_x>0`Ur^!x=l9?wPP_9M-Z>jGwUH|+wYBq^La5bUV$cN7wU_FXmC*b zeFNKX{Mfr&vG9srrF4E+g$AP`G@ngw!E=z7$R0J>Q+2U!JYct3O5cB9CV?plI7}1t z+Q5HnWWpXPSxp^P_+u1zB9e}oeygmdBk%S#jV-yLWb@qw-hx(%7r|Kfd{WA4xbqY2 z-8!YOaGQ;*!EWv7?b8`~R`sG#qFzMjnpGLnrkAwWXWQIU)9(B3ogoD?FHsSli+la! zI3ka3MSaXZZjNjkq{l;j%HlMlXl88pPGwljAV2;w-H5F*vJnzn*j5!=@u17u3K#j} zEOmXa*&D%GP_do5nui7hI!0cmu6Pz45Z9+h3#rPgl`G!-mbo0vnrva0%X-Lvk(E|D zqe684@mx>apXqZ6QIp`7N(RfB4t(!O+~wpqhV&h|&wUttC9Yq!DtrA79sFV0S6tI= zMKF4pgq9@(qfnN|ifomC``Ygx-sCjNcI^JXxR+C_J^g6h)#=)cto3}N(~u8pO^VIiV@F2ZY2Z$3oxOzbnKYle3{hSL)tEX`uGOw^!6SQM5!)`c|u z9x;BB-gmQSWy1Jq02>v=yO#Zg7~}>nKBxxaIviAXK|uwT|v+pGN5 z!z->LNf*zK{EFKP4?fWQYT%cx_`k5zK$XsBg4Z6bfBA7U0~s?^5bn{0bB3u4~If z9jIpN zW1K}=LQha~@(SKg{{il7ftOfQnzWS{!epCl{t4lXu-Hpx zt<=(vY0)__ocBnte?h(?%4}XjesNvQBY#m6-+CAkOMwlFPQm?f^}$h9h5hlQ*l5&R zjHxigM^mR~(oc;AX>FKPq1iY!87Zq&2QsYu*qi1>#+^W9n_Mzd&&i9hQa8Rcu8`pv zvr4%&Cw{?E*i;Rw&p|14>;g7D+;nc8TGzz3pFkfie?r~1Z;Ymyy;VJGzHTd9-;ulr z#l&dxyNpsA{F-3w`y7vez{c>9yHQPT{H_B_bd0KVM6(~(nV>_WC%ddi`UG=loJ613 z_%FpJyI{dMFq#5YtN!dzw%Evd0bHo_aJ$xSKSba_2E z`ih(6HxgIAsV5iu82NBp2Vkz%U}zv1FIeSlbym}Nl~Ond75FsrVL>q$>T8^rkOB!tt&v`G7aTd9CK0i1i zp@oKG-RUT2w>vW3ez^y8-5CBn%Q-v#O&YZ(iV%1Xf0g02DDk;6%+I+A9mKiSPKX7r z4g<{+Ox2uMw${Ec&?F0hk%kIzqC6R|3qZ8&rI;(YKDJ$*FJFE%(jzhiS&jB;zbv)AcPE_5TU+vw{#$ zf23vl-w>AwSCIG>>M7)pqzX$G;wGCa9rHG^vI;yKc_d`=$RI#>h$R6Yp=oDW!HATU z?(*7#t=ZHn>|;d1HBBxmR=SP39oKoMb9Fb6lvKH@a?BBmT^~wZTjFNqGaM*u+m7Sy z3-r=#i1qlK6(=sS37=6!^G-P-_&B+Mt#sEmURQrutH>X#D~efLUtXIx&3C-Q^sD2a zB`$JA;|%$3(R-)YpYtUaLG68fZ$$&TH&ZI#$o8E0R$V#^i-+IZI!6u$`*+ zd%hVPtzu>v>*4WwHF*rYTMp_THnE+i9h$`_6z;cD3*HikUs#2fH&!Wq+9H;6KIa26 z$S8SbM<4wop)oTioAbtKO{0#-kFQ1>;s0Rxpf8J8xx=>`xhB(|Ve`n8Ft?f0fD3gb z(|je5P?@NU7Tyr2=tItf?-~Auo$!!pN-adapJWtqqHy|%5&xG$hr2$UrbcsU1(VLu zLOmzp1)bw8WlK|^+6xxbh=TD=7Z^lokSz{BDY&Ys7>XZzAg}{5*{(U9Y zRAEm0Vr=sTqu46-9mela+wg1z5`wQ)S;aPJnK2(jm<-dIrLPJ>w(90a8&0iTC7fL% zC}Al#m%is|@rL}+KAl{m}H#g5mH`ziZIEe%(5+-UYrrR6+Qre`Ail zk?|xUm5f9m7u7!$V-&qk*;M|zpe?yr6_)`FKkM{e92+Gml%Tj&$q5}>9;t?}^W0o8 zHDWG7t(k=0#! z@=LP2&lyHrM}#w|!ujQ~`XZGx)-Hr0Nb7RFuAD`e(mjmFy1rL57#GPXQ=_a(l@bZ9 zf0P(yqm$saJCvye`;4)28dfKvGS~PR&tf}+8_Rdqc7l@A+Hc9lDz5rEXIdNZy!K2t zpUd0qCC=@8q7gesV+Ux)hM&ue+4AW_o*a}MNV2_w@T0d<`)GznPW>y-f@CFq-QS&@uRP;A#+eg<$_4n9lT4q@`%S>F1h^mj)7 zT0C%m31<*RHTx$emoBK&^UJDP%YzCfNJFNpZg5!W9~GQXODLzSO&r0-TNXO10*nxb1~hNbY(+z~Pi+*-8C4g!TtlAe z8Q1G$HG{`DbY?#aa#~3T5q%LqNOnVEeJ=M$v%DraqZTeT97PP}8GfF7YgRKCvC(!~ z$zmrp<;GH`){vZU1Afza2m9d)0|DKrv;kizun z8I*Dve6m4<%{xYPCB}GybNnq#+zH#)q*S9Gc**M3@*z1iR3my`j&NKX$NuV1G)}$I z29yCRT7;?P@G`;|DBYU2l&S>?x9Lm(@J-pBii&U8?Ae5~1^o>0c9r4GH_0#-fLGag zNYt}RmSS~Qkpj`iMV*(44R<^S5#MZSnFpeSYUs+U5YqTFvcBH3x3ppW^R z?WG<0R4Pciu)(Hrr^dJPVoXJpzE-18rREz}+4+T)>kg75 zn9&pYD6-pE0{}@f)QI_TLh#JwMf9jA?U<`FUW(LJ9+>WxMjg#7x-ry5f99i@*|5hALUAyoxU8qn=gmqOEhnbFggOWx zomwe4NN&5~!1IomrD{|U6u+IG$5raj1x+y-s`pgTHw4_LE+1$l$AmVjA9o0+0x+`u zRRIC(RiIqhli5mov$9ZU|JZI{PG}~~Q%DUIm=T7%{2ijhMZ!bt*b6O?07U(?dgqJK zbZh`+@GghyCH->jJRJ)J5pOBEn7v0ue-e74!X{PHlAc5_17S%wQa=HKH~VP zqXp~gz^Okz00p14b|vTL1# zomD|_oZ_7AlKW`SWi9KCmxkS<1~|whAf|KHmLE9iO0NM=ovPIQH_Ab1%?kLg z;4qqYNz?A5#!FW5H)cej{}7C`0&qK5bKtbe-{AJ8&=6)3E|1% z!c(QZ(IS6PYd%gLNDr!WVUjlq{lK`%&8=I;+W~L6GimMHg#J#)l}-={A-y~mnjKSv zKr^9#q^9>-yqIf-bs~yoOplIVl@YER}H9IP-~^nZAJ^;O&Wnz z_!h%-Ufk%+p0i#j*XT(Ulpu_2*Q0xDqEfq+dbB}VRIY|#j5WH4YlLrKpA~MQBTXp7 zz5&>ksO{l1+MEw0LXHpz=p}hEL0RZ#0&2Jjni)3!)=FJ1_4yL=0a=SV3B&Hi%D{7#4%)eq7=VN^8@4)bjfAS1JaF12+mktv=7HYJ! z6Z@PIscoUZakW)y3AWrnYJ#egO%?|7L-U-X+603qXQYq$S&+gvUErM z0_c56*7r6=z>OguE_@;yGq(1+2bf4U`!j`_Mh-S_Lu5Pikm?u5eP&goGQa#P?{IB- zKIIfc`W-}fHdm)46m+93PD|ihh#Ih)3En{>eUez8xKx6k>>`nLt&f|6u@a4RMy!r8aVKl9F5 zTjO-2#K!+e}$z@+M*k-V%{TwKm<=)-MkMPA$J zN(uy&Um(g+9A}O3eodFDPnN%xF0@9hjniEyYVd?UNsIUq0;(V?ImUKDaMkiko8e=c zH>;7{8RBKwO^rtjVy6h(a?U83(s?E#K^C0S$qk!+$^wU8tLX1v;NhE*8F~CK zH;3wnBC+hA=2f^WdW;`lI>Z`NBxuO?;pwzk6k7Y6On;}0J9@7)D4Ut{cL@oH?>@SL zS9(mn_76`wcK%-L%E>=>S$5wUa*W)~`)T*~GFnH5YvK8aq0u-c6M$(*F8q)2b|Uu_ zXLq5jO4otH#A>#ioJb+QLDR^sv_%nlxNuLMA$|380r;C-Dz5oL^eo;o0f>$@otVJ& z|C)82iSTt6i$dWW)hEZ*e(R5R>}MN>{4>p`@L=PiL4>HgiK zf)^W38=soMXkw!WLvccp0YUa~vT93hM=QV$AepQD%{}>`bpv!#RQDG84l8F&F_ z1m+Lk^4|PfP7oarx{d+XiUWUi;g zMj+`#b76m;rBQ7kjBVu~C;v|QG39%CpPYks8Oq1nPQ5_(L@g$BI^wF7@@=xd zqXgbgnZVnjII;%N5tq%Nl*Cu)_|uX(Y|rSLlT9Bsr?c9>IR(u6&7|la;rN42BQ`nx z(!qd3UUjHPe(QcO?hLwGL|XWZ|ITBw_zV7_(M72&HNYtBzzLp5>p3ht+!QgW(zKpY z)G>b&gax?7?#mabM+ZO&k3HIz7$-GEq z9sXkG+PAMCX1uFRjwI_#&g~P|5J!<{uy-6y%x>ohYPfaJyjtv8-{zpx+c;WyTo0$K zql*^jzctg5FM581tv?7(gJ#)B6o%t^Vf(0#3ljDD=duAJ$nB{ym$HR&AWrsBERuUA zrGXGwmq)Ic;D03$xA36YA$aDtbrNl|SYfu#R6#$gG}I}e3EVx{g%weA=0z+_F#R`1 z5pMfA1*l`8_=3r$sg#e~juSfdNvRoOox~BYd1*~eA>pvRywNeEO-qH2`2=l-!1IdP za&LsJI4P(vTZhdE>Wn`J7&)>GSrxHT3lR$7PTK-IXER@ytKq0fXUsX}-@E=NdiWG_ zgfR`w3~UvHSffa7Wo9)kh3hNEK=Pp@<+rv}{-%QWN}fCez?!Gz|KR`?SKjIFXo?@o zyn&3Sb^6b{N!zxmwY`P9={d2{stE+H@f;nBUva|TbE;x+5#4};2^7lcSac&ViYAmt zV8=AB%k9N^LzDr|0T+Ftv5O}J(#E;-{ibq0mu9a=e(y5=4Ny{+nJoZzfPZC1-Zk-e zLR3Sq_W_@@ZS}Mp|D((DZoNvKh|7GDd50XX)KY|=!UQ=S_-+{=y5Qx}G?<(RE=(M5 zV4_AMNuwfuVeGEGvB=*cv1!o?of<65B$}iUVo&Emy#i^rf^7bk3a9@O5Ev1g=j6vX zL^=@YtL$nHb77}>8u4sAHuO)iTdY5Ou+7Q3mDuVk-gb8}0|QRmB`ozjjR8g3YTrYE zliEv=PkCftGWPl)8pC@BEFUi*NXxQAORMY8NUR)EmRza5*h$&4Z{q z+VRLaoksJ9=9T2XbGecIo824l8~X=}PaYyP3gkeOZ4vX_F{Tz$0%~WFT`*cT=%$CvTSKq zvTX9}xC3=H;Y!2FD8F+#(A+CvRkhsQR%zGtprLuTYh4^m_R_HK!(3RKh(pW}Rnxq3 z#v?|fUTP0&dj%fR(w890^Gk^UYv~$8^#I@?&th^UX1=xHQt|%aFO{}#Wyt|)k z{C|;%9jT(q&MKoJaX-kMb~Y%is+Q0L$>kAtMfe-gPCP%2_InHZA_)5hE@won_3>nMPYMj z(zbmcpZjov6I}X~Cugzzt#Vmlc&PXDY9Jiaq|KsvAn)4CkjkN1f@>_RUz!mPi=t{R zw%rOcHCEIWkpeklZyw)+dVjxh_%ANi!9c+qfCA6@_YP!A+#4znj;xURJK=_oK5eos zd}(X%?6B+9ILxFw$r9tC0T%rYz|`iu9vVibv~LJA z;R|YXv1iVgSBBjO5g0_>SQ{%mx6N3p5ywbbr6>QU+;@2^pSLS_mZz5*p-!yL#i_F_ zT5EoBG%|~K9GL_HBYmU7*Bh8*QMzEyL&e%t)e1%T8BLRVTSJrC;GmB}k#Rj-fWQyd zc_=842ss`h8qfm2D+Vt79Q!fGv7)tYHiu&gni}7{KB&CD33WCksTMwK6~#gM&=2GN>w+O3d= z1M7#NJVYTov6Ib?t9I#77u%|v=?QNsH6>#WRe&zYKkVPWC21YcLBB5@EiIj```%o* zJPx2wju#vdH5h9myTb)yYEgbJ{_VWXrHHmoUL5aWj+e~mfza+*^sa1bKnO9#SWOXl zX_*MKA7~|4??KtMP9nW&^2}HiqGh%B5Ir&_g51^{dRoRfOwrem;9Ye(LaKz+>9Gh* z!?5+jRaZCLt!BO$a`}gn1Cj~d2S^T=tKn8;no+lp)pnxAiRKl%$# zHrg?J@iF(C3Xw*eR*g421UO8%U6nGXTA%VgWs)g;Wa#>V1-M zuSAELO;d&T#nn1tO)vsDh>p-Q2w3xPjNx0&`1<|O2Uaf;C;dtp5J3X(j;T>|3zIt_ zDThr5%kv`*kuA}E&(V%n08qzrg4}+PhVAv2gdl@FZu{ai=iw>KCUL3tTqnFA_7B*;2=jqQV#j=9>v&ju&xZJD7+n-r*Iz@nf|uX{ck&X{}$7)qI%$ zVmYT{nLpiZ7}{o+N0+N6dyJF4x1S8n^zZw#y%O7AM$kJdzaP8|R z)G&3|jCmBNy)?{M zBrN8U0e^)2io+cFkm2k%V1B5MoCn@*iD6^~GpZPciJ8KO@(`xiP?0nwq z7>(1mOH?z=P`g^6bdffO%uPnNRhksoP=l!i3FKsFu^((dmcnD8H0Edv zRrOCcA0+RDiar%hjx%+R{g5zQNvO4z3j+>_Db!J8FUf5F%xc6TUd|EvU89JRh;jI4 z7FKqj#HDp?6k1zfuS2EKG2xg&D0ZbnaTXtJo94_sID0-cKQ7?)yN~rf+(3AG$Z(!P~K8RRN?-OT=bgatRLJ-x4Dr&9E1<;u7rqNxlM=Zf;VeS zXJGIGdwd}g-kKlFHEaFM3ND!$>oa#Dxb15niwy-$1A}8mx1<}HRJ5E$EXk~~&0sMM zJidosMF`7rjImZHyA3&;fTVjN$Qdv8`IZyf5+Ljz2VAI34U5 z+$Qhy$GQCQPU;z$QjDaFA3-8@yK7KAf^&UhNVTd9$`o|t)-(Im5+H5CkJ%j_?C4P1 z){cKX=@CJi_(`F3{;NdlcQ3a0;9A<7GTTSPb^j3F;iy3m>(E`0r@DUGL@CU=uenEC zzy0a(*jL$XTKh;>?Bi>1lQW)c8n5OEr69TeX04L)BQ`lr9?@m_g~=H&W1|iG8z6N} zwO_LQS2EAkv}Ujs>qo;hHu9I%8-f(+zC~uzPyj;pv=`$eF!yq)ky!L(NkXmx1{k3G zmpsu_y12TI6U%_zbiL@kJtjh9W(K(wDcwS~3c}wQv#LMu%Mssj4OKM*i(-Oh;cvk2 z>04Rhojq|-muoJL_Vy<|S{x6^uHQhjWKT!;Nm_QE4)rSsCN@tBDDP{n*0+VJ$mu*i z9d*~$teQq>2-S4zsbkw=XUc`Zx~>$YFrsln;MJ(ba6A2wR6s zF>5`yhVNH-+9Kt!{ngH(q`7hBqP5fNUZ!o)pL6+Rw1wq_u!Sla4AW29&x-cxWIscf zmwamvEvYX&4p6d|lfwANZEE~orgboQeX)PY*wt|Q)y+*}!Sd~Cgn|+1F>3``zp9Lj zV2l;7(e@RtM$2h;gT`diFcr(J9%}!4LjdK4SlPZ>v9bUSFr?MoliB-O)+J7^)3Q01 zTUM3~@e?AZH|15_OcUVIGRgdx3%JSvM{$F7KNYPlu?eObHCAdxN13 zJztRUZy@&*}^g+)XwHdSRP|V@GuL-Ms$S-j;5|wy0l0Nn)TqCw_%?wFTzg* zXwrWI612GbIww+NX8ap}%n5y-nL3_kyJ;W}U+Zxy%N5CMkz!Kx41V%FR+*bu;&e*% zZ#-cl(!pwNf7u$#e;)Na(rD2~94n%GmZOt6bygU;rKseN+&W`BXl4{wyNpVX_ruAg zZbQ=IRXS@va5=L4K|Wq{rcKRxY1=aeSw-1>i1xV}C?$xS>*chO^O`doGu)Z}4aGTU zczmRc&iwX1KMXEqFq#UhW+@%VP;LkrFGC$iVYZeD-0s0(9zgg$w+)Az%gUW}dv#^b zm(*c4dC|9_+z$kVY8d#hK0sUBZ%3$hpIe1X5Zv?A!m{)($yG(qCHij^4_cYol9zhb zqKH8Y7oaM8_JnhW z)+i0te6h5Hs!JY_E2D0I)Zcy(Z8TG$+taAeaVoSiDKc)c{08Dztk*E(?7pGYBm%Hj z2xqbExJ#}4Vp5WDTXfVT&|vTbZ%}&>8wM= z0w*rqr?s3m7M=}=x$NZJ=1lrbLv}fq;?WAxTd@-|T~SWptmJ&Otc9GRO!9FQGV%Ac z1o0QKgOUbLvW~m$O1G%VU{${Lp=q6i$mpt1e?W8^iC^_Q zSir`i7XRaX*{~SD$7uUi)3LH}r4A^jKvW;17VULfx>}X<-0Ar>Xa-&G@I?t0QF=~% zPHubXR(lpd#&p7L@#5Q5R_QvOqSpF61m`aU{WUyxg$p4s?J)`LJ4Ge2p-sw3+A=}y7ecuC1=S)Xg0(m zUK7r2at#!;5qnfzu&DpT-kZlm-A4W6c1ohe6opb$mZ@aRo=T-?MYgeovM<@jUY6{Y zA}N%1d-i3FB1HCVS;lT;8Ozwm%`_YKL?zVfR`o)r&x^vv#kZ?pg1+8GCizk?zuTH}^ zGZl%NZ(=6wA3yhqJT`NrLi4eUlgQWda-SKm#!~}G2CGYxVLYE+501Oiq^6i7BmGrf zhJI*Hq;-|`6?iZvihMzsV>J7{dr^@a8VJrJUkRCyqLRh>C0J{>S%CS8$FW~+Cd^fM z)u~?$2*qn8d={Py&opQ6OrOTrkN3k9tDUl2SvJCRqVfQb-=b6Cc2l2_>}jx@$@y&5^V#K#W=mKub5umbciO_lkb3}>19f`pRvSN7KU`S-2rW}-Y1GFeMQDe`zP4&>wWIRom9cR2> zCASuL^9BC~YYFz(M&LOpQ`mFqbC$N?F|;?svr$D>lf3bJ?45h{S{#bnAXBI=DC`B-D;13e$tV{MyfF@>XO zNT+lvgy*L8GG^rq7d+PFOY?Pf-hW|I4645Eq_4 zm_9pojqxn&{%u$qRA+qmM78q}l{GcOvzenlp+NMemw(2&oxOgY5vlLnLh~8u#oDrT z!J{?AH0q%aoTu)Xi^|eez@bkR7){17?Pm;}xW15BZA8sPT$F~LX9{GqrvtYVjH-ru z8@6WXgy2TtbP)DWnz^mmgs(%dK~0-tRKQA^@8p4zs#nY(t$?2~_F33(KrZMcmb_7; zT`Y~rDJHf(j*{Ln9C0iobu6Q(57C;o4_Eq(aQ^YM*Q+_}`8qfJyk$>k*0g5+D~X?AWcZws9npESt z%gS+0`A&SofJYb|3HL3#p9}aoA}n#HLlon+x)_(s&*!h7s;ttG(5>Z8aM8DL=zi5B zP$Gn_cd-Gue;nXGxQ(`Kp{Ft_mD{VfjK1fg2(mYRus`<9!p0ABMMtZ8>{X*CWjitt z4hs75j_;gGJ|=|GsRE34AR$kfofUt~#;IJR=u@Fti0*iOuy-*2duY;4=Qss!*ArY9 zbvoc;vsE2xRn1Jj1RhVA8}41wxSc9~ud&Dx(_RUMf^Qj}tk{(C-ME@J1(%EM_KU=K zg&vyw{$-@3RyD@L6l>92(CZVqac{fbY_o{Ot#0;P9$*+kPxL{3`z}e?M^DKx?~+z~BF)==JTa zTW8&OmWSVZWUb@QIw~*EJnKnfJ%#>_ek?GPb%L=@zm{jtpLBISg|4U2^%T0ELWvew zPZH}%Vm(Q$ut31NzOx(~|0X}ITj#$>8%)rrZPTKo$9Nx_ysW<)_ibdT0wK(7=z0`# zoNv-1(8rhYoF_xFuWnv%pWfitmd-ivsAeV+eCLVA>Ac-{d>kpuet$~FfR_IsW5I(o|#CXP8pq?Y4J7 zjc!tn+Q7Iorz$78Cn~6Q{zm3>WBsr}Z-S>*PLQ|5c^Dy4Bi-wAAETGAu;zhAmExHESoS_)5j$T)H#$H1CDdQYZN<)8nF&{ZbBX_H%)qUb5HK8og=R7iL z_g5`~oP*(yFNY92B?ceeF7uyTl>b+=@}UPnCgu*W*F7f8sWhAkeOk6{?EA$#8{sJ^ z2{w-D(np^^7Y`rXCdkoTzgY`sKUv4yRp%5I>MG(0ME*VFb6}isD9TYUt36}k+1tk@ zr}|ux;!oi-nX%Xp(%MTC0>2m{koiKDiDs$9uE-fgneHsKuRu9?{ubSMq7QEr?BFMc zgJ`YAA=Y|f2mOvJMMy#Vl>K*2xG;NU%cyK-sv7^(O_d1eJ*Mh;w!L5NH~S!zVOpA| z;}9jUuBq-)M}HZlwW+Gu?2j4-@hK^%!-Ki41z5jNdAzIDmqgk62{&l$Jk?BWtF=$` znvZh0J}UAg7J@YdFS^GtC^q!<_}ey#W;%nx+RnOH>=wh0U`)-WxW-I0MFyi9SEfy# z+5hp)C!45jq2|@AUT&D^W>@Wp z%OUo;0&b{)ltJS7PQ;AmF=-jhSB>~rB3{gpDEbg7!8{Fz`CE;yBVY9{$0jJwmE)G) zS@5flzg-tN@D`=vC)pyVa?ljbOkq}RMO=KeJr65Z3CfD)`Q$tP=F|0H<926$bnBbw zjMvy}kAElRZ`T5gRhJKahld{c77xFwX_%!;56|fm5S`+0v$m0rON-9v7a9$Xh_Wp! zPuo{p^E*rA?+1nmyd+}r5*mJ7>(NFyb8@u(!OK;1qrq;@+z5W*NiQFc{b??Nz=PTi zH%Lz7{6z=iP3H5AIOgZo6OoU=LCVT_v?}AyB4IN#2PulYu3F;!h;6j(keV7J&C@o_ zC*5VGsNPG8;D(U%83P`T`T{Iic=XXRg?+5p51{=szykl=`Qo-VcZSk49@%yt(8YMQ zFMk94NyL5%s`t`$l@h zGDP1a2kM$IFucz|-9tMNTNe&^1e?!?oQ+r3Qt1stjy}(hdp`ksWBE_0@$D&YnZ4V| z?@((#7j1mILvfQvmH(^U7)}&>0{?r{&2O}&Ie1*(N1(^RgXzAi5LUNjUTJxYsZJs6 z@e({PzX9sKixZuIE?;~u{gr(qRtMa}8{@G}Qq+iHhK~SHw=)2*cqw^s@oCm*8UQIb z&s?ffTsVRWVw=+XWpr3C4>%q;Xcs;T;RUaf(Hv;_QALel5|jcD$(4qNh>r$P^ZZZW6f6JA+ztGeiyr_*0AcYHINgRzLtA!0f_ z68W{{MC}@$TaGrSYq}XBr>^7XU%iSt&#^J_X$cNLRHi#;6iKJpFl@Hrjkfq!>wO6D z))yH0W2XW?=a^{K`zO>GD5&bSWaXfN-+nq>d$**30#9yj%ZV*q7hH(@+PTWUOsao? zcZU>Aa0+-PNBOGeBW#4vN!h`Zt3>P?A}u>TzA&{h=yo6jyv~P2j8%Rq(=2cJfi9Gy z{S?D!%E0bsC#~r=kx|g`2Fec^Jl;6dGp>vBNl|W!U^MEq0iYnQ0Hr~t3+yD+3|sa= z&FO61oW&(aUm3Cb`^DQ8V`R2eNN;P1;ejO*LL`hoyjBSTaACrn*(HO>OD9u=Zk&$x zVF17H=_1RBTyW}F>A9+&RN0FF3EpPr7gSorPqV4mOys2xz*KBL$FTtHt(R*bHzKqi zOMT({0z40O@#SGurB8^&Fnu4Zg@2a%n_>V_kb>*!JP=5f%S8A{elmS5wYRTRu+L>$ zQG2M6{l3BPwnx9(5?+soXxMv0DhKJ=C1l>=_^1)3Z%Q_9<+`^&Iy#Kz4ao<85CgsE zv>dej{5EomI>-g^TC@ANwHLzv$8Nwklp?obOReJNV(B|ReRJsu?|&5mn}l_o2M-Ks zs>&s%;l7#}eX0h-qvwL#&1jW9<)$TG6z$ajz-&q?MHX^nz)*ae9e=}*q*~=F)EH{ z9NxrSK*KmrgXuZ45srD4KD9@-9kC7EWsTkK$U>gGWFBmEV&ck*4@md?9<+GFLb>~v zpv~RJ+j{I}v}#bS3j6*M52%)@PNFS%?+3(EJb^~k|Gz{!(5HBJrMN< zAaiq#K)`dd;cw5Q-HbV(MZYQa<(7^9L7`Mpd!(DveQ9Mzve!K&nfFL2w4J^5OUP|) z@dS0VXmC-=kc2WSwmn2U+@MB~j)J%~1s?OISPV(ODSkxo<-*oD!2SGXBfuQ;Uk)7c z@CM+vk7sr?N_o>ZFfQWZM=yyF@k`VZR>jPP5p;!BzXDsxw$o5cXHO`bCwUoqM<^H@ zwoN>dy-f9W-=mP5L|9DwE=x|U$8auNkom@4_d7|2C-~6&K5YQEGzM_>%mIL_ddw%> zWf_R`7Z0v;93Xkhp|C59o>FH_N&Pfh^iY5Hx#-;#N>#O6hggp-S)sY_Wlzb>aZ-wF zcit_aP~^36zu)BZ8%e%KTw&*3VbThlKh9WYF9@ru-1<==h^-tR)tK&iyz%bCI zW_nUCaet>1g)aq9E^~(`*uNtYmA4&0zalv)a9;5vRuK!1^@IL#>iM$!R!iY~NQ9J0 z{(h>dC!9)LmQI0u>ZZ7L-lA*%pcjLk{&y?zt=Pis_XM|a*8P3}i&-GkxF$E%QQ^4W zAK?n`4Yi3VJHV|Yc++L4fBb$l%SmTtu8a8|YI~j@qM$kmZRg_udkikj_WX5NkR|)- z%Zoc+s^TlY8p{9>#YCsZHe6Po=!t)KkwP=l-Rabb{5v0;pY95NL+uA%havl!dJt8! z6+0*&R!eabgiLfN1)~fyt3klNL9{SJIJx7dBK7C=ymUXL+mVVpGg@l9qXhcX_Tb!&6 z^`&E+C6f4mk?&sZQ(sA>e4Cem`K6h9(9e3wJ^A@l$ph#|UGM8?Hi|JVA;(TnfXuW~ zOPPTa3$Sl|F(CmiG;{plt?;)ktS|7NHsaUnE}5w9`vVrTi35(81@_S|A=2vk3*TgQ zP@DR@C+li$_YYjkC4eezQQ8ikwkDEk#ijgL2RS6Tx3{FwjFe}Hso>;tx^Wf|?X$Xd zH<+oxGen06X3s_Mpa6tx%#_6WCa44GeTm7HjyHhJqm-Cje=a`31d{6mP)S}=6aIc0 zP^Q3hIZDhoJOO2Tc@$74;)|6QN>Sf4Ah(hh0J(L20oduY)j(1>d_ai_6kk8Mh>}8s zuCPf)5SSQM3};D*b7#huzAp0H!ew~}5XcZR7VLvYD!>LP0dG&;8=iTdRN0^V{u@qB zEaR9{5-O>lfO;zIp%FD=uZSEFKV^xW`piFb>IhJuv=j; z>8q&t;GZ#u2TVl^lROFlnWG4axX%Ki=;cmu2P6&+?qJ`S)vAIQKqTNX)QZ}0R6f7Z zOg%D?R2}8HTkSpos)7)bK|ob-X0@syV!uvjy6?3HBZ_jSLsk)?MqNv!TSxPB>3!d3 zl0otTNu-_y4uPM)*>Rc3b=JJNOsw z6%EMh(k;lT{e6Lzx3H>zu3SL#Mx1#slzVkRLLqUC z?2RT`JhIUnC^%bZc^8Gc4YNx^9Z~Z0BqgLOyxpJxN2=uGN0dAPf1iUa<*s8y~( z$O<1+BK3|}h|$X_r#hgVOZ?yf!PwFM%S1G8mC_Foi{SRkeD{8u*kQ;rI0UCbIj#8ddG82{}QR!v4f zhz)$}>mMXYeT}5x-_Z7(zRQcczo({ic8lsS2gRh-Z{ZY^f#DDI!q4_U|jbCmmsu+b{ZX*Ucr#9JD*Q%~vyEQiw50awiJpfAb-SC!|CR z+8sT2HCFS%!Ix~LvIq1qKx1h|4rYTH1Vi0}JhvCDTujEv3<94cD>8KabMkg?_J?bXr{LsR~~AMW!?L9=o;%S z)gz+)=TF|HgJ#Yh*L6EzgS%OKZv1@3>{Cfj-N#S5#pj<@sRFqs%JX%Kk%k) z%37`fDH4|7kipMwzBYsXZ~1OA>5w<;UaR5|IU;%$NT-mI34yY^8q3_vQK6J*iX?CM zjF-zi|IAcRd+vTmt)R**T$Y*KCyDxWPldP zhk!imN@Ur_tDuRlL+*ie7)C-z4m8Z&rGXC^^fE(OEajkV0l_ET^KI!fqm4W{a)thK zww0$wiC9?Ggl;>!{O2uXMvIbeL9X&ox3D@AQX@#mMi2kfv6aX|iFO4J10dA;NL56a zah*4XAeuow!+_#Em1b2+w3LIoCWFJZb$y<+>TT&pbhXCkG8*j zl^#y=RS5QvzPc(1YgUm!7})zy2e%2k;6HJ@b)rT8a@N~zBxj|T`jfM+o;)B}60QiM z0j{hc^@_2*rI1Dgr<`5#&{+U!|Li8~-zD;^-`Z;D3M|YlCt+cM*;2Xyyaph6 z_pSpZ9BF&-J0SfZ^5qo>MsgNmDy;W!()^L%YFf|w95C*8eLeK zr)-IML#KeDa>9Jdv#wB?Mj<=Q_nDwg=@m~o-Y7@yXihZ4Ps_A^!{djo%AD+SW4;@^ zl~5zp_ee8>^6+dvwN%K_#Viaszbv%uA6SXWovRr|z7{S9JK>XsEK}KCl=cC|gfW>w z1k%2zqh*p08Z1wkxj#CV*ruLmg29h=cTEMgstUT8$lZro$w9Yz2FtnUGe9imDo-;k zrr>XoLsfrclD|?Ccu3;x4+mqynlfmykFB zKK#|!s#40QD4gDHcq3tCSfZ$-i!rbjll=+9GQSUkeerQxjfze)!<`;}>c)y1ZAEPU zQlm9Q!0S}qoNqY)Q0zkrVOlc+6_EIm%=!5~*TUXO3#C8|E{wJ~Ii!!)DPx$kIJiYZ z5KmSSZ#9_b(uL;h^EF49NX~>2TnA_RB#Of?yGcYIo367O!&wZ?7KU_X(M}5L_utMt zcSU+X@P_^Ew_O8u`Ush%V_z(OSFqM!DW65>RZ+^UN>dtZq=SpUL{ULyo|yEklSSKb zzZE)xva8SnMwn>r`qJf7+$PEcM>^kZnfbz7lx2k)>KX~=XvO&|;%%BRD3Q&C_ECd8 z#Y*b=2RrAvftNf2#$tW5#=T?|RhQd0?vj|>Wf!5_>JR>laDCC+h&xm+&zWQNbdDph zj28X|IaMMyG7(le+cG&*&@~zi6RD7x8{p;0G1@u%C5yAfkszwQ)84IJfN=Xko*;Uk z{^)Z$rc81`Pj|dn^M=MFFjY>ygZ5~%Ji>4=C#R2$eRIU5lc8h^A#xPggw(ef*K&|) zbcVFeAn7r$iidY9z>E8mhHE(cv-7O0iQ)drfHzMNslE5_ zbHuM?5%Eq{YP>cv$SH4np5Cct)FY=ThL%u}IW(VBf&X5a=VU4A(A|Ra%;@3{4uT*Z z=4ND^`t7HNnw;%XwW`y@d56>8TyM3^Wa%53*jeB?5C#4?DYzgSg6Hkv1m^idB<->j zOLYqNXHf_$L{O)#8eQ2^O3vdSt^J9vo#6~@M%naRXwAu5RPu_-SdS}1@g?Oj!fZpBpxTe9 zV9Akpm!gV&z;mGafm<^%5vaV2ifQT!up2BHz#@Vm5eXOe2mk zl&s%EnCL5N}>=6E2VPQPH*Rq%<6i3v22|L({(^Gs7 zX8>>B$hXYt0x|nwUMTKHxlVLO73z7P!oHS!1dnT;WFEIET+bb6_2Y~WC6&40r=^N^k~5vP`j`P!>C|h2DFN4*Ic}p+iT`0vi4g6d zP6Ur6O%tH)OrhaFy&?bar17udusE|=e8OuJvTeuEjrJprP4h$e?vMyhpR6fACzpxh z-~eTp{+<+MhP_ag)7YS_ML-xwj*aAKNJ>}!XcN-as$~M7p@dZ;j8ut@^e`KlOtoap zNMP~Zov7#bpWUwAhuvc0`_{Y&(F7WSh$y`P78Uxiw-x>l1A1ZQDoVlHr0Malm!upf0)T31KB}xuWe! zAQmr=%-F^}8HrJZ^l zkaDt@oNRGG7vxmTKZoTV9maJt_qks0%XHa^ua4>ZaKFs}>DDZUyHi{|Y>#l9e?n-L zi!&6I2IQoHcuG6qOELS)Dg8?ACwR0c#&la71GU5ESE>a0f=p(*sL4=!l#)ewtyg7QfhwC6KlM-`=kQCUEt=TRAn)IHDfV?L&Aov ziyJ3~hpc)t!tk9z<){#QT)dldTR3x9q|@eS1VN-C0k@BU%gZUw2yT@z&*~0)Pl&mr zHsR?kO+j@DsAT6V3d~3{2Zwn|0CqW;Vooo}NA*l2p+^_B10sYWj%iO9sTN&Eq{j{xPox6A_M1I z2eV{~eG*Vf%qbgz?sS{Od`T{{jQCS96V>aXlpmAzV)Kk|io#K*={RK(!c+p_gHldK z0urblAM3+ai(`?JLg@s|WTUHDfR@|H^JJ%nAbSol>;HN3 zlQd;GLA?pP<`K&Odl#->nlU8;{E801KU@0eNbX;Qv5TFhe?H;WFI(^7Vnjx^q4mrO zxhsElbpJHw`(M6=^~?S`OTBL7g?{OO)T{r`yA)5RxrJHaP=g3P(q!CC!Y=5U1P@M; z|C$m|NHzCLgO{?1o(7}ycfS2wEHZyQFex_Eg$XbUl9W-JH=gT!kI8Y`DPu=yoS99` zwS!Ae7||AgX&^Kcn%JB;r@v1RDwtmMzgxf5;W zm?7kdlj_?^Mfwe5cLlbE2A_4$7Y3b2E#?Lc$1sGPC zXxRSTc}zdOg+-S=XwPX7uUxyz>HfU3U;`K<6PhckhCS8j9!4IM9wro|xM{R~e%{JL z1J{s|IX3As+}QL&E6TxIaw@-VV0N3I37y#8x{{A?z(7tBJ!tB_UNM03N2_L;2gXbd zu@`GM@sH)@h{~vsFuRKE|q;7 zqVAA+unT}m0^c7?9kE}Au@|rW^ZAm7o@_9QQZ9=@4^SdBFuRI_2i=S)5v1t_8hC>N zEU{58PMb%13kZZ$AP{U;JERHfRd6JsOqd;Q_RQIEP=ffr#uQ9dP6F9k7Kyu${0hM2 zP&;@}ny10zHP}Uaj9augavuzn^)Ua!e#_yv#Y73?N|$PI-wkuGu1TihH0~P z+4dP}1H298NF@#4@D)O}^V1Qvf14;U$F$rg<0-p78YxF<85ApUuoWX6iW`$>EG(w% z(a-Q5s>L2qHv$f6TkL=?8MP{oPgI?*`~hM&mKQzF%r#;M1}7|dZ6;t1kc8nb`wdKL zs=&oQ{L#g<8{$K{^7HO=wVbv{X`~%ygUuyQ1r1@O#Wv&1dsR^xZU8_q+l`ch!y;Yu zBqtD;A%s9qR|gzAIanKq!QZ?IZueE!cn1hBKX>`YtCk648nd6kJHx?nt0Hk;!+8}$ z|8xV<{0VF@V<08$m{lO(5L>X!R7<8=gK+3fmjU(8!qQV+cR;K98Mv<<(W|)bVt?yz zeR}&ln#zRk@X`L_NX}-=4FsaAnmahSdH!v={mZmcPHQHOeFvgK$UIC~Ea`Gol5O0y ze=7-+Q153v-cQhYQ%tWAxuen<)044daEQ%bas<*sj5kcBSMXt?|39^9bU89OuauFde-{tyB|~a%re1k7SR%y z>gL=g>iZzmGL>_0-s7tYka>Mvt-8nD$udG`dXEfL{otbyod`6lKh+@ebjBpcQY4WI z|2fNTxNgGoFddh>Y%CT2hm%|D`^)=&NMgNCd@lDt$#szeOD$kNd%O1(3kBUYR2Eis zG^goYrllSF3JXuW);0(m%otZVCUA8q zcdBp5vNF0n^(5w7PDDnKYVlx|P`I(en3_8Ue<8)DK*dvJ9^O=Hp2CILDmko|&uIrT za;kb?G8Z}e2YJz17rn?R@bp!X)BrU76ZWfgTuk0%h>z!$Heoxn+rrZ^xwoAA`6+pM z;tB84U!hb9hvx7}LlP3It`7Qdo<)7Ph*04y#K>(-Vxm7HBFIKg#m1zwrJn54BY8Ca z)e8=E;8I@TQvUbCkOi>N4W`IF`4Es_Q{EyRj*B+tF7usqozN$@!GsV_RgSUz7PKJvnL{ z6%GB?({YB1iB1i8mY2e6PDdy2-qy~;O9M~VjIl>gD1hveWBI_29bsMiAy*z6dZXks zf8lYZU=s!KR(=ZpPe1yN*=^|$nvyq$%2Z@H>*ij8RD*7J$ z)h2TIortH~(VuTUbBwLr?3_8GEs;WWQnXOGaHW__Qdy9jI{&T)m+lusO`+N;-jq0q z&hB2fQ<}Re=x%@u9Ti>8}rmQijJh`u^Dyix`A+<387ZKO-2#V0^-rJW^vc~Zp0hf^5+|} zD{uZXEFF=Z;r!xTsL~ultMYq;8=t;ebzH(Uq1Q~>zO~KCsKuJ4xG7z9FoqkYF4+Ah znp*8H^)60GFd2m{2+6vS@5Z;eJm0)o86ZU!(Z8fuyIB&59Ii6)Fd6N;Tt9v%L!6r(n$*B*OG9Wt6SDAa*tcl=~<1zqqZ8#QH5$7C)0{B3mY`cXUNjQPtNHDM?H+HTl-d$>1OUNtcaO-B$J^0q?zWS63equ!w*BW2F(D!k z%|eV1j48S^WWyXSh3UAej)4`Q>|4W%pRWtFY|n^9Fppi^j{b71jpc*fl;BoDkOYt|5l>;~JRGHbk z%L%}fO}LuTOEFDw`yGbGkGP3Xql=&?T#Tg@VQ=>pbb&mXP39t}cyC$0DGb<-_O%3F zB+Epx3H!9LP!`H+@{tEjDLUMY4oj})(+>@7dsr;fTcr^ti`-~ z@y-UVf!K5%Q-i6F+YZ0)-{4p%XE z?3X9=;G)`&7Weh_(B`jygnBMIQo%BS`lNx?yHBI}l}4(4B=Z&((_6lL8ib&7Id4C` z@J$C0oD@W0Ctn^!zxoq6eP_EGxOUXRXZzC3kXqt3JH`VZ`hXCU`qrIkPQ|1Kd}~(y zcwN*R=oR~pi@+5Z*v{!?IqBEKX`rZocVAEg!CIBi-I?;W5d1&B=uZ?Hj zln}9Qv95MxEpj+n);QVsVe(ODV!h-zs&(#x%ar|;+N7^AV~;x-Rbwe?NKr#g@~aWd4T^7@D`7HQfe6gN&jjv+g*F9+MUr=3WY$7DekN*t`!o($*ak zP&SVfAS;CE^%lh!p4vh|N5z#Ns3EX-*?yRWI;9`bDeM4$w>uxP_kYM1OtzTdi)@`N zI;C=ERc%yq8>Y|rw1ua(377>!EMFpt46xjr4+NtFU^#nb)?yz7Yf^=qLn93;TkzRC z`&%{MA2wn4N}~Kgz6+&mxC8RtR-G+8XRNza^kM+;QZTg_#j|c*fdp2ZXGpQouKj?R z2|gQ?!!i=`3RJdL7JxVzPY&>U9Q@AmJczB0i!a%4)0sQm2>r3W!xgp$1)s30~ipFCC6Na&F;`bA8|C}zduGKb8F$ZS1?fLz#Xb8 zx=Xu|6?gi~2tnr$C%Ri(fUNDvObr2?OaNqU9*?!%g`Pm;bOJ|2=2hu4n273PBk5K{ zua?Y-fO8Ky24xQ4q*T7@{Ia)CsJ_7|e~i9Ty3GW_>&>qv*hi2Dw38KnTT_OD?i;Y4 zisI|xu9nRBvVsuc*-2!g=4m6#L;maCxzkHtKlR{Otp9SD&t;c3_V81e>S9a5O+&{f zgPN-Qj_~2nEyKY?j))^MeT^}a&SVB(!! zKYt{jzf^)sZ?+%vNAW)XkdEakle{=OTzD|?)xD^UnVGk}uGsFdX4Be+BkBFgR~~Uw zI^6YABin7|OUK0pYOavROe?Rnl zfygwtLE&cIy%xam|ExZ<3(mrsb(7_ebgXkOu6SeAv*gGI=p)yDXS1)9ZcaT4)19w45ZPt#5-D>!v&cn+*;)`=U3}Wg$Icu?GA52Wjnzm@ zHqYF7)??q_iZnBF9r>Vj&;_H7HBaq(VUHeS7~vL`36@q#&A=tU=uwUOP@#piXl>3= z*Em|0J1?4IHxzSw0zZJiDxX!VYjhc$MqQ|Qc6ozWrF2&N41G#qh z5#e$>VT-KJJn^89^sLE{%OtnZ z)`}o;Z*4gwE#~YWO219%yohq+|NiZC*fV~Y*Eep(S6?t6EaWKrM##<`^Ut;^&(=Pc zJ}u?cY&IApU+uJ=4}Wdc*(Xp-D%+S#%_`19<^$8Xz?KABaOnHMp+8vLp?^`I9=whn z4ZjR@hrzTj@1CP~8TYuoW^^qERcRli>2SuE6iUV72JxE2H|FP??d^8Ka$om)n~!tu zO!~+y^y>R!CCgXj_^LROvp=PPvrkcm5n=Ngo(wwbPmVYlAWa z1gA@GH+18xl$WlE@|s|&?R_U1Tcd)dwQVf>yM*}&SBw>r&yF2ts>rE4DCpXIB5K!k zw4~*Lq{Csjk8XBn)2xiPM2$hQv|#Aw_rh^G^C1P3V~mMmK{rto>CfQ0Ci5Y)WBl}o zVGr7mfiz!7OhXsfl7>Ka!>0_NGpsPg!|OM`5?3kxp3)rO^{z_VaQvgm!37}R??S6n ze+r7ryEdHdGS(oIhU=@QKR2&mmTEK@b=4*CQQD9Qyyu}oZ0<~ggMLf)q|!sYj$z;1 zz@g3E5;WKDN=*lQx^cVb!TOvXKJpGWy93DJ$omBu=^40 z!=G|Am9O!{(M>y{43t75$HWbr{6vpRi)rj;Lr)y4a?1aR+yb;21t@T-QV_9Q*-wHj z;7-f}_f}>BkI26hkL)02^{-7j4R^~E9efXznSN0#^$SIcTl6q?X-evh%VMQG=KWF3 zjX2rF`B!LeQDm`#c|vS$|Buob|aAc)oW&7@~XwrZNrxpLbG0@wIFpprR{slTS{to@_}P%DLbQQ;%bgKRCSWS?Y6R*xrmEViv9f zCpfd3Ql{@mM9jqm*X~rqiIqQ6Rm&CE)k*{p;(pCN%7!QtWS`ee8bwQBdCsDqH<-t$ zDqTx2J(}de{k}CvEyp-IV=U2OlAZHW`!z1j%>eArxd)%Qw}0k_@DkbwtJMCP>|&}+ z?%7VZ=p3!mm?^hn2(6cjlVL+Mcpk0Fkujo;+?5{gr8?mN4)?8eRZ0}>0|wWAu0IXR zi2a(dtN(*OCqywAGgHkn;5ydf+lKS;F&l{=c%}c{{v_)86b0(J>Zf)B@mLiW(6R3i zX#SUWK}y?f1_)T{@#m6v)ekm3{(vj49_jaaH5zJQ$B~v{f3o0>lcGW#PFMb80tZK` zP}Z2^_o<+!cYxvqkK!}XT6Xi*IfKKY&|8(k(th67jIdiBwITI3mhZ8JV+!U^%H15e z*ym+n*v{UjBJ&)vv|`p`$BQR{zJRG_hq?r7V@*z);f)#w8wYrY zK8muavPP0!ET-x4TtiIqRca5AWGMYnPWGX!7}pl3j8sbG$&f_z&J5!g?%HK^`_8zV4$vkamtCxbxZD$w0QW%E9Dn)f~RIx~aF? zx*=|1UTPsaJA=q5J`&5!7oC3ykzdM8B5S-KVYnz5@#Sqv_|as9;!JljD&ypD${R3~ znD|uxzSwI_r(?X?Zq8y{1?TgE#Vx*E#LPV7yjh@@%WlrPwrg<+i%@)geCU~m#}p!V zr3&`j=#v$UDq*L{$TNsX23ymSJ&t=+AfEDYf>Ydpve}q%Vxy?wHB_6>WV@8vZlpYv zr*)RkXm>jPNDm9B#;*Z#iiJ_EskYOsUu5tJos#d$o6XR3sI)=ClVogS1PdWgXIy6P zoz`5tRzyV)Ur>PbYnvmpk1J?U3)O!X73|`=-{CN+ z>++SJ^R147xiu$t6&&ZkXf>|4<@7_MjA6c}qhL*`=u2qAD&xNy;%zE=G1AkobG>99 zd^ne0a4c#jL29l%F3s%5C};1jU~PA=#+XWXK3OtyQR11auH`}tGV}j>y@X|;Z(L*^ z18w>iHSg6!$V(1k9Zqkm3Rb!{74oiVqgbg0=*+qH71ROdAqc$ZL)ThD)r5Rtkk-cx zz7S%U56CYk0K0^OcVUUZ4ZeP;ju@NfeNI&J*d(Fs9#q8eJZ>1x zOA-$bRWZx!A-NXhf;RdjSk<28eRE!M&{72myBRTgBibJ58~l~|{@3nOb8v-$2AVK6 zXrR4(H$_E>fFG0eA*0w$50cZCQHr8V>&2{5AK$f?iKK8UX%J5Ib_U z?`C#VBAy(T1YIK!;)0ad|GXfvgnT)XD}D8tqH(ipj`d5S-W>-RRouPQlB%sbKsL_*@fC zqjUlcfBD(>r@0H~UIu-3s8GUo&}Rn)QT^lE_c7bi@f01ZKv@?huDk!w>*{^zwW+l; z?au6ZG0q<_>KB?kRB158_Zb%N*o(}W+BY|h8BQK#HsL5G-%SUuwR>N}7ILa>Kmhc6 za=0plE zJR+AQU0LN#zVo*iYAFY3zN?)7QX`+(Nqh=AiBKS---3a6yOkN~M)TIrsFoc6iaeJI zG?g2HV689r*S1!NN`;~8>&@6p^?7DF1`c<$ziyK}V6?mU43j1e;PILuFP}GwKg+doG$UfxRx1xbfOuM;2NL(9H$50ki8KS%agexu;#&f7CMc;j2p- zLx|QpB37}^4pR{jv&!0j8e{Rjz!CK13JXtyX%a55TUjCfHEh@BlX~CFjMqaFIYD8J z4!I42N}G0YgOX{t)aT>;FHqR>)fB_>S49NZ&2A(F>%k-yl zYuOEU>Geksi}J?U_mA#^Pkg3u4E0julCug2vVST7uGe2!H*QCtA$4xR!uJ~gh+D*k zZ{k6rXK(rb)`bNfr=lL(-gF2E++O#YRei}Q%0ad=Y2$wnV(MRK0bmHi%g+(a^%JEI z{n3+J7R~P<>Hk&hX1G~5YU4X5YUFk~DFc!I`v7Fb6x2$EpGtgVPmp=^f0HkAw*@gp5hADb;H_jm3#G)uY{sk@u?lDZ}z1>I2~Q^)Oyf2F?z zEpTy!5=i|*pc}0h{b!&!e67#Ty5>|xFaLbql~y4ZOwZ6{d@hUXE@3QaLi7eVq!%cUQR3GjuvS4pm7W8t#3NA$8{#26G+|2Xo@GYF$LEXFk&25P^RPm_SZ?GdM?J zDon2M-|Yguk1fm);2O69kdp^uszR!Wtclp9_C5R$dB$KKmtH<^_R+N9JMY0ZsJcco zPnoGwqRSx#PhLP~a=&Kkfgm{tf<#{_HuwcJjipe9lh830{@48T5r$p_-TKLh2>#Yk>yZYrSD;8J z%=NuZ52oN)i4$b9tB&FPI@q^BE{fEXT9jW8B7CR#?PJyEP$-2xFTQ-7M)k>Dbt+9UZc@Bm+% zkfIrXC>}9;&x1Lno^Yl4htG`E6@a$Sd5Ud;V5|-&$I{ZLLN%F6?cu;fG`ecU|}59 z&m;mxc@Q6%z?cP>{4w_p9-4Pyi86x;j8(^R7UtrX81quY67a_e$(oxJc^ruj15XgS z1CM(kgyG4Cist7Q7JjxY+nn}*s1D)E+yq=Y3&cv`!`04V<-pfZ{7h1x^Wpt+<$zDUoBhMPV8WEV ze>XEqJbKXT+l>8ghAll%R`2B0)`>dUmU~?*@#%s2P+uCjKKKW(+Rq=RKWy=${Wt)U z&%k0wFRXSZs|OX(qaJZ)g{R9ypx-BNQS$P4n@5J(LjtiLIXImx>6_X`VBf0$QcjIEeVus1RGzX)4L)XxZE5>!H!-@yy z`Z)s|3tPv0FE!5&RS_mCzq($XFFcTAhS?=~GpnX{2m7;~Dg5KPKh&N}l^*9$EzHyg zw{`{GTFfQB;23Bewp|pU<$}(yxY{xO3>}kuU?QdRlwcpbWcFymBIg&XHqrdr#SPfi z&dp(9DlQqg(@p2qEVOa}`X?u5_|U7wc#0A+LlbO{J46Ey)Npj$OMe){-AS=URu*uz z*B_V9A^c%tlNf5kCGff04HAw$$WuW0*O8<2VeyA0WAJUR0}d}d?uZw<0rbEd6|w-X z#se&WYmOm42+U*4=Gzk|shH+|H=g|){;&RZ4Y&F${eS)W-0!A%e)TNS>k15MgEkJr zv{N{v2!(m0vlr*;ds$tB`q#F=*Y)lBd+ z9>A_=UV2HSOn#}0ogDVMSq7EK#R9gl&u_#HWC~aBTnaFU2DF~I>@xM>8c6-tPDju~ zzY3<9_x*l~nOIE;s>vYDggBL(gHcgQEv?7gboA@n9DIUX;<&ffUj~R>>K_Y6T8oG< zVSd$dugmjGccMVkTZ%Z+dURFmECFfa)wt@Z&hq&lUJ=_FAah=Ig0^*Xet(=i41vdw zYoL-Qd8gl&tBg8Xaj@!X7v`Vja(AZ$S(NSIvH_f*1JVm~nLizuIMXTyW?Hq+)i;aA zU_M8v&mbJ?l)}H)m?*&9+CD_o)XTHVR)K_=5qaVfBPY_b%U=5>VolK`w!BC%o>uM0Ukckd}A-6@gdlwA3iOPXl z>`$O;2U?4VGBlI*ONu5Z)q9hBd=9$lMXSEM?;h0@&C7LNdk@717M(i@)XKk$WG(|R zl(;A|Yym@wJo|yoGAkn418Cs>m@2-ySNtJENf_xV=NWF1%Y4d3vKFt3vk8F=v)RFq zA$MiZWt(IfF=I%jlV#d)vW*r=_GBG1LqZXQ%Ff8d*ax%k_ce7+ zU*|r~`J8^=@9(}J_v7Iok9lCO_xrl8*Y#ST&)4-JZrLa_V6>8El&KM)d%ewZqW_vN zVY{PI5;!Ao3xblILWw~yJ_B@O*#Q7l)G}EmiX=8XTUrg0n-`?c^R_8#b$dG~9)1bt zLZrawB}-)q=N%LaJ^IP1qt&zxn~{aby=n^RLK8uiGpJ9s*$=Ln6OfnAXgT~_ zDM$#NSX(v+J=>y!)S$BJX|EYLWwtDdN>hA@4 ze%LZrm*ut8Mjl|bO$N9{{y>9h03_=I>%`OnMc+&QfTD19IY6>bOf?<%0W$h)$#yqD zM#m=uWb_*rJ91?_and=SnE^4O~ zwtNMl*7Y5`G^PV4z*kvcM*)F^&PjkB-C#Xs$^VQU{j02c+Cz+nUvWkq!okplV_;~g z(ZyYMa{`n@u5-b1EIdMu13Z*P;GH9XGC|Epe>%NH9XyG(7Pyj^r$WL1dceG?Cpj6> zU`WiFra4LASgCBjui2Iyc6VuuG>afr563f5##5H}&q{T=mFUaZFU4NJ{&1yE;m2K4 z?6vO9_y5Y;`C^o2*6)8;3B_LjcjYI)L8|Vuti`QjpYzTAnA6S8$F~Y_^6n%1vh$yG7ge12WlYnJVFM8m{yd!c`8fr#CBr#{Th|3@kR_hgK-}Yqj0BZD+CJdKL?3Rtu zQ3L3kd#RgiJY;pf8nBW~6o3o2bgHvbbMued zz`8Osveh9Fg_bNgg*uyL!%rGnZtC!`fb+8Y$jTkL*zoh|@&S!^S|~#R%NJu2KtNcx zH@rW{jQL@gI7BJn&7jw)!kR-iKI`rLUk(Bi z1CcvcI+9iB!MvWCq6;j20b1n|wkKnIgVyIqYkT%xQTVNGhpRI_FE{Jz85`gZ1umA0 z1+^$`72rqQnYw!4oJJ|(ZW_z7x#emkeJJv`LrToAn2Cv|JM)># z%bP1mt;yM8ORp$_Sy_Qu=|$&5K-lN;dJ%Bto=Q_aky9e*CjevhH5a@FB$+$qq!g5| z1Q#x#(ldgsl12;VAxU8m0LIhq^6P*)5ia$BlBaWbzr>W&_zbmrAQvkJz&rYu zgeMc&&Uc9`Ufxmex5N}PdaiVkoR4IrC$}yEQk5iEehxgLR{De|-}8j`zWte|(DBp6 zKN1N9rgtW`bF&y#6A*N%=~g%f+4K4d3&!dRHF9>G--kU8Z17_iEn6cv7z!R7r~Ms9 zsnW+`MT74i*%En)&xnz0nBzcB2VJ?Nr>(dNIgDP4F6@2e*NsT^O4W4l_nErkv;AP#P(;}r=0`r@7@q5JB(q2(t z)NBeBpXLQltlDvo=H^@=>3FbrLEmqO!14HRxC8kOEI-d0@c^h#c6POET6qk421>$w7%$>jmQQ3A09JU@a@bSih@AAENxGe^< zskzP9QCH^eLa?xXf15Fw=KZ!gATY+Bn%?l-5TeT!j>Ey)p4zr#dB|EF0J(GpOvUV3 zc~uq6>w3ZdfYyC=8PML1|LihX`utw>1$Bc0_riy<@RtY=Hv`iXx*ObY_PICgI=HiR zY11FQ03zK0c5W}&LW4)l@oj*ZZsiXMpUq)Xr8AW+K8@0O>egq5;2pi#A#UP$^b}Ka z4;tkQx56?J;P4DX;f`uD`}i*&j09-8@Wv|uHeP@V7Z)nt2QCQ74ws`0OM0*g!`-(_|fNTV8r+E z@um+a+(2bM2zBQ5hRa&GAt_wfy`x5+r~TjcEQ-AxyqaGn?ht%#e`!U4o%2rbPWu`M z#f5aw%Q=KO9jfkn+1>zzZPM-4emF#auksu}4iX^OzBF|BPmANa939&|f`jLCy44CF zoT?nc^i3>)@~gu#sB=v(=NTPx!oDz9-n?}S08_65(%HTB<1N`iMJ+=vsAMO>=6Vazd-3D z_ETdS5FYtIAULhbEl<(}z{lI7Yy+SzWm21A{LeN6aP%Ro3(A+YxFw_rJxghik<@cn z3>=jn`!ctxGJThB&;bi_9Oxf-dE>Ya^ZJc6!-asuwgl*(kpHBA5={&)2)4Y-Hm;@G zskX8n`C@cy@e{{uGUyZ_@pRM`Uxgp-q+y@wcUjoF#Id|PwY(;~7v$ZP$d;Bm{KT2K zIj8F9n6wTQT>=^bgp&MKW*>3qLmj)WTL7>WYL-6j%#Epq++TK&sQi(vV$YW*t5n|S zU!ulY)uq;>JR*pvT*X=QdK<#gR*81K&1SU zIwJQ-Q%9cm|GP=p()VtT!yh0P?=61K-#nD0s`5%r9pmk@3^ zkMqp*2TW5d@$vbQPR7&%=Jj%B=8%p@)qwS{z zBkwR#rieTzw(u0<6g@`27UTEUS{!yoP*Zio=A}>16c%zy7<3bUrw za|j!hY=EEIBjaA5|HIU{=UX!rY3f?qje#7gp{im$1;$Jbq?L~J0>M(N6Vjh8{ay=OzAa} zN4w!cxn4Z5IZ_#fRU0zg=>CH`E`Cw%tz+)*(vv$C!ESvk0D%1Qrtc8FN}uRC0S18A zqXojKCV_3e8TlL9P1fY?9i@^#kaPX^f8t;Mxg0O;!Z_AcgF~b))s@fW$B3wG3>;{aZ7c{#djC z44e-J-hcl)2lmGRoUF(5XI15+1rm$L&AcD!_35*gc2~@2zN(GT0{&DL$gb=4za08W ze<0nAyA0U#$RB`|9++YX|0<A2isj59lBfU2*}r;PM%JjI@z_@9WDJ%Zv2oR<9kPVr3ThKb*k%D8QDU5* zbT-uS4 z)xdG^z2pk3oI@y3A_I-pD%DuRseHQsagFoe)p*%^vUsX3qW~#0G6b))n{cFRss*?- z1r)y2b1b_fp0~AuVW64?dP?-p1@JIo>%Z5f*|UKkq+U>7m}Tkm#n0U=YciKyxNc4W zas4Y6SegQakGCoo6Tj>-wOM!j;eZ^;>nBRa$0qK?;m9Z8^jWn!#sdFr zhlCX`e2Nn!$_~LHjstTqi$EgF5`5HtP=d`f&;EnH4^HD$xAd>4QQEreS76~CLF+E5 z%{TxLQ$f#nfddA=;x2p?!P$>l{O%U%?pMQNiB;MyOA^T*!@z?L(BL7`8zaq<>ky310Ev= z%t-&r9jb$?3YrXt&v9C#8$B(L2@`8V9F10S9qjeS(+%%Kb}a^`_#0x;EL)0LY)jVp z1F;C?a@zdce|4^_%?FtKO{SOMZ<>QX&hzJCmwipXZW1-|+J76BuxqfNBYgKSg&Bc` z#MUQ~K>62mHV_@+cZtrwB+Vz;@rwu40s?t&>P~Fq{_^hsyKw-9^-KPCIZ<1OPb|Gf zuh9C6cCs@SQ0<1h**2RwY+X4$iz zgejj673a*wf?_Lwp;TV}*>~LLpomM1Fg5jlj*5vS=k&>%Fy*R2#TOG{ImMI> zZ-K2@c3e#yHrE_}@1`v1NOA}S zTPH95qj92DMdxie3>IVY5t^RH?fF2^eyRTs>H5F@{g&k6&OTXvRKN!QoYMQz#Ch4} zC2?UM5%rgK&h4VxOS{VGDN}z92I^q;(&e!LE@1@>lH0A}@^Vl*-Zzc_K`KIOZg>A< zfRJt8(&imnK!1e_wJ-=e@jK{VZ%h9KC>Izn2(tt%(i1@Y{Al_e?zme+bckcEnAj5CEIp9t=DyL815Ng3OWI4m-X9+|2KJzxU2gsnm~hK8L#5~C?ydz9 zK+S{iI3WMs@1Gn!`KF_@v$Rjry_uCV@EP8AwoN-eMsgtcg0g9mZu9|dSiQ|BKtfW4 z?Q)zYqi|FOOtR}-q(xhD_N>?ML0&LJ>Sh}Kvzr<17SvoN;bPr;-}9nfI$PcD9oco9 z|Fl%V@at(akGC^^gl^dgW$hHyPgW*GyZPz5@UDBq)RmYUVn79NAKBWE z)AoTd3F-D`YYca<=B#_hF$WD2l{a1jwXU9>fZy}_r*_){#9d$yAL{XbA=k+buQ3*mQDRmDH_+EK*w5gUY5kCW>rX71r>Cb4G5)6c=NFGdJ?CwnsJXzO7$8gNCF|I=DA(VQ`kxq^ z`=)L~_rq8Tw}_?oV2h~lcYa7!$*tSrio7fFIP$59Am%1w=lOVIOs*9+LXH|n<0(-vo60n?_2>uq&{}t9PP3cHeDpJvVeUP^qi)>HB;3@5oS2j0UczTY3 z#tYs~6ORq01+-)}$yO5AR#!jZ;=32v%2EZJn(VLrBVx0j_UF9lh04V)a1>QkS*yl( zA|5EE8ta@@p*l487^k|nQzIPbqCMrPNy%vl$QUxfy;}QV@%JP zzzi?e(yiQjp3EZ3W;UmnsG&7`Y85GSi?$i{c26EYCLi#%|HJakf{s=T&^E^YOhGSi zfhs=W=iiWnxeL?h-~Eaj1(@2VX+>tbZqNWc7(JYrpeDA}@FVo9`R7|Fc5ge2kPJI^ zEN!UX-yEQQJw7&r7OmTt3ZdtSCEAE3kQhputp_NpFG^9%j%sUkIUd0{Kr0S3X-?NaQ!}PSCcrVomK8^aKu+ysc!ht$hSwaoHE&W@! zp<2k9_TT#;STJSc1$moa$1!>@fNF#V(7-Xvrc+7Ni&TVnZ+>UMm5#+NXQI!!ppSeCzW1y_Yl_Z1?N}XpyAUj%MTT zY}v_1r!0imR+j=%{x&Fcbkf2lORpjR=9~a(N{D0CUd`&wr}|P<9)&o9Se>+v1^^Ok z8UdE~CATfvP1;W9&w@L>7=3}rc|+6-KNUW;tUf9@QBzWh6~29B1sTkxLUd3O7nr8_ z*uA44I4>-1KMsXB3M?BfJcF>Sp*2#?;F1Fk&F!8)UeUAzDbK;wya*- zZl=Q#=R|G}vT)=-Fc|4gr<|NPNqa;KQ^C<;UX^o_o(m7wUDXpUAb{xl__hW?pAM$D zm(F9>wqUq8RLN>7lXKyP2W6Nmqmm14#dm$y@ps;B>d#+yd$SaFZ!n#R0IP)ytgt2V zKW<%^ZogiZu<55r&QGAhI z5K)w3;BI5leoJ+GOxN8g^`&zHq?VU63H@Q^z!ermPRbsgyJ-B%qJD2V_Xf0em>Y1F z4M91~>Ti6|U@{>j#Bqg0DSu#-qP}kq**a_0yJJZx!C2vFL;Wr6ubb=JCIFCw*}EnK zMhN_L>Xn<|#L3-O4l7Vx!^mKLR~(7&cPa_(?D z)RC{9=bGH|8ZLUJ-1m4f@zQ1S8W{zYxeV&y)j9vV_k6EffK^HTUdYB`#DvEB;b^}v zz1!Tk<8_@YbkuVCl-ul|)wDM%K5m}aP0;0X6AT*yODVvKc?A3-Daq7*Lcn1Q2X6Vo zc;mYf;))7=ZZm7KnIH@FRdRf`B8va!g}>G2*Wcm`zzLeR5B8sr#J5EJdHe7@{my(u z<)tiYv7>+w6ICA<#^c%pA@*=ScYof3KwEDk6M2A?mY(`H|H&jy%9%JLw|mnvN`{uy{_a_$b}OINBAk!kK3U9gZ&Th zIbd%Dg{g!Efxs)bTl=(A?!v&I4yXg{z3)0e8=1bV{`A&6dv43lu?SX#{mG1d9Z8Tx zIB!8-Z)swi$%WVhkd3_YU*Chaf34;9P0)|(L4IiC?SWeYW^sk5p}0-Q`O_od7|xdRt)^mnz9qu` zW^Fgvd(-B4e13&Wd(@A_qrY@eI!@Hmc|Oo;;%b3BAJ26=tzOa(y7H(KejNy8Rzc>Q z7$DmlTLd1%E$y2nd2W6qtb3O9;DZ(v9MTJEcph*sgov1Q;CbZ(@b94h#y4WND?d$OFBk*Sm<<{ z*GJZ(E-?IL{r}kDevOBNn{^%8#rV?4+ zf}#ySxvCo>dBIA!Ef|Y#GiJM>Faw~?XQXQD~MZfO|1+0p;C=b1JB?>khQ6{~j5t zCG}6mY<$ZePw&Hh$x|Hyk)X^j+Io%K3&A^`Z1@gYlOhOYq+KYs`Z#U}1`Rkvv;VcB z09`PoX||ci|DRiYF@`+`V=4>kl?AFheJu~GSmQ5^g^=tY#BHb4d{8T@9+#DlfVH*z zzWxE+o@Vgw?c31q)wZenOLK1O&F_ky`}3llYv;^|ufMBXI!gvzrnNKXj^mrogNxRH zD=Vd!w152rxB%(KjvZGT;;BO)ZpbVL_rc@0his6E$=Q5?aJ%@yI`ZJ*eFsBB&HRv+694ZF)0$IQ+JqC?Tod_s{Nlo znUYMbesd*eZ0d}oG}S+xag=5pr5Q(QCZw5(Q)lATndHNioXd=(G~+1E zI7%~V!kOIfOzwATLf_uD^4cH00A`$~8K-H+X_|4GX3B8?Rb-qg!_CxIXA0&DGfvY~ zr)kDfnsJn79HswhM=8H9t;59{+u{h*Es)glwCDnF`Ko3TNsmpU@fGUpaHi<<38IPq zYDt@j`V`l(%7B2Nu#{8;hnMG`3E}oFTyv=c;G9;b{CgY@ee4K^Sz|a6Z-d2*3)8&% zpBr=;cuJU5DoNb>&?_^wI4_%M93^bmp!UH^CWB?e##UNDNJw`FH*U?H#gsFPv=)WJ z)rrbUt({(!qETl~R0n3T zp|#y;YrQ!AJ(Yts*

MGgUbxa4qr*oTSGJAr!3WpuSEWTU`w&j9VE{wnd5S;49@Z z=Ou=W8c2jDgg9~Z5;t$5vr||h~ zlq8ediiE)XA2TzX!Y(n6gHcZ6YdgCPCdjFKqBv_#M~?0g*ph z&*|b{ccxBYN3PU&@YwgTT_#bbKH_vnmn5H7_e;t)VSSb6DxS@6JE~;i znA4qJj6G4KUS}A|NEFQ+;kFvhZZ&)<>E$@^DWi3v-HGbVEg@V@894>vwb@_;e+UXq z`nM3k_@saU6fa6pg%pqShUtQy3Tm-V(1qB_4om~Ih^IhG?dB?wwu!k|iGRzLeDOrK zuu5`rSmm?ruHYX+RDT?|!HmL+%{5s@dv%yK9UgOi76ZUl`!w^-SbL~gHHe>z2~c{S zF5F}?;4r(=V7*LybqU$ils^`x;(}1ECJF{x1IU#a7>9(Am?P+^Bh2K&Q}1C*)|mC! zSSC*{W~ZLJEi?ubeD+|inbT~LmrI!*lNpUK5A9whLA=Sn99P!=aO`27b9Y)eth{`J zYk*r-s9waSt4Iv|8w9P5UL)_rwx}QCW6;m9HBE3U7p)mzAcu;(Hs9vo;WsS+s&UkN z2y25)l~kdr4-&J(kz?&G0q>w3bO)8&?>3Ow%FC6nZloox3S%b<*aQiZEw5SiNghi_ zQDfu@1VeG;53^)ovj86Q#+bptUoe}06Hetsy2uBD%TQn`&S(7V z!#a%Tf6z^}j<7NHK_v(b@!mEb2I%pSiD;efZEQF>6OQp(Eq=WOn&;f9A4M1+Xk|Pp zqzMpeK;XDQ;8?4L_axhv=i*Rvf@aGpypx{UtZ8KU!}LXRVz^D0x(&sf=HHLq;xG|q z1KTPVwvA3?8&H@>Vu@F1IPqr-%yw~2A_l#h-xdxzS7>7GPK@fF2#0&q`#Y+sq#$xp zAB~OGm5fwQyv~O4sw_lmtte3`B8cB`PP18L8-Ak8U09>A(BB0pvUmSdG6Ax<1v!x> z6+-i|*Ol_c!$pH?7(v@ana&uWOVHJw(m1Fn%*6iNc zUBP8aOTbFp|IU>lquBKmOyz9JEzWARUuWQjmeB6=%#mRotfso@c57n5*b?NJh?I#n z-WnD3Day-$euFdw;3vF2btDqucO{{4Jr5ZzPp>NAM$8JPZ562c5je};Q8g<0}9 zUdjxiW~$pTL#UatsWUbebe*1|zRghIX84RVe8w4)>J0OEhIu?gQk@~G&X81RNUAd= z)ftlNOgE1|dX>y%lxARrGcdv#7~xDarJ2&(OzCZ=^d>XY_H3r@*_4XoOfS2c28C1o z!x_HC4BujEv&|X4#s3R@i|iv#f_H;neC7jy-HQ)_;Q|cXT(~nRN_WTageqbQjMkkT0CS0X`aQ7B8)btCDcpFd7D@>mR*8zNhP|NeK+rmDO#L{9lTAFEH&-Mr zNvcS+Q>4yQup4^^h!1`U>61d(uYCtZleJ1l$JEc?c%q4iCF7f&yWB{~v#3b}>#>AO z<452tZP3CPw}j)v@!DtdC&$ylN>xc$%JO?w>R8CA7mC4RSdRcqZYXuY+a_|CEw2Zk z2QxGcQ)U_c@WcA>{kzSNE`a%;p`g!v z+|`*;bmIY!$j4-L)i5@kCtGNs9DodHz%Q;UTnI4nnm+=(c8_R|$-iz<%z7>ZkoEK) zO?}*DhAq0LF8wlpuar8lQMxD>Nap0f^cwy=PJ8DI%?v>Okob+D2-pOi7&=bEVs#yU11>uY9NMBXxKL9L{x z#6KFIB2P$9=03HP0YLt9@Lk!Hq1~JHXp7gF1p}22YzbIrR_(MITWKPG-o20mGq);LQ&(-%Qa=tgDT_628pdUIkrxL z39TqK0u>6kKrl=UD5mNXR$!GjtPqpHbJ2;?3=+MasJR{@3kWcrIvYqkbc{0nyGeJZ zPR@8hPqFm1FF9c~l7c>)a3v4^PC#EpG4zrY4b}xk(Et9GeqK19+_L8LEn8y&zn1!I z7&hWwc9P_CJRTEy3UbA1wdj=^wQLLlNK4(?G94XMCdtsG0D}_m6m;idMkEhpsbvB- z7Tv-aJXc7Lc%Pl5?jo)`FE$ZWg}_L91wnoi-@yb?qZ>8aRv*TZ7*w_8xm1fWoTs_I z<2{C#(9{-|H}}g{UP>ur52scS>UO9Qohhv(jKpyKy}Z685DnMlzUwCmQYC%;**iT- zoGCcy)`FlQH+$NED(N?GNf+fHcmvK6;x-yYx=KA&ily%zTTSx@ufKPxYV#(ga`Ob$ zRB{#v2fvnv1y7jhbIa_wW-V7=dxJu)y~n61`6UlbS&Mo%V-} z*5O)8**f|X2hw;th11O-!3{Ysds-M6FP(%g^=yK;-H@SENJiGw<8(d5f#N)QeUf)k zlteJmPc9OZ>u`rf!*$sxhRaETgiwdm?Lxh0)j3vA1S!mtv7P7NfNy$TDBL*D9oM$B zc{u(R|6UzpgFb2Hj&T*wm8ayh(zlD3VxogK$c)q)CcrLV*lw=VV8eYODqc1UT ziU&fG5%EF{!RHg51g`*#r`zHREGgvojZ<|U(lr+Wg0|pElHAWkZ=W5U5Kc&J{Dgz zJdj5fyDh8egVjBtW0$~Tra?5`5rps|LlyR!fQ)n@`AS%Zy5O5j@v#llf5Rs`Q zHq)QC2{L}k@jS(lSq`llC7}e|hKHG2IZcj+9EQ4tPmj0!V^N;w98O*|^dg4rB!qJuy%u3AGgm0M&?IGD`+=1SpseIYz}?uylU2i4r_E zf-LHa%?=!iB8f))dsL8;i^Fczw}GZRh`!O3BDj$c#h*J&j#TbK4W9B74{pNs`cVW1 zkYz7;`$)PHKMt1Qv05~$CHwUmbyT*jK~j$4K8t=`elHnysnUfRb2w;9uQ~n0dun}H(iH}SjiSfn3Ta_{ z6|nF=%Zp|awr0I(ft&NYJF0VCV3Orf5!;Z5gsid%;s|ZCN!{{<79tXbnhZxw#+vHG z^{H)jv30E?{BK%8Xrgq1<+doeV_nos0*%o_z15!y%ie|50e#coP5MoR^NQ`ykAha~ z28s_348bJL)lpH-I8&cWBvJSgU#&qQHaqw5AVD43YN}YViaIN+jG-jg{V-UbfK<4U z07ge_8XrPdg~3>TmawyoMjsA_Z(Eg#xyab4ppWbCe<$${NZ?a~Fv3uZ39qUpx>RWJ zks=XD>4SV8i3GBXWKxA#ug8*->*VhN8fpa{U{2Meu5 zmpIk(#7f!D;nb=L7s((ujU)O{?3^Ve)kU*M13ipIEV@0HSZGMES%Q+<*pu^0sgD1} ziY-Gj)Tjd#VYJt{3!pq@3(Nf{AL?L_s1S$C`jz3ND?A9%)3l>{g2ZC__rViardksw z_l6~?7N5l08xBQE+D!9#3S(h@CjA6XLlLK(Wa=rXjn57sy?2xNmkQf;BFK`VOvF2` zywr9U6_gFqAS*fO!6vu_I&O)Kls9GLu$eFt&ux*!FEC+;h+GX5Tj)d~2tE@Uk8~(_ z%6=VpES1x_!#Y7=Nu|Sn9^-L=$`SX~#X4W1uW%95ZL5$ZF|rEjC*Iyu43~sVaCIrG z3yJh5hb@u}^+K4xPbZ^1)L8;9r-yMzHLGGt=m~Q67Kt9*r~)P>`uaE2jvfTsyhnSs zbt1q~Km-zxOzLZF5j&WuxI z1PO;9P94`wGL*#g(~T9zMCD(ohjQJ&I57;)DO03U8KVxE%yo!}4vct6(g&fLt_MfX zAWA|SZ9ZB;&DigzP zsd6Cs=i`u!6Wq2s_&VMv9=xj0WTLlUCkp2ENhb%XAQ?2YSm3#cyb%qj}B}u_ZQ$(uTT5iA9>eLNHWz1O-ZeuqWYl zV=y_xpOg4wjb7tt5D9{Z9jVpflJO6%-5i%HTpLQDY>m2ta-lso>K+X3?tjm47wgk? zRZM3y3GhI_PR1;p{ph5R5DK2{r`UPZ(NHv6XK@+D5?WmDEa8Pxs^?eRW+ z%-he`YsGip_QASIUo6Whg%Ms}+_1o>(xtGlnkb58k0HAi5n?ygImUxWrrw`)_lyqy zT4#ZRO*RU)pe}}_8~>ODWxoTPML~nj!t{tII$Op{s^IPz20WC$-mGT`>{HfQ?b!YBtBQWrAqYa z*NIPLbqY^xf;kje`Fbq75A9^kuR}z2EU=#l{Te@%s)Yc?e7sKjWHjAW&$CSw%gCZ; zsCFv`2Gw^-MoA;Odpw94?>^PVMz`^9(%r;CP7J{Vs6OtZD@}L5#~7!xKL|lL*c}+8 zCk8BG0$5Xa0M`I$*Um#BUGNG|cVhGF3V47&YCyI{g6}y(@}>9>6p|&QZGrkgt{Z3wbmF+Ne$1Yc}y809H;Vm2HDKSq?Juoa-S!{P3B5cD|5 zV$=u@VmwLQ81MI{->sy(kQbK)C8_et2-H^R!bn^3Cpz{B1!f}d>n~g(=tjQhhGR~< ztu7gbsTB%G@+D{9X5rdl(g3xrRn(@hFVQyfY2nsXaH2w6B&s*Sa#O2mXWGGsEE(-iCAN!B*7~W#MuIY+jCEJuNJj6+i_F}J0j)>(LZw_2;ocML54VhMfW?+ zwU93Qg^)ZL>ilZ)$ooJnnjYdc4&$d&n@=r>f^*BtbMtvt<5u!nV$~i?jDlbTJST{u zI!bmAdQ4ydDz?c$WL@eme||YR!lj#gwTgz>2wYtK1>*SF>RJ^ddN>vWsa9w18R5+7 zlSX&96%y0{qj%h&|EeXS$p2MHymAyNV4&G+JO;i(UfDA;6NkSz!rvUPf@xiWU{jcu zFxM81u6Sm}bqFTSa*}e0E`Dh$(1$N!7uU61V_~F<|B{IeJx8Tpw7#^?MPw*mjx)N# z(ddc{Xn^8*`-l}Prg!O?o&n>|*r;q2UmsE|I(~?V18$gVh;0z(;lu+{peweL$U%s& zzQ&*~2w%bZ*S%`X>u}3JAY*vxBV}u6t7Fj+?vzK+xkB{NfIpWS#ug$){E~it5IS%R z9S+zbq;TbKR z{>p>A8<|{Lt$pLBVAr8TqUz>L#fk+Bk8f=}{XG2b+YMgVwB+w^{?(>vr@}F9H`Irc zWd7ABtD}}(TlVg)LdS=Xhiy~LZ~Hxby&-GOV4S*J+}Is_U+0z;{D||%p?U3g*%ooP zH7FtrD3nnTPl#D@FGdhnou@3)ZIy_GEVX>i&9^y&jkMAcPDOE;^$sSC7xe+d4{jKZ3>}hK zh7NVOaJnLGy=Uo4OiB;q7w%Ic91i=yYASL>73elt^ub)XJ$K?B^u>CdFQ$7{+s;OS ztG}=QFpHpYVW~M7Q~g*nN+&g3;&)ilz}quxB4^3SJ~vm--5cq(*7-~HPnu=>1X_n# zmkc|a+=tu_gZbm;`?V0~f98AkwOuubDDyO(3}nCs_X~gObZq8f2+yLS<+B!t zgt|XIM@jCt;rN&5TPP3cxvLzwqAhW;uDraTBx330qt5NAteM@q_y>lrNL98>G%7!f zFmEwz5!ZdT!T`FU`@@YNWE7qWFCM-gcqJ329vdP9D6MXq_@vuttj=~e7@DERiGsZrtftL#|J1(bw|CsPeve3e< zg!M_D&%++Sk5?^X41egb45%r#2Ro1O`*>%E8Ys+ zzx%_iCI0vQ)*diJ#5Xr6`gH1_(7L$R`vlECO zEA{Lupk2phURbX(e=@}e-tdNa9O`i`xO-Ro^|Ji-ChdC`Q5PF)^_#pdpKJ>qn_q5* zUl>r|pQUq1Q&nM2!%H9yPtyz+f(^N8nf#>Bd!?0qT74Zkp^FEJ+1sXt8BUxF1*~Ivo{-GUY%3$8vkR^8gNJy z+|Ad#bjXS7usgL2;fYov+<##iQ<72N!g_J8e}KK+`x-g!l1>95FL$T`-%Qyz+vxl8u|0XLpy*=&liL<}D+~jPvgO3Cv=RV~D(4&FU57&6-0WKID6)sNWNs z?~puuR#w?bcs};nrR!*t$45P;u)J)q@=$FmUT-1^`iNaLn;9^7V77l7*h#tG#U}y{ z9*5BJTJL?^-?U7y?qpwyG({gAyA)w@oOLj6l-}pRdEPjlDmvo+EnXEKbU3b}x z+#Z{niS~l4@wLPS*LFKKIWP}1I6gwlMM>QZ(@u;WiqsPxMgDn)t8sWu77THpDu8#^>oXSa^| zJ!HR<34uxu8e=5)=mA&zL}cBKfj55ZUAa!-^>Ue0i`OIFIWOS$~wX_GDlfGc-3V?(#36s-8umT1NR+ zgr8H=T)KRJ6V4)JDM=N69M| z%jQ05dxkTu6N;gwFK_6e#}vEDYS(8ezr4`c@a}F&yKAkAPXX;_RyWd=-f(|*`!7oE z4=&6iyjZT=73V{ZoTqm5m%xi)TfxY3vkM+Nynz?8d*Ai5U%?x1DKS^D<^&kK-*(KK zWumFX%pHq}t+;(hP(dx`BQ6L6{zS@f8j*BZ<_K&PKjuK&2>5&w=- zhJU;2iN-VNotBQc2ERhZkMp{aDVz`l2fkURu^irsoDsZp4RZ{NInmX>=r-+wbu^p-89fnZQTomd*Ox6 zIclRS`DORD;057FXIbWAxQF&u7QEc+2ss*H(`uEM+_uExXJqyD1MMTj zgEb?=WoS}8l2s;-^DB>WTp2WMI|Q4+vT(<0+*XaLkIzZ46o*jjqq#2feEIdq#R*!@ zF)t)fp>IOXLzXQIT9<F)3#;Q-pZfoQDK-!kGKM&V&hat6D%AG$+h#4`YeH&S?_hu5|k(fde#<;@&7)+kL|YNgEbWICF*v>F9`WZlf@FW3@E>P}^oI@5Z?YUBLTmmk;d zJK_407wdY}^Z1V#K}^Ef$C&DqM*}d&D|EXfNRO#Qk|FD8NULt8bEYfhh&PE-x4Nh?&j@ivy6_6u=C+QwNRa5!18Fp;SR(uE zflPQVy`K}#?-4|^xmJ#C{3UEEKNtfBii*!YdQ>0v5Aw;^|jE0OPgc+>Iz0PL`KU#V7Kzx&ghP`;lt zIVy&wd~DFZHha&;^J>FJRTb(z<{&lcFuN%T-v3aG1B@mC9Uv=eiug3K-2f^ zyZCbsI|}+;nvASdhkX)`pAY@8ns_m<&*`|OrU8<_+_Qat**3(So+$M?odxZ;mwuIw z!*T`b4u`zN=iF|BshQZsJQDCPngkjl)AlXIeM~p8XDr?54Ah!F4Q@LZy3qD>U~aR zr+Udzb6ufpT1*(>XzgiGm>g7G)mfOfXC5?xyvQth|16mRtDRmeq@LFP&iZ#=-sN&HA0%7rt#yk^KH$ehM4m^ z!;ATF6(~-%F^%^A8i%vRKB zgfP&1m5Ir)>e^E#<}GhCZe+L5dSKsKmAAo z_REHtTF7)XZn=MJ_Oda%jx(b>+lU>S;+kLhn7vB7-nKs}ZP}17^xC;UNz>Fq;$S~d zMnOng`V*e4xSn>U9PQLl53_ovcUV^=yIe;l-{DgGlUJI}HfMdI*)eL?kZ9Hty;J!q ze4S41)-`)mu{HIlM|TSD?Jp#!m9t(b&XRkixUeDI(_+8WwUKV&-~2eEvL;ytx^3AP z@9^(`EOZDCcJzTBkVaZxbnf&&7UF@&+xlzT-#qM(w+I;k7UNOJ;l=;(V&H#6T0tC9 zX?<|^^bh;?D!Zj~=!&}gAO7w27NE2I&TRU-rTG2r)|7xb4EWub#)W^p@HC&+{I8V( zv-3vbU`Bl50d(R;pdVbfFIFL-Y$GVT=FZ^4Vq98GfQDR4B&p%*K_QtltalhV{# TnMdWL7=Xaj)z4*}Q$iB}#eve1 literal 0 HcmV?d00001