{ "cells": [ { "cell_type": "markdown", "metadata": {}, "source": [ "##
Plotly plot of a circular phylogenetic tree
Interactive path marking
##" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "A circular phylogenetic tree is defined as the image of a rectangular tree, through a map $g$, that associates\n", "to each point of cartesian coordinates (x,y), a point of special polar coordinates $(r,\\theta)$, with respect to the `tree.root` as reference point, and the horizontal axis through this point as reference direction.\n", "\n", "The Plotly plot generation of a phylogenetic tree with rectangular layout is presented in this [Jupyter Notebook](http://nbviewer.jupyter.org/github/empet/Phylogenetic-trees/blob/master/Plotly-rectangular-phylogram-Zika.ipynb). The cartesian coordinates on the rectangular representation are assigned as in Biopython [https://github.com/biopython/biopython/blob/master/Bio/Phylo/_utils.py](https://github.com/biopython/biopython/blob/master/Bio/Phylo/_utils.py).\n", "\n", "\n", "If `ymin`, `ymax` are the min, max y-coordinates on the rectangular tree, d is the distance between the y-coordinates of two consecutive leafs, then the mapping from cartesian to polar coordinates is defined as follows:\n", "$$(x,y)\\mapsto (r=x, \\:\\theta=2\\pi (y-ymin+d)/(ymax-ymin+d))$$\n", "\n", "\n", "When the tree has a reduced number of leafs, we can choose to map the rectangular representation onto a circular\n", "area between some `startangle>=0`, and `endangle`<$2\\pi$. In this case the mapping to polar coordinates is defined\n", "by:\n", "$$(x,y)\\mapsto (r=x,\\: \\theta=(endangle-startangle)(y-ymin)/(ymax-ymin))$$" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Let us illustrate this mapping on the basic rectangular tree below, where $x_{left}=x_{right}$:" ] }, { "cell_type": "code", "execution_count": 1, "metadata": {}, "outputs": [ { "data": { "image/svg+xml": [ "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "" ], "text/plain": [ "" ] }, "execution_count": 1, "metadata": {}, "output_type": "execute_result" } ], "source": [ "from IPython.display import SVG\n", "SVG(filename='Data/recttree.svg')" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Denoting $\\theta=g(y_{right})$, $\\theta_b=g(y_{bot})$, and $\\theta_t=g(y_{top})$, the circular image of this rectangular tree looks like this one:" ] }, { "cell_type": "code", "execution_count": 2, "metadata": {}, "outputs": [ { "data": { "image/svg+xml": [ "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "\n", "" ], "text/plain": [ "" ] }, "execution_count": 2, "metadata": {}, "output_type": "execute_result" } ], "source": [ "SVG(filename='Data/circtree.svg')" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "The function `get_circular_tree_data()` computes and returns the lists of x, y-coordinates (with\n", "$x=r\\cos{\\theta}, y=r\\sin{\\theta}$) of the points on the circular phylogenetic tree." ] }, { "cell_type": "code", "execution_count": 22, "metadata": {}, "outputs": [ { "name": "stdout", "output_type": "stream", "text": [ "Python version: 3.6.4\n", "Plotly version: 3.3.0\n" ] } ], "source": [ "import platform\n", "print(f'Python version: {platform.python_version()}')\n", "import plotly\n", "print(f\"Plotly version: {plotly.__version__}\")" ] }, { "cell_type": "code", "execution_count": 3, "metadata": {}, "outputs": [], "source": [ "from Bio import Phylo\n", "import numpy as np\n", "import plotly.graph_objs as go\n", "import ipywidgets as ipw" ] }, { "cell_type": "code", "execution_count": 4, "metadata": {}, "outputs": [], "source": [ "\n", "\n", "def get_circular_tree_data(tree, order='level', dist=1, start_angle=0, end_angle=360, start_leaf='first'):\n", " \"\"\"Define data needed to get the Plotly plot of a circular tree\n", " \"\"\"\n", " # tree: an instance of Bio.Phylo.Newick.Tree or Bio.Phylo.PhyloXML.Phylogeny\n", " # order: tree traversal method to associate polar coordinates to its nodes\n", " # dist: the vertical distance between two consecutive leafs in the associated rectangular tree layout\n", " # start_angle: angle in degrees representing the angle of the first leaf mapped to a circle\n", " # end_angle: angle in degrees representing the angle of the last leaf\n", " # the list of leafs mapped in anticlockwise direction onto circles can be tree.get_terminals() \n", " # or its reversed version tree.get_terminals()[::-1]. \n", " # start leaf: is a keyword with two possible values\"\n", " # 'first': to map the leafs in the list tree.get_terminals() onto a circle,\n", " # in the counter-clockwise direction\n", " # 'last': to map the leafs in the list, tree.get_terminals()[::-1] \n", " \n", " start_angle *= np.pi/180 # conversion to radians\n", " end_angle *= np.pi/180\n", " \n", " def get_radius(tree):\n", " \"\"\"\n", " Associates to each clade root its radius, equal to the distance from that clade to the tree root\n", " returns dict {clade: node_radius}\n", " \"\"\"\n", " node_radius = tree.depths()\n", " \n", " # If the tree did not record the branch lengths assign the unit branch length\n", " # (ex: the case of a newick tree \"(A, (B, C), (D, E))\")\n", " if not np.count_nonzero(node_radius.values()):\n", " node_radius = tree.depths(unit_branch_lengths=True)\n", " return node_radius\n", " \n", " \n", " def get_vertical_position(tree):\n", " \"\"\"\n", " returns a dict {clade: ycoord}, where y-coord is the cartesian y-coordinate \n", " of a clade root in a rectangular phylogram\n", " \n", " \"\"\"\n", " n_leafs = tree.count_terminals() # Counts the number of tree leafs.\n", " \n", " # Assign y-coordinates to the tree leafs\n", " if start_leaf == 'first':\n", " node_ycoord = dict((leaf, k) for k, leaf in enumerate(tree.get_terminals()))\n", " elif start_leaf == 'last':\n", " node_ycoord = dict((leaf, k) for k, leaf in enumerate(reversed(tree.get_terminals())))\n", " else:\n", " raise ValueError(\"start leaf can be only 'first' or 'last'\")\n", " \n", " def assign_ycoord(clade):#compute the y-coord for the root of this clade\n", " for subclade in clade:\n", " if subclade not in node_ycoord: # if the subclade root hasn't a y-coord yet\n", " assign_ycoord(subclade)\n", " node_ycoord[clade] = 0.5 * (node_ycoord[clade.clades[0]] + node_ycoord[clade.clades[-1]])\n", "\n", " if tree.root.clades:\n", " assign_ycoord(tree.root)\n", " return node_ycoord\n", "\n", " node_radius = get_radius(tree)\n", " node_ycoord = get_vertical_position(tree)\n", " y_vals = node_ycoord.values()\n", " ymin, ymax = min(y_vals), max(y_vals)\n", " ymin -= dist # this dist subtraction is necessary to avoid coincidence of the first and last leaf angle\n", " # when the interval [ymin, ymax] is mapped onto [0, 2pi],\n", " \n", " def ycoord2theta(y):\n", " # maps an y in the interval [ymin-dist, ymax] to the interval [radian(start_angle), radian(end_angle)]\n", " \n", " return start_angle + (end_angle - start_angle) * (y-ymin) / float(ymax-ymin)\n", "\n", " \n", " \n", "\n", " def get_points_on_lines(linetype='radial', x_left=0, x_right=0, y_right=0, y_bot=0, y_top=0):\n", " \"\"\"\n", " - define the points that generate a radial branch and the circular arcs, perpendicular to that branch\n", " \n", " - a circular arc (angular linetype) is defined by 10 points on the segment of ends\n", " (x_bot, y_bot), (x_top, y_top) in the rectangular layout,\n", " mapped by the polar transformation into 10 points that are spline interpolated\n", " - returns for each linetype the lists X, Y, containing the x-coords, resp y-coords of the\n", " line representative points\n", " \"\"\"\n", " \n", " if linetype == 'radial':\n", " theta = ycoord2theta(y_right) \n", " X = [x_left*np.cos(theta), x_right*np.cos(theta), None]\n", " Y = [x_left*np.sin(theta), x_right*np.sin(theta), None]\n", " \n", " elif linetype == 'angular':\n", " theta_b = ycoord2theta(y_bot)\n", " theta_t = ycoord2theta(y_top)\n", " t = np.linspace(0,1, 10)# 10 points that span the circular arc \n", " theta = (1-t) * theta_b + t * theta_t\n", " X = list(x_right * np.cos(theta)) + [None]\n", " Y = list(x_right * np.sin(theta)) + [None]\n", " \n", " else:\n", " raise ValueError(\"linetype can be only 'radial' or 'angular'\")\n", " \n", " return X,Y \n", " \n", " \n", "\n", " def get_line_lists(clade, x_left, xlines, ylines, xarc, yarc):\n", " \"\"\"Recursively compute the lists of points that span the tree branches\"\"\"\n", " \n", " # xlines, ylines - the lists of x-coords, resp y-coords of radial edge ends\n", " # xarc, yarc - the lists of points generating arc segments for tree branches\n", " \n", " x_right = node_radius[clade]\n", " y_right = node_ycoord[clade]\n", " \n", " X,Y = get_points_on_lines(linetype='radial', x_left=x_left, x_right=x_right, y_right=y_right)\n", " \n", " xlines.extend(X)\n", " ylines.extend(Y)\n", " \n", " if clade.clades:\n", " \n", " y_top = node_ycoord[clade.clades[0]]\n", " y_bot = node_ycoord[clade.clades[-1]]\n", " \n", " X,Y = get_points_on_lines(linetype='angular', x_right=x_right, y_bot=y_bot, y_top=y_top)\n", " xarc.extend(X)\n", " yarc.extend(Y)\n", " \n", " # get and append the lists of points representing the branches of the descedants\n", " for child in clade:\n", " get_line_lists(child, x_right, xlines, ylines, xarc, yarc)\n", "\n", " xlines = []\n", " ylines = []\n", " xarc = []\n", " yarc = []\n", " get_line_lists(tree.root, 0, xlines, ylines, xarc, yarc) \n", " xnodes = []\n", " ynodes = []\n", "\n", " for clade in tree.find_clades(order='preorder'): #it was 'level'\n", " theta = ycoord2theta(node_ycoord[clade])\n", " xnodes.append(node_radius[clade]*np.cos(theta))\n", " ynodes.append(node_radius[clade]*np.sin(theta))\n", " \n", " return xnodes, ynodes, xlines, ylines, xarc, yarc " ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "### A circular phylogram from a `'phyloxml'` file" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Read a phylogenetic tree from a [phyloxml file](http://phyloxml.org/) " ] }, { "cell_type": "code", "execution_count": 5, "metadata": {}, "outputs": [], "source": [ "tree = Phylo.read('Data/bcl_2.xml', 'phyloxml')" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Assign an id to each tree node: " ] }, { "cell_type": "code", "execution_count": 6, "metadata": {}, "outputs": [], "source": [ "traverse_order = 'preorder'\n", "\n", "all_clades=list(tree.find_clades(order=traverse_order))\n", "for k in range(len((all_clades))):\n", " all_clades[k].id=k" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Get the coordinates for the nodes and links, as linear and circular lines, that define the Plotly traces\n", "representing the phylogram:" ] }, { "cell_type": "code", "execution_count": 7, "metadata": {}, "outputs": [], "source": [ "xnodes, ynodes, xlines, ylines, xarc, yarc = get_circular_tree_data(tree, order=traverse_order, start_leaf='last')" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "In the next cell we are performing a particular processing that is dictated by the type of data provided for each tree node \n", "in the `phyloxml` file.\n", "\n", "More precisely, we are extracting the text to be displayed on hover over the tree nodes, and the confidence values to be mapped to a colorscale. \n" ] }, { "cell_type": "code", "execution_count": 8, "metadata": {}, "outputs": [], "source": [ "tooltip=[]\n", "color=[]\n", "for clade in tree.find_clades(order=traverse_order):\n", " if clade.name and clade.confidence and clade.branch_length:\n", " tooltip.append(f\"id: {clade.id}
name: {clade.name}
branch-length: {clade.branch_length}\\\n", "
confidence: {int(clade.confidence.value)}\")\n", " color.append[clade.confidence.value]\n", " elif clade.name is None and clade.branch_length is not None and clade.confidence is not None: \n", " color.append(clade.confidence.value)\n", " tooltip.append(f\"id: {clade.id}
branch-length: {clade.branch_length}\\\n", "
confidence: {int(clade.confidence.value)}\")\n", " elif clade.name and clade.branch_length and clade.confidence is None:\n", " tooltip.append(f\"id: {clade.id}
name: {clade.name}
branch-length: {clade.branch_length}\")\n", " color.append(-1)\n", " else: \n", " tooltip.append('')\n", " color.append(-1)\n", "\n", "size=[9 if c!=-1 else 7 for c in color]" ] }, { "cell_type": "code", "execution_count": 9, "metadata": {}, "outputs": [], "source": [ "pl_colorscale=[[0.0, 'rgb(10,10,150)'],#color for leafs that haven't associated a confidence\n", " [0.001, 'rgb(10,10,150)'],\n", " [0.001, 'rgb(214, 47, 38)'], # in fact the colorscale starts here \n", " [0.1, 'rgb(214, 47, 38)'],\n", " [0.2, 'rgb(244, 109, 67)'],\n", " [0.3, 'rgb(252, 172, 96)'],\n", " [0.4, 'rgb(254, 224, 139)'],\n", " [0.5, 'rgb(254, 254, 189)'],\n", " [0.6, 'rgb(217, 239, 139)'],\n", " [0.7, 'rgb(164, 216, 105)'],\n", " [0.8, 'rgb(102, 189, 99)'],\n", " [0.9, 'rgb(63, 170, 89)'], \n", " [1.0, 'rgb(25, 151, 79)']]\n", " " ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Define data and layout for the Plotly plot of our circular phylogram:" ] }, { "cell_type": "code", "execution_count": 10, "metadata": {}, "outputs": [], "source": [ "trace_nodes=dict(type='scatter',\n", " x=xnodes,\n", " y= ynodes, \n", " mode='markers',\n", " marker=dict(color=color,\n", " size=size, colorscale=pl_colorscale, \n", " colorbar=dict(thickness=20, dtick=10, ticklen=4, title='confidence')),\n", " text=tooltip, \n", " hoverinfo='text',\n", " opacity=1)\n", "\n", "trace_radial_lines=dict(type='scatter',\n", " x=xlines,\n", " y=ylines, \n", " mode='lines',\n", " line=dict(color='rgb(20,20,20)', width=1),\n", " hoverinfo='none')\n", "\n", "trace_arcs=dict(type='scatter',\n", " x=xarc,\n", " y=yarc,\n", " mode='lines',\n", " line=dict(color='rgb(20,20,20)', width=1, shape='spline'),\n", " hoverinfo='none')" ] }, { "cell_type": "code", "execution_count": 12, "metadata": {}, "outputs": [], "source": [ "layout=dict(title='Bcl-2 gene family tree',\n", " font=dict(family='Balto',size=14),\n", " width=700,\n", " height=750,\n", " autosize=False,\n", " showlegend=False,\n", " xaxis=dict(visible=False),\n", " yaxis=dict(visible=False), \n", " hovermode='closest',\n", " plot_bgcolor='rgb(245,245,245)',\n", " margin=dict(t=75)\n", " )" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "### 1. Plotly plot of the circular phylogram" ] }, { "cell_type": "code", "execution_count": 13, "metadata": {}, "outputs": [], "source": [ "fig=go.FigureWidget(data=[trace_radial_lines, trace_arcs, trace_nodes], layout=layout)" ] }, { "cell_type": "code", "execution_count": 14, "metadata": {}, "outputs": [ { "data": { "text/html": [ "" ], "text/plain": [ "" ] }, "execution_count": 14, "metadata": {}, "output_type": "execute_result" } ], "source": [ "import plotly.plotly as py\n", "py.sign_in('empet', '')\n", "py.iplot(fig, filename='bcl2-phyloxml')" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "### 2. Interactive path marking from root to an arbitrary tree node" ] }, { "cell_type": "code", "execution_count": 15, "metadata": {}, "outputs": [], "source": [ "fw=go.FigureWidget(fig)\n", "with fw.batch_update():\n", " fw.data[2].marker.showscale=False\n", " fw.layout.title='Path marking from root to a tree node by clicking that node'" ] }, { "cell_type": "code", "execution_count": 16, "metadata": {}, "outputs": [], "source": [ "textarea_box = ipw.Textarea(value='',\n", " description='',\n", " disabled=False,\n", " continuous_update=True)\n", "\n", "textarea_box.layout = dict(margin='-70px 10px 10px 80px', width='540px') " ] }, { "cell_type": "code", "execution_count": 17, "metadata": {}, "outputs": [], "source": [ "def select_path_nodes(trace, points, state):\n", " \n", " if not points.point_inds:\n", " return\n", " ind = points.point_inds[0] \n", " new_color = np.array(['rgb(150, 160, 150)']*len(trace.x)) \n", " path=tree.get_path(id=ind)\n", " path_ids=[0]+[path[k].id for k in range(len(path))]\n", " new_color[path_ids] = 'magenta'\n", " trace.marker.color = new_color \n", " target_node=list(tree.find_elements(id=ind))[0]\n", " path_to=target_node.name if target_node.name else 'noname'\n", " textarea_box.value = ' '.join(f\" {x} ->\" for x in path_ids[:-1])+ f\"{path_ids[-1]} ({path_to})\" " ] }, { "cell_type": "code", "execution_count": 18, "metadata": {}, "outputs": [ { "data": { "application/vnd.jupyter.widget-view+json": { "model_id": "55cfdb04a59349fbbf400a87f9361e78", "version_major": 2, "version_minor": 0 }, "text/plain": [ "VBox(children=(FigureWidget({\n", " 'data': [{'hoverinfo': 'none',\n", " 'line': {'color': 'rgb(20,20,20…" ] }, "metadata": {}, "output_type": "display_data" } ], "source": [ "fw.data[2].on_click(select_path_nodes) \n", "ipw.VBox([fw, textarea_box])" ] }, { "cell_type": "code", "execution_count": 19, "metadata": {}, "outputs": [ { "data": { "text/html": [ "\n", "\n" ], "text/plain": [ "" ] }, "execution_count": 19, "metadata": {}, "output_type": "execute_result" } ], "source": [ "from IPython.core.display import HTML\n", "def css_styling():\n", " styles = open(\"./custom.css\", \"r\").read()\n", " return HTML(styles)\n", "css_styling()" ] }, { "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" }, "widgets": { "application/vnd.jupyter.widget-state+json": { "state": { "077f9e5eebaa4a82b9bd15265b9b35d1": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.0.0", "model_name": "LayoutModel", "state": { "margin": "-70px 10px 10px 80px", "width": "540px" } }, "08c0800f5ac14b4490a542dc696b0b92": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.0.0", "model_name": "LayoutModel", "state": {} }, "55cfdb04a59349fbbf400a87f9361e78": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.2.0", "model_name": "VBoxModel", "state": { "children": [ "IPY_MODEL_cb0c6cddd93141a780c2f624f05c8713", "IPY_MODEL_9a9d55e1d7e1492f98cfd636c7e89ea7" ], "layout": "IPY_MODEL_08c0800f5ac14b4490a542dc696b0b92" } }, "90fb4529362f42deb54dbcaca1ea98e6": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.0.0", "model_name": "LayoutModel", "state": {} }, "9a9d55e1d7e1492f98cfd636c7e89ea7": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.2.0", "model_name": "TextareaModel", "state": { "layout": "IPY_MODEL_077f9e5eebaa4a82b9bd15265b9b35d1", "style": "IPY_MODEL_cc1cd20fb2c64f18968206d8488f4d7a", "value": " 0 -> 60 -> 61 -> 62 -> 144 -> 180 -> 181 -> 185 -> 186 ->187 (55_BOVIN)" } }, "aaa8dadda6b94f058f94a1ebcb40d182": { "model_module": "plotlywidget", "model_module_version": "^0.4.0", "model_name": "FigureModel", "state": { "_data": [ { "hoverinfo": "none", "line": { "color": "rgb(20,20,20)", "width": 1 }, "mode": "lines", "type": "scatter", "uid": "5615301a-c555-11e8-9bd3-8af2f04e441a", "x": [ 0, 0, null, 0, 0.1578079409818431, null, 0.18173590669014342, 0.3704706342339276, null, 0.3998564910644171, 1.024082831887035, null, 1.0781485228424805, 1.1693956546285882, null, 1.19320430825563, 1.436458094721308, null, 1.4544062403961326, 1.6420259159356294, null, 1.6474436091332678, 1.7522906094092747, null, 1.752675, 2.033125, null, 1.7511376062435167, 2.349372391993509, null, 1.6301278966180768, 2.0101865414957976, null, 2.020853573559901, 2.0474073081662336, null, 2.051464901944066, 2.132449876615273, null, 2.042451653875596, 2.1830144647578313, null, 1.9959929591719348, 1.9960027820444421, null, 2.0035390173470806, 2.0963804041976397, null, 1.9875910339530896, 2.0543789521311937, null, 1.405759845305352, 1.7461607596629802, null, 1.755987999052346, 1.768337434356736, null, 1.735567596453274, 1.7571934439025234, null, 1.1363278791903368, 1.5087943689945196, null, 1.5202145838716363, 1.7822506953214303, null, 1.4967123470410415, 1.8188241128121674, null, 0.9484350204488002, 1.3896348769327327, null, 1.4310073516929878, 1.5168991612173741, null, 1.546818511219353, 2.0035484555183105, null, 2.0346257791219275, 2.0346348273924524, null, 2.0542394256007457, 2.088442567534885, null, 2.0141377711035546, 2.0801338135979948, null, 1.9704938714804334, 2.0202242755729225, null, 1.484942293387745, 1.7098346646691456, null, 1.3448248000205862, 1.628876734444117, null, 1.6522283837407923, 1.6522367129531994, null, 1.6048106059768361, 1.6048186961467799, null, 0.3333473197571598, 1.2908572971741192, null, 1.324485046020822, 1.3591634815074902, null, 1.2559556280221975, 1.3668922875694631, null, 1.3923675006872231, 1.4678928973895988, null, 1.3408175103181614, 1.395001748394395, null, 0.12849093341262552, 0.47111541775805055, null, 0.5373592099474311, 0.9056318619949466, null, 0.9256301112822649, 0.9256371079156701, null, 0.8852363726415463, 0.8852430639476099, null, 0.39914756548253283, 0.7523922838101064, null, 0.882230966362246, 0.9772394001880166, null, 1.018089163526263, 1.1679286425628, null, 1.1985323923247166, 1.1985387665646143, null, 1.136812600697851, 1.1368186466889996, null, 0.9354252195453294, 1.1510236840094772, null, 0.6142069655114251, 0.6716347014154497, null, 0.7757843934977681, 0.8604087058329355, null, 0.9615652957955837, 1.0192149006673739, null, 0.7555677136995645, 0.7945387885848596, null, 0.8567277420109971, 0.8613402854883508, null, 0.91401438449459, 0.9257209987752617, null, 0.9607824999999985, 0.9724624999999986, null, 0.8902534457250971, 1.0043354614130118, null, 0.8078161476112073, 0.807820405404123, null, 0.7312826007716955, 1.144788857607141, null, 0.5640052583088262, 0.7156794132599676, null, 0, 0.023544836327340873, null, -0.14860702261158398, -0.2424644452940123, null, -0.3578133295471951, -0.42829964763304745, null, -0.4045913457420647, -0.41750117894923894, null, -0.3985232204475163, -0.4941569200964988, null, -0.4499228097952459, -0.5300346628176277, null, -0.408731544191389, -0.4598423282231091, null, -0.12553795638039722, -0.15524120668112146, null, 0.08209508980588105, 0.10243183802607282, null, 0.2786796386046482, 0.2802299879655742, null, 0.34909804363034974, 0.6343485409679197, null, 0.21023283992938827, 0.22449146514162482, null, 0.32440470260371007, 0.37626857920757023, null, 0.12295401913696334, 0.12732657829057095, null, 0.17601734146722547, 0.18464754192340235, null, 0.23206512507030508, 0.2320668959177083, null, 0.27246515214131145, 0.27246723125821964, null, 0.29925267352566337, 0.2992549570343645, null, 0.2455622758580187, 0.24752977966116882, null, 0.19143961768561144, 0.19297787197637362, null, 0.1369819379006787, 0.13698298318531138, null, 0.0784394867590058, 0.08083682879463498, null, -0.07641211837432581, -0.0814071613207816, null, -0.037595380486817424, -0.04352510358558665, null, -2.5454436801127623e-16, -2.586610182266101e-16, null, 0.029488707301455835, 0.029488916725654672, null, -0.029488707301456356, -0.02948891672565519, null, -0.08700725314878106, -0.08757487944532605, null, -0.12510959504273794, -0.15327897060873785, null, -0.3817733841172063, -0.39767345342423505, null, -0.17333333520025415, -0.2168595634497718, null, -0.1714174777908488, -0.1894076027583099, null, -0.261967267380151, -0.31219631098145506, null, -0.2620368410363961, -0.26203871484954194, null, -0.36193643495704264, -0.364646270359266, null, -0.3217201156358513, -0.3217223991445524, null, -0.4072125632381114, -0.40721545355608085, null, -0.37887979066574495, -0.3788824798639511, null, -0.4353724982898918, -0.43537558845983554, null, -0.5968966646896544, -0.6285519390529037, null, -0.44895730847282345, -0.5411493731634495, null, -0.44980245387197826, -0.44980623227984645, null, -0.414962822314965, -0.4250748974077709, null, -0.4842057377992333, -0.5121770167435561, null, -0.48797318950601415, -0.49202272738443864, null, -0.5361561862139446, -0.5361604440068602, null, -0.6286410131459844, -0.7218397081072679, null, -0.6585307760449691, -0.6843142326828929, null, -0.6580958025265348, -0.6584154767907675, null, -0.7102324999999994, -0.7256224999999994, null, -0.783069989553361, -0.9164951319452446, null, -0.857245177081122, -1.050314287847954, null, -0.973930016006747, -1.125548137515659, null, -1.0552008759952618, -1.1933478021889554, null, -1.1933964006981292, -1.2575871677422763, null, -1.177979754428832, -1.2032640894123765, null, -1.3337476220427493, -1.3337544675138087, null, -1.273108369299222, -1.2823215998154824, null, -1.2509286442820595, -1.2708353954819112, null, -1.3131520867141, -1.3780109163884642, null, -1.3920607071795632, -1.5313828797079598, null, -1.4996409124728343, -1.5068264549799064, null, -1.5624531317993686, -1.5703332826617942, null, -0.7784075192407357, -0.8073166797242599, null, -0.7754089603804857, -1.0189115599319862, null, -0.8372795024739893, -0.9014124190425679, null, -0.8642453893370762, -0.9076384960692079, null, -0.9357243374283774, -0.9635130469690216, null, -0.9324436671936407, -1.0901043153473118, null, -1.0739983756275457, -1.1811122256827888, null, -1.1057320992860815, -1.2175434466390054, null, -0.9921989412845769, -0.9922076790068072, null, -0.971304608803963, -0.9802089507522339, null, -1.01177800350948, -1.011786913574722, null, -0.9950944320572097, -0.9951031951240102, null, -1.027480883563051, -1.0369182297202713, null, -1.0264722415579637, -1.0264811986755662, null, -1.046909391276556, -1.0469185267311325, null, -0.676993503787383, -1.0985541624891162, null, -0.6111956649358464, -1.2579801533840924, null, -0.5259273989566795, -1.5313234816548074, null, -0.431349000812468, -0.517101830577536, null, -0.5144484172860555, -0.9813055009500559, null, -0.5195284259157499, -0.981380378554231, null, -0.380528480625566, -0.6347577190586658, null, -0.7044246978518764, -0.8812378001519606, null, -0.8959318220323339, -1.3454101601595518, null, -1.3381043471706275, -1.6665849839918145, null, -1.657787951047722, -1.7875409102391475, null, -1.7816208892836218, -2.079933990299303, null, -1.7926768566726627, -2.417669433912731, null, -1.6724582605646023, -1.9002279205265027, null, -1.8973074566181676, -2.141458172062889, null, -1.902314881665775, -1.944318005443131, null, -1.340607705852664, -1.5969370604728959, null, -1.6023834937290564, -1.7576394360658651, null, -1.758025, -2.052815, null, -1.7564829133845454, -2.359933120307654, null, -1.5849230025652734, -1.719362122069589, null, -1.7325871869842246, -1.788430646816567, null, -1.6987744845869763, -1.6987842550427208, null, -1.711215982598081, -1.7330355992267592, null, -1.7419750265828726, -1.7419849193062023, null, -1.7469899746771311, -1.7579925267147087, null, -1.7362157717765256, -1.7470913080654134, null, -1.7223858749661327, -1.7664416429031833, null, -1.6840706993385453, -1.6840803851701567, null, -0.834345301170519, -1.3283734483587595, null, -1.3656114766320064, -1.5341092813926256, null, -1.282670431887766, -1.6510989106147809, null, -1.7037254036780831, -1.7566306268753997, null, -1.7879452848339623, -1.8909295280083596, null, -1.7214158096339078, -1.784589534490498, null, -1.809373072833056, -1.977087636001552, null, -1.9940590871075268, -2.1673043397230844, null, -1.9592489689150685, -1.959258104369645, null, -1.7580448217335038, -1.7969276692454965, null, -1.5902261573181184, -1.6723773271211102, null, -1.6922314482993048, -1.6922402113661053, null, -1.6517896459746535, -1.651798199617255, null, -0.5084182615525373, -0.6007450103151444, null, -0.6562749050956511, -0.9724988042889932, null, -1.0297498484759846, -1.3054178494742603, null, -1.324132377812677, -1.5705104808147246, null, -1.2861307217226006, -1.4441074702141967, null, -0.9096448493523941, -1.0425334341218453, null, -1.09775438521471, -1.6989000495516051, null, -1.7431576017280055, -2.0801536253126898, null, -1.6529658881369862, -1.714282767687126, null, -1.7462324094021933, -2.236295868530027, null, -1.6815811848925746, -1.8200487756712718, null, -0.983855059789419, -1.0478807506069292, null, -1.071020153440942, -1.4685898534208517, null, -1.0242817126429178, -1.4068638281346584, null, -0.5394296126846749, -1.3094059211016047, null, 0.005784513668042991, 0.0073299211724926205, null, -0.18105952833475866, -0.1955873122814473, null, -0.2421503385422714, -0.3207735566410482, null, -0.3655874602056933, -0.5788137895938991, null, -0.6052806803269585, -0.6052865581794815, null, -0.6226010535074021, -0.6226070994985508, null, -0.5877065641622357, -0.638831085555407, null, -0.5517756795315463, -0.5517810377994962, null, -0.2738480085514164, -0.30457099185284214, null, -0.328409917654092, -0.6683443841440724, null, -0.7092160800972108, -0.8177214601151402, null, -0.8486925000000003, -0.9182675000000005, null, -0.7863917405719261, -0.8229133670204247, null, -0.6268131129739796, -0.7458056515876704, null, -0.2803229625056545, -0.5200478545966545, null, -0.14682753379377722, -0.19018844867090978, null, -0.2091575429925052, -0.2573759707373163, null, -0.2727977128147622, -0.44527464755006957, null, -0.2418413350527494, -0.3509027028774996, null, -0.17103166131220568, -0.25768031671265035, null, 0.19441011044703568, 0.36724808752319793, null, 0.29853190029784415, 0.33487246529977244, null, 0.25726008009800505, 0.2876835649917768, null, 0.17561799943985087, 0.20586668687905826, null, 0.0433739865529769, 0.04804824735983767, null, -0.13799821012743796, -0.14330460023805075, null, -0.3019678210683514, -0.32665525523605216, null, -0.35876776080260375, -0.4870141764741501, null, -0.2943994678784966, -0.30057555600724206, null, 0.017110111877635517, 0.018182155571879695, null, -0.06059301074531001, -0.06232868720001843, null, -0.15767953809425253, -0.1707569695429975, null, -0.2511554381013541, -0.2511568989316397, null, -0.08997937781002485, -0.09095544339395575, null, -0.14542497909488117, -0.18826636132416005, null, -0.2351780668635769, -0.23725609271333786, null, -0.14127207593640406, -0.14127270384159937, null, -0.03639614565158387, -0.03667153847305001, null, 0.03324808109471824, 0.033248290518917076, null, 0.09690994598374955, 0.10226597729959999, null, 0.23324360300087432, 0.2332452706883415, null, 0.17529294046153943, 0.19981940093773812, null, 0.1666502516299366, 0.16893419855233482, null, 0.23290090285219572, 0.23422587592125677, null, 0.29078840945308065, 0.32748482288241526, null, 0.29514711932369386, 0.29514899313683973, null, 0.3596788807743458, 0.3596811642830469, null, 0.36491565007325794, 0.49198558928192543, null, 0.4577512848539961, 0.5604652103379968, null, 0.5260040925701199, 0.6211875071774913, null, 0.3964830276007422, 0.4642326702768304, null, 0.4395754945763582, 0.5761983085241437, null, 0.4886862181850857, 0.6721360968115112, null, 0.4100829379815262, 0.6841911303052887, null, 0.4331949857219327, 0.4640115329845541, null, 0.42609104701956124, 0.6877513817345567, null, 0.5009017973081453, 0.567140796746673, null, 0.5394292952653812, 0.7792447189845781, null, 0.7521274999999998, 0.7521324999999999, null, 0.8060201354811305, 0.8060254937490804, null, 0.5942925987333141, 0.9143088175410056, null, 0.1797004976168639, 0.2700963584799674, null, 0.2232652239887754, 0.39012208559250416, null, 0.34908645993481235, 0.673447839067328, null, 0.427814065513073, 0.49668547261481644, null, 0.46649470450370895, 0.5681188501900846, null, 0.539871860934943, 0.6008051362058643, null, 0.5791028818066333, 0.8185894489951135, null, 0.6219144684717433, 0.6903075698250786, null, 0.6747613404113679, 0.6747680317174316, null, 0.7055510075237854, 0.7055580041571906, null, 0.5951044735248806, 0.858633922023995, null, 0.5247916674508968, 0.7932332897028126, null, 0.7670063152627508, 0.8111164171555786, null, 0.8181542677222755, 0.9968001264317192, null, 0.9674421437977426, 1.1025273850369977, null, 1.0246211155202527, 1.0246294156431035, null, 0.998711254131013, 1.039210644869423, null, 1.0491712821749588, 1.0520354205503246, null, 1.0310273932067928, 1.0399563089072053, null, 1.0720052159475484, 1.090165768664908, null, 1.0767453611539481, 1.0946310278339042, null, 1.103107993439416, 1.1122478721122735, null, 0.3044899921867922, 0.49592793271006025, null, 0.48205863368444835, 0.7574362572524534, null, 0.507900696104816, 0.7681716679430264, null, 0.743603163884636, 1.1109032505844199, null, 0.7876014712039423, 1.0610546506958753, null, 1.0336865195093163, 1.084004722303817, null, 1.069210416594483, 1.6727655246439825, null, 1.0973429793822203, 1.1764495026162196, null, 1.1642885736928321, 1.3409247299820506, null, 1.1874494179149948, 1.225195758907795, null, 1.2177630534331538, 1.2502831967643182, null, 1.2320910530294806, 1.232100738861092, null, 1.0807459910222021, 1.2295748115005625, null, 1.2203320559374924, 1.3689224579649648, null, 1.236921651825659, 1.4775155763352414, null, 1.4693953841848761, 1.4694052441452468, null, 1.483651151179209, 1.5287202413167904, null, 1.5234268478829267, 1.52343676902994, null, 1.5325049724371058, 1.5434832664498168, null, 1.541111084079432, 1.5411210490080245, null, 1.5451784260469377, 1.5451884172752388, null ], "y": [ 0, 0, null, 0, -0.14468352631889764, null, -0.11317565658970795, -0.23070981425875983, null, -0.17490081697536966, -0.44794301943353315, null, -0.2949480596945455, -0.31991045022126985, null, -0.21469134119755137, -0.2584596056149396, null, -0.12212990428959827, -0.1378847686322067, null, -0.03450902419589474, -0.03670525576906236, null, -4.2928156573911747e-16, -4.979720047032925e-16, null, -0.07339441139982548, -0.09846787782672123, null, -0.24071634488028615, -0.2968385227933938, null, -0.21240026943292273, -0.21519117940216909, null, -0.17226632090058866, -0.17906681922820594, null, -0.2580216479403288, -0.2757788604717193, null, -0.3807560205184738, -0.38075789433161966, null, -0.3388732594833872, -0.35457620467417544, null, -0.42247551618323403, -0.4366717264322707, null, -0.3924952011834959, -0.4875368441853432, null, -0.45086108748608866, -0.4540318835474406, null, -0.5239987511114946, -0.5305279794044703, null, -0.4225965501513128, -0.561115596036529, null, -0.5293947289206677, -0.6206453573912224, null, -0.5925903393069248, -0.720123409339005, null, -0.5914977660239163, -0.8666549711604663, null, -0.7964884742578647, -0.8442952421534938, null, -0.7881433972153444, -1.0208589273818363, null, -0.957422217288428, -0.9574264750813437, null, -0.9146063187691845, -0.9298345386859426, null, -0.9998266724982913, -1.0325873925006368, null, -1.0832881729637107, -1.1106276939689832, null, -0.8993130192170823, -1.0355126805214656, null, -0.9346775847716635, -1.1320988221050623, null, -1.097737913614306, -1.0977434475297985, null, -1.1659631546362261, -1.1659690324887493, null, -0.28170032594180267, -1.0908589924263026, null, -1.0497739117982603, -1.0772597010755756, null, -1.13086752692982, -1.2307553438470704, null, -1.2018593866401412, -1.267051160300234, null, -1.2591114510833452, -1.3099938374670246, null, -0.1712505446874615, -0.6278946674209438, null, -0.5722294379963972, -0.9643999801765685, null, -0.9452223486104112, -0.9452294933372076, null, -0.9831545940377012, -0.9831620254859561, null, -0.675930966293428, -1.2741283861087205, null, -1.187925003952917, -1.315853968624621, null, -1.284508842762631, -1.4735592154733435, null, -1.4487767875602477, -1.4487844926926756, null, -1.4976952916129465, -1.4977032569121267, null, -1.3459005054845516, -1.6561060422189908, null, -1.3461972725207279, -1.4720653687522098, null, -1.4199395046375392, -1.5748297101438913, null, -1.5151844570700133, -1.6060256985747752, null, -1.6277313006266767, -1.7116872945894945, null, -1.68142286682849, -1.6904754931142438, null, -1.662585993313421, -1.683880245638487, null, -1.6641241050230453, -1.68435445845545, null, -1.7028977807254289, -1.9211165500753231, null, -1.7166966976969424, -1.716705745967467, null, -1.7396525626784172, -2.7233450758439584, null, -1.5165644366874076, -1.9244039487750144, null, 0, 0.21858056800026554, null, 0.16201165654211472, 0.2643351959033585, null, 0.02513412467841992, 0.03008534298304405, null, -0.1437065028995733, -0.1482919370734484, null, -0.19358970992576102, -0.24004547266245715, null, -0.3152496722455884, -0.37138204619610216, null, -0.5017966648035064, -0.5645449927147971, null, -0.7172211912184646, -0.8869212658253206, null, -0.8966546493799963, -1.1187756055543936, null, -1.088342223775308, -1.0943968845303855, null, -1.0744133017412165, -1.9523240613681097, null, -1.1099709636023025, -1.1852525417410276, null, -1.1618870833921848, -1.3476426160247814, null, -1.2000426304107146, -1.2427192132922926, null, -1.2367623038109667, -1.2974012528461059, null, -1.2897637393534922, -1.289773581309572, null, -1.281847758547641, -1.2818575400236485, null, -1.275870284320762, -1.2758800201097908, null, -1.2872825306436928, -1.2975965467763442, null, -1.2964265532630017, -1.3068435909291019, null, -1.3032960808327378, -1.3033060260516915, null, -1.2467599398208074, -1.2848646003121988, null, -1.120853391479255, -1.1941233249169416, null, -1.196304404568942, -1.3849912530347848, null, -1.3856749999999998, -1.4080849999999998, null, -1.4077761836906777, -1.4077861814975126, null, -1.4077761836906777, -1.4077861814975126, null, -1.382940686914845, -1.3919628485398365, null, -1.1903382839568095, -1.4583519895396053, null, -0.8154619839113875, -0.8494242835395293, null, -0.9217490677691821, -1.153212105540596, null, -1.1608368873070944, -1.2826657751114865, null, -1.1438091542938342, -1.3631206753749172, null, -1.3736452257277592, -1.3736550486002665, null, -1.3507651643700271, -1.3608784077712737, null, -1.3716607125744524, -1.3716704483634812, null, -1.3487530802804666, -1.348762653475442, null, -1.3569949245483865, -1.3570045561740545, null, -1.3399387705256602, -1.3399482810908234, null, -0.7234501784555493, -0.7618169766668595, null, -0.8797044851504611, -1.0603492174514042, null, -1.102207267039982, -1.1022165257458303, null, -1.1158014036204644, -1.1429919541356242, null, -1.0875438932324983, -1.15036841435458, null, -1.1608423456905452, -1.170475815624645, null, -1.1393898934120479, -1.1393989416825725, null, -1.010936983009223, -1.160812676026849, null, -1.197863034752559, -1.2447629682685066, null, -1.258821167172667, -1.2594326476423365, null, -1.2301587751866627, -1.2568150371151479, null, -1.120419575197568, -1.3113247859114339, null, -1.3508022532540265, -1.6550304913709126, null, -1.2692503082316335, -1.4668428911645686, null, -1.5182350900054418, -1.717002467568346, null, -1.4121939342830183, -1.4881534493307333, null, -1.5519310137312123, -1.5852418949029843, null, -1.4202969597659185, -1.4203042494521927, null, -1.4749102415554904, -1.4855838718401801, null, -1.5121129761164172, -1.5361761046883051, null, -1.4584031413787495, -1.5304361693122732, null, -1.3632065610727284, -1.4996409124728345, null, -1.53138287970796, -1.5387205141277887, null, -1.4672411531699023, -1.4746411073849917, null, -0.6078851700892887, -0.6304613265411263, null, -0.6693150601821644, -0.8795008658676613, null, -0.5900887563425598, -0.6352876569089203, null, -0.6849924548742163, -0.7193854074682263, null, -0.5835706645893229, -0.6009012768712277, null, -0.6480652310805409, -0.7576422360759517, null, -0.7803054949020881, -0.8581282623056116, null, -0.7346466503247631, -0.8089339318951896, null, -0.5522508462091885, -0.5522557095629927, null, -0.5882429803586104, -0.5936356415261848, null, -0.515526642026744, -0.5155311819317414, null, -0.547057793394573, -0.547062610931314, null, -0.4834958034331761, -0.4879366814441998, null, -0.5095452458182387, -0.5095496921700305, null, -0.4661140919152209, -0.4661181592816517, null, -0.2680406899235311, -0.43494836211076404, null, -0.21284084943597759, -0.43807503845429874, null, -0.15878684344636876, -0.46233381723339106, null, -0.10117199475687647, -0.12128513939622301, null, -0.13208790321930505, -0.251956428832765, null, -0.11042917590249046, -0.20859883895591178, null, 0.19885620799411374, 0.3317110792850304, null, 0.12936555600812968, 0.1618367702604478, null, -0.008796072693102569, -0.013208957735151293, null, -0.1406404341150461, -0.17516514024771937, null, -0.24480082635888908, -0.26396107638513494, null, -0.30133861765999326, -0.35179450197895, null, -0.2264677530581797, -0.30542267687434854, null, -0.10522215495903978, -0.11955220732601968, null, -0.15932135853707868, -0.17982326693192932, null, -0.07973061656558919, -0.08149106904836473, null, 0.11434139510018615, 0.13620391005102053, null, 0.03356514933175236, 0.03681729771543888, null, 2.1529596890710257e-16, 2.513973318991674e-16, null, 0.0736184461472765, 0.0989105034866386, null, 0.2382825133417851, 0.25849453073007184, null, 0.1454894110342474, 0.15017871737459038, null, 0.3703927371605078, 0.37039486746437056, null, 0.3078963525699581, 0.3118223212628433, null, 0.25723249208955073, 0.25723395291983636, null, 0.22069615765254477, 0.22208610321277292, null, 0.2936589168737164, 0.2954983761499951, null, 0.3661044194518145, 0.3754687620062464, null, 0.4323958633640973, 0.43239835026296897, null, 0.3265564561292211, 0.5199153457251076, null, 0.41230241318230415, 0.4631748997625006, null, 0.6242151457517289, 0.8035118932484347, null, 0.684893220938091, 0.7061609843005637, null, 0.6226284232710567, 0.6584913310978993, null, 0.788125691350966, 0.8170488807972186, null, 0.760590404575068, 0.831091115218299, null, 0.7895038437834854, 0.8580964916852214, null, 0.8723138426221616, 0.8723179099885924, null, 0.8727010284175293, 0.892002641545947, null, 0.9181175000000007, 0.9655475000000007, null, 0.9303121112894518, 0.9303169288261928, null, 1.0003593676654048, 1.0003645479354986, null, 0.504440753057181, 0.5960452019825822, null, 0.5342917734409675, 0.7917385028413602, null, 0.7156947888511463, 0.9072890406584869, null, 0.87975144845186, 1.0434446687180412, null, 0.9344286659056978, 1.0492054921208491, null, 0.8632207303301167, 0.9893272885972124, null, 0.927674379815932, 1.4356818529390674, null, 1.381609690456342, 1.6487094474538184, null, 1.4883371707649125, 1.543547137095582, null, 1.5073073821813558, 1.9303188127924704, null, 1.5791098412207698, 1.7091395639919245, null, 1.0476992252320123, 1.115879660954737, null, 1.0936897714381082, 1.4996745821858561, null, 1.1375800887719034, 1.5624805741868584, null, 0.6520583893976534, 1.582799861008668, null, 0.3586483548360765, 0.4544658929783455, null, 0.41690577211666746, 0.45035729515521294, null, 0.42712914155892395, 0.5658126877199311, null, 0.5379456117167892, 0.8516986275678444, null, 0.8330973852125177, 0.8331054753824616, null, 0.8202465963333669, 0.8202545616325472, null, 0.8455989268356603, 0.9191574729898575, null, 0.8694593462045827, 0.8694677894838377, null, 0.5899550325553833, 0.6561420342782315, null, 0.6445407545000025, 1.3116997096165266, null, 1.2900592605599737, 1.4874298141062532, null, 1.4699785300026493, 1.590485964939254, null, 1.5042286623333756, 1.574088090484172, null, 1.3320456694231129, 1.5849176857757912, null, 0.6668619759118474, 1.2371449587475256, null, 0.46852723009984937, 0.6068920777347095, null, 0.6006186495891868, 0.7390831129934062, null, 0.7335309442061967, 1.1973074454266797, null, 0.7443110955003316, 1.0799674717963803, null, 0.6125665766704766, 0.9229071873183501, null, 0.41084995385295026, 0.7761111778833967, null, 0.8050456028881581, 0.9030445505117963, null, 0.9281413035809621, 1.0379029615810054, null, 1.0626206799689832, 1.2456479375242588, null, 1.2617997362162914, 1.3977794217796484, null, 1.39178031313373, 1.4452978861728167, null, 1.4206469030917683, 1.5367921492029006, null, 1.5296141537765942, 2.076395537208218, null, 1.5432960568011111, 1.5756722445851288, null, 1.452284211955957, 1.5432778970243046, null, 1.542195106098388, 1.5863710217905906, null, 1.5797452475925933, 1.7107642144893878, null, 1.7008212975316122, 1.7008311902549418, null, 1.7169088070698224, 1.7355332478929952, null, 1.7318198874826025, 2.2420043015611637, null, 2.2375698397796016, 2.257340935059523, null, 2.245455346157126, 2.2454653264244104, null, 1.7375338465211863, 1.7506809625088804, null, 1.5872468141812475, 1.5872568119880823, null, 1.5403394822552678, 1.6254711621901994, null, 1.3790189874269936, 1.3790288473873644, null, 1.3875865029789487, 1.5817334288791787, null, 1.585571230395115, 1.6073015338089118, null, 1.5772018268045571, 1.5861745268645313, null, 1.3680519066003116, 1.5406949581298284, null, 1.5472153829315187, 1.547225205804026, null, 1.533498733599058, 1.5335084693880867, null, 1.2086589450116239, 1.629534888906622, null, 1.639480873764472, 2.007360816152837, null, 1.618874136189866, 1.911818564339099, null, 1.0014018174786528, 1.1725178819415265, null, 1.181982884898487, 1.549350560679834, null, 1.1625385738894682, 1.5989485898514644, null, 0.8714706031768596, 1.4539801630134337, null, 0.7413243706842332, 0.7940605709152948, null, 0.815037000801052, 1.3155470582792572, null, 0.7713211279865667, 0.8733202424600892, null, 0.8907036345690379, 1.286685965167743, null, 1.302723043769761, 1.302731704023799, null, 1.2700845035760338, 1.2700929468552888, null, 0.8550749887090628, 1.3155179847466048, null, 0.12664736547299935, 0.19035557874898465, null, 0.24359788378030275, 0.4256503219286399, null, 0.4599044267184004, 0.8872347624392014, null, 0.3877480671443457, 0.45016947199737606, null, 0.48138519181108713, 0.5862531750734455, null, 0.61236442335887, 0.6814796573146206, null, 0.7000151336280184, 0.9895046640713101, null, 0.6622716428554893, 0.7351028984211625, null, 0.7493983891837863, 0.7494058206320411, null, 0.7204849672319131, 0.7204921119587095, null, 0.5588402981314738, 0.806310922395754, null, 0.4170644050972311, 0.6304013394118492, null, 0.6620620914778744, 0.7001369100723779, null, 0.5977026809650655, 0.7282124306620342, null, 0.7667851945812642, 0.8738524374678365, null, 0.688516815956613, 0.6885223934077028, null, 0.7256061993237506, 0.7550307290535119, null, 0.650513755645761, 0.6522895966765848, null, 0.6850129622731272, 0.6909453196810159, null, 0.6189224999999999, 0.6294074999999999, null, 0.6521001698040367, 0.6629321145700289, null, 0.6064387512643507, 0.6114634420852315, null, 0.1283477069646637, 0.2090420526662658, null, 0.2392959839096401, 0.3759946233982542, null, 0.17798869942005646, 0.26919804827418164, null, 0.33107345904762436, 0.49460599376268055, null, 0.20552183140091318, 0.27687847598116694, null, 0.36604759473286463, 0.38386620487876333, null, 0.4233303512280356, 0.6622947233577674, null, 0.34388644466677065, 0.36867692634480026, null, 0.4054481784313634, 0.46695939603734804, null, 0.33154183464283954, 0.3420808024127518, null, 0.3676643424621998, 0.37748275260440356, null, 0.31634721441748936, 0.31634970131636103, null, 0.18570612567828262, 0.21127959425452383, null, 0.2593895859057824, 0.29097345085790827, null, 0.1628438247827753, 0.1945186158488152, null, 0.24852962632487213, 0.24853129401233928, null, 0.14024632554761574, 0.14450660889154487, null, 0.19245356680116393, 0.19245482013349957, null, 0.0964170404054442, 0.09710773612026664, null, 0.1294107134379425, 0.12941155021637582, null, 0.06476216414008773, 0.06476258289662502, null ] }, { "hoverinfo": "none", "line": { "color": "rgb(20,20,20)", "shape": "spline", "width": 1 }, "mode": "lines", "type": "scatter", "uid": "5615437a-c555-11e8-a95f-8af2f04e441a", "x": [ 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, null, 0.12849093341262552, 0.135422873544206, 0.14212581746960434, 0.1485884307023415, 0.15479978514826592, 0.16074937758464927, 0.166427147420835, 0.1718234937104096, 0.1769292913861285, 0.18173590669014342, null, 0.3333473197571598, 0.34222830625951667, 0.3507557391112413, 0.3589208086815696, 0.36671507969468814, 0.37413049994416014, 0.38115940861160147, 0.38779454418101805, 0.3940290519406287, 0.3998564910644171, null, 0.9484350204488002, 0.9670359776130955, 0.9846288359901423, 1.0011952556840074, 1.0167179668226378, 1.0311807875610608, 1.044568640950348, 1.0568675706547703, 1.068064755500755, 1.0781485228424805, null, 1.1363278791903368, 1.1444641671977043, 1.1521526820026826, 1.1593904154631256, 1.1661745358057176, 1.172502388733908, 1.178371498466409, 1.1837795687058483, 1.1887244835371977, 1.19320430825563, null, 1.405759845305352, 1.4136713382462651, 1.4209627482159493, 1.4276308769610078, 1.433672799619789, 1.4390858660053285, 1.4438677017678054, 1.4480162094360132, 1.451529569337379, 1.4544062403961326, null, 1.6301278966180768, 1.6333299233041914, 1.6362135290854918, 1.6387781517973175, 1.641023291461389, 1.6429485103832802, 1.644553433237748, 1.6458377471419017, 1.646801201716201, 1.6474436091332678, null, 1.7511376062435167, 1.7514602318522188, 1.7517449179527538, 1.751991658378353, 1.752200447784213, 1.7523712816476118, 1.7525041562680073, 1.7525990687671165, 1.752656017088979, 1.752675, null, 1.9959929591719348, 1.9994506734554378, 2.002735143121742, 2.0058460835843355, 2.0087832252923383, 2.0115463137538563, 2.014135109558029, 2.0165493883957795, 2.018788941079244, 2.020853573559901, null, 2.042451653875596, 2.0436304153891314, 2.044764908507972, 2.0458551086571326, 2.046900992221085, 2.047902536544272, 2.0488597199315963, 2.049772521648893, 2.050640921923375, 2.051464901944066, null, 1.9875910339530896, 1.9895357899471802, 1.9914374493251004, 1.9932959708937805, 1.9951113143945882, 1.9968834405041986, 1.998612310835446, 2.000297887938158, 2.0019401352999617, 2.0035390173470806, null, 1.735567596453274, 1.7379875909536122, 1.740369937785336, 1.7427145853428956, 1.7450214828373698, 1.747290580297567, 1.7495218285711045, 1.7517151793254773, 1.7538705850491019, 1.755987999052346, null, 1.4967123470410415, 1.4994541671350519, 1.502163506586575, 1.5048403067068663, 1.5074845095120313, 1.510096057724292, 1.5126748947732198, 1.5152209647969648, 1.5177342126434632, 1.5202145838716363, null, 1.3448248000205862, 1.3550741256178909, 1.3651578825840023, 1.3750748388432672, 1.3848237827004402, 1.3944035229887377, 1.4038128892153736, 1.4130507317045808, 1.4221159217380783, 1.4310073516929878, null, 1.484942293387745, 1.4922177454405399, 1.4993942059497003, 1.5064711988393278, 1.5134482546320591, 1.520324910480214, 1.5271007101964962, 1.5337752042842603, 1.5403479499673256, 1.546818511219353, null, 1.9704938714804334, 1.9780085686479238, 1.9854268604683334, 1.992748385384583, 1.9999727865558758, 2.007099711875096, 2.0141288139859523, 2.0210597502999272, 2.027892183012962, 2.0346257791219275, null, 2.0141377711035546, 2.0187693441715386, 2.0233571873765053, 2.0279012013382274, 2.032401287625891, 2.0368573487602295, 2.041269288215632, 2.045637010422237, 2.049960420768, 2.0542394256007457, null, 1.6048106059768361, 1.6102198439018434, 1.6155942018176965, 1.6209335633069701, 1.626237812710311, 1.6315068351289614, 1.6367405164272313, 1.6419387432349788, 1.6471014029500644, 1.6522283837407923, null, 1.2559556280221975, 1.263819901837496, 1.2716225788537636, 1.27936327877953, 1.2870416243439988, 1.294657241315445, 1.3022097585194368, 1.309698807856942, 1.3171240243222617, 1.324485046020822, null, 1.3408175103181614, 1.3466631377977385, 1.352479594339724, 1.3582667539501097, 1.364024491269502, 1.3697526815758447, 1.3754512007871167, 1.3811199254640247, 1.3867587328126734, 1.3923675006872231, null, 0.39914756548253283, 0.41559131176896663, 0.43178546254088973, 0.447720291927523, 0.4633862298011321, 0.4787738675246421, 0.49387396360227115, 0.5086774492297811, 0.5231754337410107, 0.5373592099474311, null, 0.8852363726415463, 0.8898025775432097, 0.8943495078581364, 0.8988770650923376, 0.90338515117148, 0.9078736684430092, 0.9123425196782606, 0.9167916080745696, 0.9212208372573659, 0.9256301112822649, null, 0.6142069655114251, 0.6455589270986604, 0.6765569239139466, 0.7071839595245578, 0.7374232408985663, 0.7672581876125769, 0.796672440942911, 0.8256498728352011, 0.8541745947475315, 0.882230966362246, null, 0.9354252195453294, 0.9447985056565184, 0.9541257436214547, 0.9634064788437162, 0.9726402589933628, 0.9818266340289792, 0.9909651562196015, 1.0000553801665528, 1.0090968628251429, 1.018089163526263, null, 1.136812600697851, 1.143770853325188, 1.15070432999539, 1.1576128805179513, 1.1644963552423093, 1.1713546050610837, 1.1781874814133102, 1.1849948362876503, 1.1917765222256098, 1.1985323923247166, null, 0.5640052583088262, 0.5881953316448885, 0.6122348518044511, 0.6361176656850878, 0.6598376602945634, 0.6833887643155114, 0.7067649496594189, 0.7299602330095721, 0.7529686773525345, 0.7757843934977681, null, 0.7555677136995645, 0.7791613561991377, 0.8025901779084774, 0.8258492227849373, 0.84893357069981, 0.8718383384791077, 0.8945586809365377, 0.9170897918984223, 0.9394269052203928, 0.9615652957955837, null, 0.7312826007716955, 0.7454274316953209, 0.7595228120529329, 0.7735678067776014, 0.7875614841449113, 0.8015029158347647, 0.8153911769929655, 0.8292253462925726, 0.8430045059950186, 0.8567277420109971, null, 0.8078161476112073, 0.8197811682007936, 0.8317062338127789, 0.8435907632362906, 0.8554341772361312, 0.867235898581014, 0.8789953520716844, 0.8907119645689723, 0.9023851650217142, 0.91401438449459, null, 0.8902534457250971, 0.8981694210942957, 0.9060659406371716, 0.9139428333021233, 0.9217999284627083, 0.9296370559213292, 0.9374540459129189, 0.9452507291086206, 0.9530269366194599, 0.9607824999999985, null, 0.1797004976168639, 0.15273895606504567, 0.12034945775350525, 0.08368304365327868, 0.0440427455212763, 0.0028372794424200358, -0.038469016382333784, -0.07840822051750307, -0.11556099451369374, -0.14860702261158398, null, 0.005784513668042991, -0.054455719977707734, -0.113152888979209, -0.16864374241918673, -0.21935588397164374, -0.2638523275367584, -0.3008722158733026, -0.32936654841991075, -0.3485279059168218, -0.3578133295471951, null, -0.380528480625566, -0.39709459819300386, -0.4103437987990552, -0.42016541234542343, -0.42647739924580247, -0.4292270356996038, -0.42839135409197504, -0.42397733484146455, -0.416021848092835, -0.4045913457420647, null, -0.431349000812468, -0.4287247734312969, -0.42584014183858626, -0.4226968581379282, -0.4192968315362648, -0.41564212718425037, -0.4117349649218949, -0.40757771793024866, -0.4031729112899516, -0.3985232204475163, null, -0.5259273989566795, -0.5199905545597995, -0.5134047472117573, -0.5061781961867975, -0.4983199204254352, -0.4898397272785619, -0.4807482002675954, -0.4710566858759435, -0.4607772793882721, -0.4499228097952459, null, -0.6111956649358464, -0.5969961779015727, -0.580550397563033, -0.5619202037908623, -0.5411756956595211, -0.5183949276883528, -0.4936636161490085, -0.46707481654430844, -0.4387285734720762, -0.408731544191389, null, -0.676993503787383, -0.6423173286859968, -0.5993912663965691, -0.5487666568183973, -0.4910937195537037, -0.42711320252409535, -0.3576468678464485, -0.28358693716707833, -0.20588463201772925, -0.12553795638039722, null, -0.3817733841172063, -0.3331955864257859, -0.2834662821497965, -0.23275733317352618, -0.18124398698230212, -0.12910427101630792, -0.07651837741703311, -0.023668040292615353, 0.02926409234576049, 0.08209508980588105, null, -0.07641211837432581, -0.036676760884473546, 0.0031045942670104654, 0.04288205583375069, 0.08260573745246202, 0.12222582020724693, 0.16169261510932026, 0.20095662541377193, 0.23996860869524525, 0.2786796386046482, null, 0.21023283992938827, 0.2258709557250423, 0.24146411539284132, 0.25700921535500487, 0.27250316159929205, 0.2879428702948231, 0.3033252684058643, 0.31864729430346916, 0.3339058983748488, 0.34909804363034974, null, 0.12295401913696334, 0.14562077599849774, 0.16823547463573896, 0.19079003048076448, 0.21327638046620737, 0.23568648590773078, 0.25801233537779256, 0.28024594756966414, 0.30237937415068183, 0.32440470260371007, null, 0.0784394867590058, 0.0893163948964993, 0.10018650124471784, 0.1110489780029799, 0.12190299795162231, 0.13274773451500516, 0.14358236182445094, 0.154406054781141, 0.1652179891189521, 0.17601734146722547, null, 0.1369819379006787, 0.14759245388859094, 0.1581931788088899, 0.16878340942498243, 0.17936244319645106, 0.18992957832566407, 0.2004841138043248, 0.211025349459979, 0.22155258600246666, 0.23206512507030508, null, 0.19143961768561144, 0.2004856436626865, 0.20952189825233367, 0.21854794104025133, 0.2275633321098467, 0.23656763206367903, 0.24556040204487398, 0.2545412037585051, 0.2635095994929702, 0.27246515214131145, null, 0.2455622758580187, 0.2515508795366832, 0.25753403420972537, 0.2635116102721805, 0.26948347823992236, 0.2754495087524724, 0.28140957257580007, 0.2873635406051263, 0.29331128386771255, 0.29925267352566337, null, -0.12510959504273794, -0.11541040205130633, -0.10570355290252964, -0.0959896915345902, -0.08626946235084967, -0.0765435101771013, -0.06681248021879309, -0.05707701801822589, -0.04733776941173006, -0.037595380486817424, null, -0.08700725314878106, -0.07735046393140137, -0.06768990476153613, -0.058026046481207794, -0.048359360093237734, -0.03869031673828161, -0.02901938767187033, -0.019347044241445403, -0.009673757863377526, -2.5454436801127623e-16, null, -0.029488707301456356, -0.022936323692949092, -0.016383443245960184, -0.009830207906654839, -0.0032767596288858104, 0.003276759628885293, 0.00983020790665432, 0.01638344324595967, 0.022936323692947326, 0.029488707301455835, null, -0.5968966646896544, -0.5554719747578679, -0.5123060298434874, -0.4675341435538159, -0.42129666368968915, -0.37373853229292575, -0.3250088312920878, -0.27526031517078964, -0.22464893212355877, -0.17333333520025415, null, -0.261967267380151, -0.25197580128101216, -0.2419651462490408, -0.23193606463437635, -0.22188932019041407, -0.2118256780156388, -0.20174590449536725, -0.19165076724337632, -0.1815410350434547, -0.1714174777908488, null, -0.36193643495704264, -0.35092274497919596, -0.3398857752994906, -0.3288262580943591, -0.3177449270360041, -0.30664251724372726, -0.29551976523516266, -0.28437740887741725, -0.27321618733812075, -0.2620368410363961, null, -0.4072125632381114, -0.39778664342407616, -0.38834133605023247, -0.3788771014675376, -0.3693944009494342, -0.3598936966693663, -0.3503754516782571, -0.34084012988193796, -0.3312881960185432, -0.3217201156358513, null, -0.4353724982898918, -0.42913144714394086, -0.42288110030531617, -0.41662159316680736, -0.41035306131963156, -0.40407564055049205, -0.39778946683864463, -0.3914946763529479, -0.3851914054489106, -0.37887979066574495, null, -0.7784075192407357, -0.7480646005874392, -0.7159672564910708, -0.6821907644037305, -0.6468143398598105, -0.6099209506929124, -0.5715971224525479, -0.5319327354769751, -0.4910208140981028, -0.44895730847282345, null, -0.6286410131459844, -0.6095639886994966, -0.5902723896954515, -0.5707730070309454, -0.5510727047456614, -0.5311784176056372, -0.5110971486621358, -0.49083596678648045, -0.4704020041817146, -0.44980245387197826, null, -0.4842057377992333, -0.4766015110428452, -0.4689740554011924, -0.461323742625703, -0.4536509455818298, -0.445956038230874, -0.43823939561176584, -0.43050139382277824, -0.4227424100032036, -0.414962822314965, null, -0.5361561862139446, -0.5308474369858002, -0.5255271887294126, -0.5201955566901072, -0.5148526563597994, -0.5094986034744957, -0.504133514011782, -0.4987575041883186, -0.4933706904573151, -0.48797318950601415, null, -0.783069989553361, -0.7696520247145174, -0.7561245863219784, -0.7424895984878184, -0.7287490006217, -0.7149047471550147, -0.7009588072628908, -0.6869131645841053, -0.6727698169389291, -0.6585307760449691, null, -0.7102324999999994, -0.7044994093487142, -0.6987510580819685, -0.6929875707184994, -0.6872090721049207, -0.6814156874130107, -0.6756075421370089, -0.6697847620908889, -0.6639474734056416, -0.6580958025265348, null, -0.973930016006747, -0.9613294498065971, -0.9486348509348235, -0.9358474611166719, -0.9229685311537567, -0.9099993208017122, -0.8969410986469745, -0.8837951419826867, -0.8705627366837656, -0.857245177081122, null, -1.1933964006981292, -1.1785427760062008, -1.1635599108179109, -1.1484494481732737, -1.1332130451047941, -1.1178523724557687, -1.1023691146970533, -1.086764969742338, -1.0710416487619652, -1.0552008759952618, null, -1.3337476220427493, -1.3171318053599435, -1.300337670114711, -1.2833674899641325, -1.2662235623989497, -1.2489082084325227, -1.2314237722866024, -1.2137726210739608, -1.195957144477921, -1.177979754428832, null, -1.3920607071795632, -1.37931127923904, -1.366442339345687, -1.353455002543048, -1.3403503941333008, -1.3271296495797476, -1.3137939144084374, -1.300344344108908, -1.2867821040340666, -1.273108369299222, null, -1.3131520867141, -1.30635017226614, -1.299519960125701, -1.2926615982464065, -1.2857752351916532, -1.2788610201313841, -1.2719191028388674, -1.2649496336874422, -1.257952763647271, -1.2509286442820595, null, -1.5624531317993686, -1.5556073833899697, -1.5487279379670993, -1.5418149445508562, -1.5348685528880437, -1.527888913448925, -1.5208761774239654, -1.5138304967205571, -1.5067520239597272, -1.4996409124728343, null, -0.8372795024739893, -0.8307929463862422, -0.8242075342460532, -0.8175240496516114, -0.8107432878707465, -0.8038660557463003, -0.7968931716001219, -0.7898254651356935, -0.7826637773394054, -0.7754089603804857, null, -0.9357243374283774, -0.9283519149087709, -0.9208342490847821, -0.913172516116667, -0.9053679147043969, -0.8974216659001184, -0.8893350129171154, -0.8811092209353087, -0.8727455769033091, -0.8642453893370762, null, -0.9921989412845769, -0.9860340062286324, -0.9797485934086777, -0.9733434708027728, -0.9668194210156198, -0.9601772411829415, -0.9534177428740849, -0.9465417519928596, -0.939550108676625, -0.9324436671936407, null, -1.1057320992860815, -1.1023009348729058, -1.098845892809207, -1.0953670479368762, -1.091864475613414, -1.088338251710294, -1.084788452611325, -1.0812151552109899, -1.0776184369127864, -1.0739983756275457, null, -1.01177800350948, -1.0075455925978722, -1.003246342584666, -0.998880538675822, -0.9944484704923887, -0.9899504320512901, -0.9853867217458202, -0.9807576423258481, -0.9760635008777354, -0.971304608803963, null, -1.027480883563051, -1.0240804345219592, -1.0206300732452507, -1.0171299678986665, -1.0135802890724035, -1.0099812097727994, -1.006332905413902, -1.0026355538089191, -0.998889335161551, -0.9950944320572097, null, -1.046909391276556, -1.0447286667276596, -1.0425253116382212, -1.0402993737365354, -1.0380509012400765, -1.0357799428544554, -1.0334865477723645, -1.0311707656725115, -1.0288326467185447, -1.0264722415579637, null, -0.5195284259157499, -0.5190088401287606, -0.5184780117570006, -0.5179359522990854, -0.5173826734969139, -0.5168181873354148, -0.5162425060422863, -0.5156556420877315, -0.5150576081841888, -0.5144484172860555, null, -0.5084182615525373, -0.5408854034566183, -0.5709507186089487, -0.5984807005814177, -0.6233531012106358, -0.6454574734465818, -0.664695661797856, -0.6809822381956996, -0.6942448813412998, -0.7044246978518764, null, -0.834345301170519, -0.8474786980367681, -0.8590785119485292, -0.8691237520809815, -0.8775962407394209, -0.884480646253307, -0.88976451072019, -0.8934382725493201, -0.8954952837641367, -0.8959318220323339, null, -1.340607705852664, -1.3427208029418438, -1.3442367301869806, -1.3451548133853408, -1.3454746442229992, -1.345196080456438, -1.3443192459758062, -1.342844530749822, -1.340772590652335, -1.3381043471706275, null, -1.6724582605646023, -1.6714063664167709, -1.6702096514139015, -1.6688682192466915, -1.6673821861450155, -1.665751680867857, -1.663976844692151, -1.6620578314005425, -1.659994807268063, -1.657787951047722, null, -1.7926768566726627, -1.7916034155298641, -1.7904911653115407, -1.7893401301108618, -1.788150334861142, -1.7869218053353024, -1.7856545681453122, -1.784348650741613, -1.783004081412522, -1.7816208892836218, null, -1.902314881665775, -1.9019231962318808, -1.9014903120146374, -1.9010162383910292, -1.90050098563027, -1.8999445648935813, -1.8993469882339513, -1.8987082685958736, -1.8980284198150648, -1.8973074566181676, null, -1.5849230025652734, -1.5881582566158488, -1.5910708612985958, -1.5936602248903318, -1.5959258213373566, -1.5978671903623287, -1.5994839375577723, -1.6007757344662061, -1.601742318646873, -1.6023834937290564, null, -1.7564829133845454, -1.7568065238004746, -1.7570920788987634, -1.757339572493819, -1.7575489992245232, -1.7577203545543485, -1.757853634771457, -1.75794883698878, -1.7580059591440809, -1.758025, null, -1.6987744845869763, -1.7039817625436147, -1.7088285867657165, -1.713313931974767, -1.7174368493581278, -1.7211964667697464, -1.7245919889146455, -1.7276226975171585, -1.7302879514728677, -1.7325871869842246, null, -1.6840706993385453, -1.687536609033401, -1.6908905700167634, -1.6941323597917648, -1.6972617633028102, -1.7002785729498462, -1.7031825886021317, -1.7059736176115134, -1.7086514748252073, -1.711215982598081, null, -1.7223858749661327, -1.7248997718857488, -1.7273295996239542, -1.7296752397543727, -1.7319365779538127, -1.7341135040078417, -1.7362059118161548, -1.738213699397747, -1.7401367688958842, -1.7419750265828726, null, -1.7362157717765256, -1.7375637128587382, -1.7388740154542321, -1.7401466511796988, -1.7413815924677565, -1.7425788125675463, -1.7437382855453127, -1.7448599862849647, -1.74594389048862, -1.7469899746771311, null, -1.282670431887766, -1.293544114112432, -1.3040105269626325, -1.3140663751124737, -1.3237084925014078, -1.3329338433310614, -1.3417395230210498, -1.3501227591234752, -1.3580809121958275, -1.3656114766320064, null, -1.5902261573181184, -1.604451137965527, -1.6182802443025606, -1.6317100642041598, -1.644737284063218, -1.657358689608166, -1.6695711666960436, -1.6813717020808685, -1.6927573841571102, -1.7037254036780831, null, -1.7214158096339078, -1.7295745054091423, -1.7375435338493255, -1.7453220210606868, -1.7529091140444466, -1.7603039807903615, -1.7675058103679597, -1.7745138130154712, -1.781327220226432, -1.7879452848339623, null, -1.7580448217335038, -1.764094532462995, -1.770058263713741, -1.775935724821893, -1.7817266293282887, -1.787430694992412, -1.7930476438061504, -1.7985772020073425, -1.8040191000931227, -1.809373072833056, null, -1.9592489689150685, -1.9632876669578654, -1.9672838369619894, -1.9712373923638278, -1.97514824752287, -1.979016317723565, -1.9828415191771516, -1.986623769023478, -1.9903629853327942, -1.9940590871075268, null, -1.6517896459746535, -1.656427622837634, -1.6610297187550007, -1.6655958340377888, -1.6701258697764354, -1.6746197278429167, -1.679077310892881, -1.6834985223677492, -1.687883266496813, -1.6922314482993048, null, -0.5394296126846749, -0.5535258218450917, -0.5673585826931681, -0.5809213115839204, -0.5942075533929511, -0.6072109845887402, -0.6199254162423014, -0.6323447969727789, -0.6444632158275767, -0.6562749050956511, null, -0.9096448493523941, -0.924078539637985, -0.9382491990034044, -0.9521527938936972, -0.9657853667714892, -0.9791430372434643, -0.9922220031648864, -1.0050185417218453, -1.0175290104909245, -1.0297498484759846, null, -1.2861307217226006, -1.2904658046604551, -1.2947729339873488, -1.2990520164037789, -1.3033029592177845, -1.3075256703469564, -1.311720058320428, -1.3158860322808608, -1.320023501986409, -1.324132377812677, null, -0.983855059789419, -0.997183696375361, -1.0103489800691707, -1.0233487542098703, -1.0361808892493003, -1.0488432831009784, -1.0613338614844423, -1.073650578265053, -1.085791415789177, -1.09775438521471, null, -1.6529658881369862, -1.663316075724527, -1.6735851956331267, -1.6837727473603674, -1.6938782343793508, -1.7039011641628958, -1.7138410482075461, -1.7236974020573759, -1.7334697453276038, -1.7431576017280055, null, -1.6815811848925746, -1.6889124563802314, -1.6962071432473724, -1.7034650874790855, -1.7106861318563662, -1.7178701199595232, -1.7250168961715606, -1.732126305681557, -1.7391981944880137, -1.7462324094021933, null, -1.0242817126429178, -1.0295651378630069, -1.0348262610095205, -1.0400649681178806, -1.0452811457090785, -1.0504746807921324, -1.0556454608665327, -1.0607933739246826, -1.0659183084543218, -1.071020153440942, null, 0.19441011044703568, 0.1547187851037835, 0.1136429579774296, 0.0715501963020411, 0.028817167355325548, -0.014173732150292325, -0.05703779794646672, -0.0993914607369034, -0.14085571856902795, -0.18105952833475866, null, -0.14682753379377722, -0.15782517026652582, -0.1687351917430645, -0.17955154163882783, -0.1902682153700502, -0.2008792636871494, -0.21137879597738873, -0.22176098353499063, -0.23202006279688112, -0.2421503385422714, null, -0.2738480085514164, -0.28444277624569203, -0.2949450275345627, -0.30535134650938495, -0.31565834846397034, -0.3258626809954773, -0.3359610250947968, -0.34595009622607586, -0.35582664539503, -0.3655874602056933, null, -0.5517756795315463, -0.5578321551618055, -0.5638614428398059, -0.5698632487065721, -0.5758372802425534, -0.5817832462818812, -0.5877008570265587, -0.5935898240605871, -0.599449860364021, -0.6052806803269585, null, -0.5877065641622357, -0.5916357807216661, -0.5955521814773884, -0.5994556815937226, -0.603346196514439, -0.6072236419645883, -0.6110879339523266, -0.6149389887707365, -0.6187767229996396, -0.6226010535074021, null, -0.2803229625056545, -0.28574510834157135, -0.29114829826475513, -0.2965321738354863, -0.30189637789532975, -0.30724055459083144, -0.312564349397122, -0.31786740914143713, -0.32314938202654686, -0.328409917654092, null, -0.6268131129739796, -0.6360971955275824, -0.6453502756012743, -0.6545719022129877, -0.6637616259136491, -0.672918998809092, -0.6820435745818803, -0.6911349085130631, -0.7001925575038511, -0.7092160800972108, null, -0.7863917405719261, -0.7933841961235459, -0.8003594656690893, -0.8073173981127493, -0.8142578427342692, -0.8211806491922083, -0.828085667527198, -0.8349727481651872, -0.8418417419206876, -0.8486925000000003, null, -0.17103166131220568, -0.17530398011283216, -0.17956775484478502, -0.18382277769769914, -0.1880688412877634, -0.19230573866782888, -0.19653326333749463, -0.20075120925317239, -0.20495937083812885, -0.2091575429925052, null, -0.2418413350527494, -0.24530288434579675, -0.24875911997507114, -0.2522099670728264, -0.25565535088804064, -0.25909519678803616, -0.2625294302600958, -0.2659579769130756, -0.26938076247901854, -0.2727977128147622, null, 0.4331949857219327, 0.41880526733216916, 0.4042595019300055, 0.3895631092735277, 0.37472156524459793, 0.3597403998085382, 0.34462519495366384, 0.3293815826114317, 0.3140152425579805, 0.29853190029784415, null, 0.4100829379815262, 0.39360500242708796, 0.3769875713532892, 0.36023653405819184, 0.34335782719055025, 0.3263574326458335, 0.309241375446213, 0.2920157216052652, 0.27468657597814655, 0.25726008009800505, null, 0.3964830276007422, 0.37265158615828103, 0.3486110304002523, 0.32437485074116096, 0.29995664737032524, 0.27537012262009736, 0.250629073276769, 0.22574738283847012, 0.20073901372441436, 0.17561799943985087, null, 0.36491565007325794, 0.33000658804354466, 0.29482455414139147, 0.2593986499242178, 0.2237581786718893, 0.18793262114789655, 0.15195161121372164, 0.11584491131657079, 0.07964238787073799, 0.0433739865529769, null, 0.23324360300087432, 0.19233137295061553, 0.1512506663362202, 0.1100374686352342, 0.06872788138345687, 0.0273580905510662, -0.014035665155211973, -0.055417126036135134, -0.09675004316236223, -0.13799821012743796, null, 0.017110111877635517, -0.01858868598960875, -0.05427625352790567, -0.08993103014265334, -0.12553147504984108, -0.1610560802898851, -0.1964833837216305, -0.23179198198867654, -0.2669605434501825, -0.3019678210683514, null, -0.2943994678784966, -0.3015790793647219, -0.30875215815226764, -0.31591854886045373, -0.32307809625347506, -0.33023064524376483, -0.3373760408953519, -0.3445141284272194, -0.3516447532166552, -0.35876776080260375, null, 0.09690994598374955, 0.07942948756766234, 0.06193880661786506, 0.04444015417589239, 0.026935782309206947, 0.009427943821357315, -0.008081108037955254, -0.025589119862869235, -0.04309383838137532, -0.06059301074531001, null, 0.03324808109471824, 0.012007014838149789, -0.009236201210531234, -0.030477763566535438, -0.051713869041156886, -0.0729407154227177, -0.09415450215732885, -0.115351431029363, -0.13652770684150312, -0.15767953809425253, null, -0.08997937781002485, -0.10795354255856462, -0.12591586898463777, -0.14386438731673348, -0.16179712929755524, -0.17971212839986164, -0.1976074200421181, -0.215481041803933, -0.23333103364126417, -0.2511554381013541, null, -0.03639614565158387, -0.04852543476227079, -0.060652358811726564, -0.07277632675078197, -0.08489674767434285, -0.0970130308501943, -0.1091245857477867, -0.12123082206702158, -0.1333311497670201, -0.14542497909488117, null, -0.14127207593640406, -0.15172133184584555, -0.16216730122179782, -0.17260975778738824, -0.18304847534184077, -0.19348322776537016, -0.20391378902408372, -0.21433993317487643, -0.22476143437032406, -0.2351780668635769, null, 0.29078840945308065, 0.2780415901184265, 0.2652706795623755, 0.2524767843346118, 0.23966101297635223, 0.22682447592429325, 0.2139682854144, 0.20109355538553209, 0.18820140138292618, 0.17529294046153943, null, 0.23290090285219572, 0.22555777622001533, 0.2182097636355661, 0.21085702426888164, 0.20349971739238554, 0.19613800237744006, 0.18877203869089637, 0.18140198589163747, 0.1740280036271247, 0.1666502516299366, null, 0.3596788807743458, 0.3525377837300363, 0.3453890501377297, 0.3382328348507487, 0.3310692928844828, 0.3238985794130278, 0.3167208497658264, 0.3095362594243042, 0.30234496401849903, 0.29514711932369386, null, 0.5260040925701199, 0.5184638403548222, 0.510912357360345, 0.5033498071642256, 0.4957763535837346, 0.488192160672327, 0.4805973927160917, 0.47299221423018806, 0.46537678995528636, 0.4577512848539961, null, 0.4886862181850857, 0.483270244633531, 0.4778438026539411, 0.47240700979197114, 0.46695998381749326, 0.46150284272204495, 0.4560357047162747, 0.45055868822737977, 0.44507191189654244, 0.4395754945763582, null, 0.5009017973081453, 0.4927972242082082, 0.484638610339317, 0.47642685038542093, 0.4681628448585378, 0.45984749999999985, 0.451481727681077, 0.44306644530297706, 0.43460257569624466, 0.42609104701956124, null, 0.5942925987333141, 0.5883086151714394, 0.5822959582776408, 0.5762549211003328, 0.5701857980711451, 0.5640888849905714, 0.5579644790135541, 0.551812878635, 0.5456343836752331, 0.5394292952653812, null, 0.8060201354811305, 0.8001001852641102, 0.7941629035616457, 0.7882084189850214, 0.7822368605181619, 0.7762483575148419, 0.7702430396958816, 0.7642210371463383, 0.758182480312688, 0.7521274999999998, null, 0.3044899921867922, 0.2980126035630234, 0.290855048804725, 0.28303366388659884, 0.27456629986958275, 0.26547228215865704, 0.2557723663956966, 0.24548869108803612, 0.23464472708086503, 0.2232652239887754, null, 0.427814065513073, 0.41974404425319584, 0.41149624649950434, 0.4030741654869506, 0.39448136826562996, 0.3857214941900083, 0.3767982533775271, 0.3677154251372361, 0.3584768563691225, 0.34908645993481235, null, 0.5247916674508968, 0.5187321769870175, 0.5125651395190434, 0.5062918336381884, 0.4999135599679404, 0.49343164089440705, 0.48684742029215033, 0.48016226324556555, 0.4733775557658625, 0.46649470450370895, null, 0.5951044735248806, 0.5892197886115195, 0.5832704891084335, 0.5772572274233558, 0.5711806629781935, 0.5650414621367146, 0.558840298131474, 0.5525778509899852, 0.5462548074601492, 0.539871860934943, null, 0.6219144684717433, 0.617275822128109, 0.6126070906317506, 0.6079085015300544, 0.6031802838256247, 0.5984226679651218, 0.5936358858280308, 0.5888201707153596, 0.5839757573382693, 0.5791028818066333, null, 0.7055510075237854, 0.7021900886288651, 0.6988139591421666, 0.6954226921962053, 0.692016361251399, 0.6885950400944757, 0.6851588028368771, 0.6817077239131515, 0.6782418780793421, 0.6747613404113679, null, 0.8181542677222755, 0.812731271979229, 0.8072421886865068, 0.8016874641909848, 0.7960675501771797, 0.7903829036305167, 0.7846339868001723, 0.7788212671614855, 0.7729452173779441, 0.7670063152627508, null, 1.0246211155202527, 1.0185737346521155, 1.012448785450516, 1.0062467343540493, 0.9999680536729194, 0.9936132215529683, 0.987182721939266, 0.9806770445392546, 0.9740966847854563, 0.9674421437977426, null, 1.0491712821749588, 1.0438381906408094, 1.0384358524071668, 1.0329646258572514, 1.0274248739442335, 1.0218169641671562, 1.016141268546555, 1.0103981635997799, 1.0045880303160166, 0.998711254131013, null, 1.0720052159475484, 1.0676582328598574, 1.063259213616138, 1.0588083726183821, 1.0543059267943007, 1.0497520955867508, 1.0451471009430418, 1.040491167304115, 1.0357845215936083, 1.0310273932067928, null, 1.103107993439416, 1.100273561950699, 1.0974152967276898, 1.094533259685112, 1.0916275132526267, 1.0886981203734785, 1.0857451445031336, 1.082768649607904, 1.0797687001635634, 1.0767453611539481, null, 0.507900696104816, 0.5054064400635909, 0.5028167089942917, 0.5001319921163403, 0.4973527965926834, 0.49447964743398476, 0.4915130873994474, 0.48845367689428215, 0.4853019938638428, 0.48205863368444835, null, 0.7876014712039423, 0.7837350249150427, 0.7796095369971702, 0.7752263710146374, 0.7705869757000137, 0.7656928844752866, 0.7605457149450329, 0.7551471683617643, 0.7494990290636265, 0.743603163884636, null, 1.0807459910222021, 1.0770417394070366, 1.072952454268591, 1.0684795974925172, 1.063624768088157, 1.058389701616912, 1.0527762695717935, 1.046786478708379, 1.0404224703274145, 1.0336865195093163, null, 1.0973429793822203, 1.0945057019534015, 1.0915958166164639, 1.0886135164089468, 1.0855589991722856, 1.0824324675386883, 1.0792341289176925, 1.0759641954824066, 1.072622884155434, 1.069210416594483, null, 1.1874494179149948, 1.1851059007629954, 1.1827046232213279, 1.180245702324872, 1.177729257917963, 1.1751554126485515, 1.1725242919622243, 1.169836024096092, 1.1670907400725379, 1.1642885736928321, null, 1.2320910530294806, 1.2306053669938333, 1.22909302402272, 1.227554056875976, 1.2259884988901601, 1.2243963839778318, 1.2227777466268182, 1.221132621899465, 1.2194610454318786, 1.2177630534331538, null, 1.236921651825659, 1.2354534912216395, 1.2338912460510105, 1.2322350352847908, 1.2304849850498423, 1.2286412286192656, 1.226703906402252, 1.2246731659333883, 1.222549161861424, 1.2203320559374924, null, 1.483651151179209, 1.482459664117215, 1.4811698328484346, 1.4797817429383882, 1.4782954864709315, 1.4767111620421451, 1.475028874753796, 1.473248736206363, 1.471370864491635, 1.4693953841848761, null, 1.5325049724371058, 1.531794513915719, 1.531009397890764, 1.5301496626276876, 1.529215350028774, 1.528206505631101, 1.5271231786043213, 1.5259654217482663, 1.524733291490371, 1.5234268478829267, null, 1.5451784260469377, 1.5448602747839248, 1.5445086593074824, 1.5441235872341799, 1.543705066905311, 1.5432531073867146, 1.542767718468577, 1.54224891066522, 1.5416966952148734, 1.541111084079432, null ], "y": [ 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, null, -0.1712505446874615, -0.1658231417686627, -0.1601153366595365, -0.15413678109528392, -0.1478975846423826, -0.14140829760359847, -0.1346798931777259, -0.12772374890422236, -0.1205516274241142, -0.11317565658970795, null, -0.28170032594180267, -0.27084182767759946, -0.2597035246305426, -0.2482969237029893, -0.2366338089739472, -0.2247262295250218, -0.21258648699259844, -0.20022712285910832, -0.18766090549650813, -0.17490081697536966, null, -0.5914977660239163, -0.5605711491210412, -0.5290601577908671, -0.4969976410616404, -0.4644170229061822, -0.4313522673986424, -0.3978378433082288, -0.3639086881668037, -0.32960017184781976, -0.2949480596945455, null, -0.4225965501513128, -0.40003832719561416, -0.3773235886861901, -0.3544612217961801, -0.33146017145853107, -0.3083294368662829, -0.28507806795162116, -0.2617151618450785, -0.2382498593162693, -0.21469134119755137, null, -0.3924952011834959, -0.3629691075642855, -0.333283803698255, -0.3034523105407897, -0.2734877131707311, -0.24340315505081983, -0.2132118322625538, -0.18292698771794175, -0.15256190535072314, -0.12212990428959827, null, -0.24071634488028615, -0.21793274114763905, -0.19510665099529517, -0.17224252441475563, -0.14934481881280298, -0.1264179981425137, -0.10346653203300003, -0.08049489491806029, -0.05750756516386437, -0.03450902419589474, null, -0.07339441139982548, -0.06524348139984848, -0.05709113811879556, -0.048937558149831584, -0.04078291811289913, -0.032627394650911426, -0.024471164425911903, -0.016314404115258297, -0.008157290407789331, -4.2928156573911747e-16, null, -0.3807560205184738, -0.3621602471884462, -0.3435330940828505, -0.32487617517199313, -0.30619110700526664, -0.2874795085710867, -0.2687430011566207, -0.24998320820728975, -0.23120175518612648, -0.21240026943292273, null, -0.2580216479403288, -0.24851288602695656, -0.2389987409158992, -0.22947941869917635, -0.2199551255809668, -0.21042606787310916, -0.2008924519906636, -0.19135448444742595, -0.18181237185145263, -0.17226632090058866, null, -0.42247551618323403, -0.413220305096749, -0.4039561429790856, -0.39468323050722803, -0.38540176854770586, -0.3761119581522447, -0.3668140005534126, -0.3575080971602544, -0.3481944495539406, -0.3388732594833872, null, -0.5239987511114946, -0.5159154065505891, -0.5078208864137687, -0.4997153660416492, -0.4915990210131294, -0.48347202714158355, -0.4753345604710636, -0.467186797272473, -0.4590289140397598, -0.45086108748608866, null, -0.5925903393069248, -0.585617930639361, -0.5786328365246166, -0.5716352082713104, -0.5646251974595802, -0.5576029559377813, -0.5505686358192116, -0.5435223894788097, -0.5364643695498574, -0.5293947289206677, null, -0.9346775847716635, -0.9197554263530651, -0.9047208883648941, -0.8895758077899616, -0.8743220351176355, -0.8589614341177354, -0.8434958816128181, -0.8279272672488497, -0.8122574932643314, -0.7964884742578647, null, -0.8993130192170823, -0.8871886616821429, -0.8750054493484414, -0.8627641904324718, -0.850465697001457, -0.8381107849194697, -0.825700273793316, -0.8132349869181573, -0.8007157512229025, -0.7881433972153444, null, -1.0832881729637107, -1.0695052433627394, -1.0556701875850516, -1.0417836799317495, -1.0278463972116285, -1.0138590187081773, -0.9998222261464994, -0.9857367036600581, -0.9716031377573473, -0.957422217288428, null, -0.9998266724982913, -0.9904416545451917, -0.9810351819974851, -0.9716074586148334, -0.9621586886172275, -0.9526890766805559, -0.9431988279321858, -0.9336881479465041, -0.9241572427404795, -0.9146063187691845, null, -1.1659631546362261, -1.1584814255436826, -1.1509746018388243, -1.1434428461317903, -1.1358863215727986, -1.128305191848588, -1.1206996211788955, -1.1130697743128855, -1.1054158165255867, -1.097737913614306, null, -1.13086752692982, -1.1220718153239846, -1.1132214155208766, -1.104316758876497, -1.0953582793912506, -1.0863464136887835, -1.0772816009947217, -1.0681642831152451, -1.0589949044155644, -1.0497739117982603, null, -1.2591114510833452, -1.2528573883414464, -1.2465761866487166, -1.2402679820663085, -1.233932911240306, -1.2275711113987586, -1.2211827203487113, -1.2147678764732164, -1.208326718728337, -1.2018593866401412, null, -0.675930966293428, -0.6659469286716094, -0.6555629371489438, -0.644785228135178, -0.6336202744986088, -0.622074781678615, -0.6101556836585091, -0.5978701388011309, -0.5852255255496853, -0.5722294379963972, null, -0.9831545940377012, -0.9790238833769379, -0.9748719654492631, -0.9706989301920474, -0.9665048680000956, -0.9622898697236882, -0.9580540266666189, -0.9537974305842118, -0.9495201736813377, -0.9452223486104112, null, -1.3461972725207279, -1.3314469439929728, -1.3159665731807546, -1.2997646480867866, -1.282850052347372, -1.2652320603614435, -1.2469203322053353, -1.2279249083360988, -1.2082562040862401, -1.187925003952917, null, -1.3459005054845516, -1.3393372598917008, -1.332708736890325, -1.3260152595452859, -1.3192571540872247, -1.312434749896666, -1.3055483794879685, -1.2985983784931086, -1.2915850856453301, -1.284508842762631, null, -1.4976952916129465, -1.4923881233475327, -1.4870486275017574, -1.4816769197378798, -1.4762731164159215, -1.4708373345911478, -1.465369692011528, -1.4598703071151917, -1.4543392990278539, -1.4487767875602477, null, -1.5165644366874076, -1.5073472970275164, -1.4977443400864454, -1.4877580238158201, -1.4773909042910736, -1.4666456350571935, -1.4555249664495347, -1.4440317448898452, -1.4321689121577017, -1.4199395046375392, null, -1.6277313006266767, -1.616570239126936, -1.6050672145894198, -1.593224660319603, -1.5810450814457726, -1.5685310543891018, -1.555685226318641, -1.5425103145913508, -1.5290091061772766, -1.5151844570700133, null, -1.7396525626784172, -1.7336387239275424, -1.7275098781182714, -1.721266431829277, -1.7149087992416576, -1.7084374021114643, -1.7018526697417218, -1.6951550389539483, -1.6883449540591797, -1.68142286682849, null, -1.7166966976969424, -1.7110152882099976, -1.705250486251789, -1.6994025727906297, -1.6934718328455725, -1.687458555472513, -1.6813630337501104, -1.675185564765492, -1.6689264495997818, -1.662585993313421, null, -1.7028977807254289, -1.6987359242201645, -1.6945372703019181, -1.6903019099204397, -1.6860299348205965, -1.681721437540392, -1.6773765114089616, -1.6729952505445493, -1.6685777498524685, -1.6641241050230453, null, 0.12664736547299935, 0.15812221641869315, 0.18397780312700018, 0.20329528334401525, 0.21538816260869137, 0.21982669053225906, 0.2164531330417181, 0.205387377850438, 0.18702267395159877, 0.16201165654211472, null, 0.3586483548360765, 0.35453727249290656, 0.34037997405937204, 0.3165776226580947, 0.2838046849366986, 0.2429898192896878, 0.19528956126861668, 0.1420555518343249, 0.08479623707591624, 0.02513412467841992, null, 0.19885620799411374, 0.16328379010464208, 0.12634746856253393, 0.08835577113918644, 0.0496260411229465, 0.010481786561985834, -0.028750021986844336, -0.06774168263136568, -0.10616749942624687, -0.1437065028995733, null, -0.10117199475687647, -0.11177120233442579, -0.12230252092206728, -0.1327595538758857, -0.1431359496725026, -0.15342540576694405, -0.16362167242075848, -0.17371855649806275, -0.1837099252272038, -0.19358970992576102, null, -0.15878684344636876, -0.17726453055699612, -0.195520986508946, -0.21353342672771375, -0.23127937117734443, -0.2487366724161598, -0.26588354323738794, -0.28269858386021773, -0.29916080863733163, -0.3152496722455884, null, -0.21284084943597759, -0.2499138483476132, -0.28604650655864394, -0.32110286918156905, -0.35495103106264303, -0.38746363309604603, -0.418518341432827, -0.44799830778151456, -0.4757926090684438, -0.5017966648035064, null, -0.2680406899235311, -0.3429204935472434, -0.4133958458820274, -0.4785615655162449, -0.537580667658267, -0.5896951143214695, -0.6342355505209597, -0.6706299014308827, -0.698410720080902, -0.7172211912184646, null, -0.8154619839113875, -0.8364866198639261, -0.8546204016457668, -0.8698006598519846, -0.8819749323012298, -0.8911011453422937, -0.8971477592584536, -0.900093877267092, -0.8999293177378869, -0.8966546493799963, null, -1.120853391479255, -1.122856158301687, -1.1234507103204114, -1.1226363018860874, -1.1204139543779945, -1.1167864549230822, -1.1117583529005344, -1.1053359542362262, -1.0975273134942327, -1.088342223775308, null, -1.1099709636023025, -1.1068946193675602, -1.103597964841614, -1.10008165617267, -1.0963463932277016, -1.092392919453151, -1.0882220217269591, -1.0838345302019483, -1.0792313181405946, -1.0744133017412165, null, -1.2000426304107146, -1.1975034844302521, -1.1945362408479232, -1.1911419604287932, -1.1873218566000683, -1.1830772950173056, -1.178409793076202, -1.1733210193701384, -1.1678127930936713, -1.1618870833921848, null, -1.2467599398208074, -1.2460279620569084, -1.2452010944395053, -1.2442793999377686, -1.243262948742303, -1.2421518182598024, -1.240946093107155, -1.2396458651049995, -1.2382512332707323, -1.2367623038109667, null, -1.3032960808327378, -1.3021371637351205, -1.3008918647617633, -1.2995602665239803, -1.298142457358051, -1.2966385313193631, -1.295048588176171, -1.293372733402979, -1.2916110781735417, -1.2897637393534922, null, -1.2964265532630017, -1.295058470459986, -1.2936272683341745, -1.2921330166403404, -1.2905757882062034, -1.2889556589288802, -1.2872727077711854, -1.2855270167577852, -1.283718670971196, -1.281847758547641, null, -1.2872825306436928, -1.2861256937132237, -1.2849409971857322, -1.2837284667236926, -1.282488128592508, -1.2812200096599418, -1.2799241373955355, -1.278600539870012, -1.2772492457546702, -1.275870284320762, null, -1.1903382839568095, -1.191317791407211, -1.1922182685770177, -1.1930396557298897, -1.1937818983762045, -1.1944449472766703, -1.195028758445592, -1.1955332931537903, -1.1959585179311705, -1.196304404568942, null, -1.382940686914845, -1.3835144059078663, -1.3840206943605915, -1.3844595275972353, -1.3848308842296853, -1.3851347461585428, -1.3853710985740062, -1.3855399299565925, -1.3856412320776976, -1.3856749999999998, null, -1.4077761836906777, -1.4078981824977443, -1.4079896839154773, -1.4080506859618056, -1.4080811873153245, -1.4080811873153245, -1.4080506859618056, -1.4079896839154773, -1.4078981824977443, -1.4077761836906777, null, -0.7234501784555493, -0.7557226172899647, -0.7856260693300621, -0.8130667953104466, -0.8379587759483975, -0.860223981591149, -0.879792616817822, -0.8966033392292699, -0.9106034517399682, -0.9217490677691821, null, -1.1438091542938342, -1.1460516682042707, -1.1482069058430542, -1.1502747030804938, -1.1522549024458242, -1.1541473531391973, -1.1559519110431653, -1.157668438733658, -1.1592968054904451, -1.1608368873070944, null, -1.3507651643700271, -1.3536682530373778, -1.356481541331862, -1.3592048426240475, -1.361837976254108, -1.3643807675438078, -1.3668330478080908, -1.3691946543662687, -1.371465430552816, -1.3736452257277592, null, -1.3487530802804666, -1.3515630690198688, -1.3543071844820584, -1.3569852929227189, -1.3595972638146225, -1.3621429698539937, -1.3646222869667113, -1.3670350943143572, -1.369381274300105, -1.3716607125744524, null, -1.3399387705256602, -1.3419505661898083, -1.3439332929984156, -1.3458869080023594, -1.3478113688831264, -1.3497066339537307, -1.3515726621596142, -1.3534094130795384, -1.355216846926459, -1.3569949245483865, null, -0.6078851700892887, -0.6448581234449596, -0.6803187000646455, -0.7141837347540573, -0.746373804321077, -0.7768134138458564, -0.8054311737379966, -0.8321599671655578, -0.8569371074632234, -0.8797044851504611, null, -1.010936983009223, -1.0225531041005937, -1.0338092730229405, -1.0447015274564557, -1.0552260331840286, -1.0653790854409386, -1.075157110218983, -1.084556665524573, -1.0935744425903642, -1.102207267039982, null, -1.0875438932324983, -1.090897756848311, -1.0941984516464822, -1.097445816755804, -1.100639693904282, -1.1037799274268503, -1.1068663642729568, -1.1098988540140244, -1.112877248850781, -1.1158014036204644, null, -1.1393898934120479, -1.1418729280750142, -1.1443312278930258, -1.1467647396152663, -1.1491734105278708, -1.1515571884550668, -1.1539160217603066, -1.1562498593473813, -1.1585586506615329, -1.1608423456905452, null, -1.120419575197568, -1.1296788897194827, -1.1387775212851792, -1.147714175725994, -1.1564875819125222, -1.1650964919354208, -1.1735396812829062, -1.1818159490149256, -1.1899241179339797, -1.197863034752559, null, -1.2301587751866627, -1.2334510117764355, -1.2367165297893972, -1.2399552584890603, -1.2431671277192353, -1.246352067905555, -1.2495100100569778, -1.252640885767286, -1.2557446272165629, -1.258821167172667, null, -1.2692503082316335, -1.2788204369494354, -1.2882654775382536, -1.2975845061291686, -1.3067766111791548, -1.3158408935602441, -1.324776466647471, -1.3335824564056031, -1.3422580014746315, -1.3508022532540265, null, -1.4121939342830183, -1.4246134922667963, -1.4368768253272146, -1.4489825886516037, -1.4609294547065985, -1.4727161133837061, -1.484341272142978, -1.4958036561547556, -1.5071020084394589, -1.5182350900054418, null, -1.4202969597659185, -1.43571932512391, -1.4509473170675924, -1.465978873970618, -1.480811960800801, -1.4954445693956249, -1.5098747187341184, -1.5241004552050519, -1.538119852871426, -1.5519310137312123, null, -1.3632065610727284, -1.3761052051311202, -1.3888846150305239, -1.40154368348482, -1.4140813136350063, -1.4264964191442389, -1.438787924291956, -1.4509547640670861, -1.4629958842603286, -1.4749102415554904, null, -1.4584031413787495, -1.4644990109403373, -1.4705631570455913, -1.4765954483351376, -1.482595754139627, -1.4885639444825725, -1.4944998900831576, -1.5004034623590436, -1.5062745334291465, -1.5121129761164172, null, -1.4672411531699023, -1.474497222570328, -1.4817213519367178, -1.488913384782553, -1.4960731653165769, -1.5032005384461722, -1.5102953497807197, -1.5173574456349401, -1.524386673032228, -1.53138287970796, null, -0.5900887563425598, -0.5991867704312791, -0.6082134872863646, -0.6171678328187798, -0.6260487415509528, -0.6348551567435565, -0.6435860305212495, -0.6522403239973631, -0.6608170073975197, -0.6693150601821644, null, -0.5835706645893229, -0.5952289293290591, -0.6067940688054434, -0.6182642736194249, -0.6296377492247519, -0.640912716208733, -0.6520874105706336, -0.6631600839976522, -0.6741290041384587, -0.6849924548742163, null, -0.5522508462091885, -0.5631844056663087, -0.574049152894347, -0.5848437603929888, -0.595566909231886, -0.6062172892118101, -0.616793599024735, -0.6272945464128377, -0.6377188483263938, -0.6480652310805409, null, -0.7346466503247631, -0.7397849857920323, -0.7449072963002421, -0.7500134708917252, -0.7551033989583444, -0.7601769702438903, -0.7652340748464662, -0.7702746032208739, -0.7752984461809804, -0.7803054949020881, null, -0.515526642026744, -0.5237502514191305, -0.5319391159855523, -0.5400926924887058, -0.548210440032246, -0.5562918200966683, -0.5643362965750348, -0.5723433358085371, -0.5803124066218981, -0.5882429803586104, null, -0.4834958034331761, -0.49065713248083515, -0.49779454759207087, -0.5049077008993405, -0.5119962457175866, -0.5190598365611355, -0.5260981291605348, -0.5331107804793319, -0.5400974487307961, -0.547057793394573, null, -0.4661140919152209, -0.4709815634846516, -0.475838832819086, -0.48068579470208234, -0.48552234414047835, -0.4903483763666614, -0.4951637868408393, -0.49996847125330457, -0.5047623255266921, -0.5095452458182387, null, -0.11042917590249046, -0.11284596622475576, -0.11526031211786478, -0.11767216128311564, -0.12008146147589036, -0.12248816050678592, -0.1248922062427438, -0.12729354660818207, -0.12969212958611925, -0.13208790321930505, null, 0.504440753057181, 0.469459883645633, 0.4323943558199218, 0.39340876077761083, 0.3526762158639037, 0.31037759583603197, 0.26670072968049807, 0.2218395665497376, 0.17599331452190045, 0.12936555600812968, null, 0.3265564561292211, 0.29077664452102153, 0.254470648471097, 0.217704166688827, 0.18054373117069514, 0.1430565868051255, 0.105310569687286, 0.06737398436404624, 0.029315480231241153, -0.008796072693102569, null, 0.11434139510018615, 0.08604545875413908, 0.05771125402566117, 0.029351382441875656, 0.0009784569451438021, -0.027394903716502203, -0.055756080601487484, -0.08409246018692673, -0.11239143997843641, -0.1406404341150461, null, -0.10522215495903978, -0.12078531999579756, -0.13633801945478327, -0.15187890575513305, -0.16740663233954733, -0.18291985379096692, -0.19841722594914288, -0.21389740602710816, -0.22935905272752244, -0.24480082635888908, null, -0.2264677530581797, -0.23480876705678017, -0.24314469471144196, -0.2514753554522664, -0.2598005688234439, -0.2681201544871687, -0.27643393222753565, -0.2847417219544495, -0.2930433437075271, -0.30133861765999326, null, -0.07973061656558919, -0.08858349654482542, -0.09743445765988876, -0.1062833081844089, -0.11512985643773355, -0.12397391078908647, -0.13281527966170836, -0.14165377153701264, -0.15048919495873497, -0.15932135853707868, null, 0.2382825133417851, 0.21566833835291724, 0.19301034830170188, 0.17031314637307726, 0.1475813437182474, 0.12481955851787743, 0.10203241504387087, 0.07922454271990574, 0.056400575180921925, 0.03356514933175236, null, 0.0736184461472765, 0.06544263562153102, 0.057265407500704114, 0.049086938917002464, 0.04090740702950012, 0.03272698902030792, 0.024545862090726112, 0.016364203457416, 0.008182190348555681, 2.1529596890710257e-16, null, 0.3703927371605078, 0.3456467591975322, 0.3208276644513129, 0.2959407030574936, 0.2709911395079693, 0.24598425153725095, 0.22092532900603937, 0.19581967278222281, 0.17067259361955858, 0.1454894110342474, null, 0.4323958633640973, 0.41866513611363726, 0.4049066352301296, 0.391121273432406, 0.37730996522121707, 0.36347362681855544, 0.349613176106883, 0.3357295325682362, 0.3218236172232305, 0.3078963525699581, null, 0.3661044194518145, 0.35407107361869056, 0.34202047086095666, 0.32995319850799193, 0.31786984470162793, 0.3057709983674792, 0.29365724918624925, 0.28152918756498263, 0.2693874046082933, 0.25723249208955073, null, 0.2936589168737164, 0.2855750503485162, 0.2774849977982156, 0.26938893446665535, 0.26128703572787687, 0.25317947708232713, 0.2450664341530558, 0.23694808268191056, 0.22882459852573292, 0.22069615765254477, null, 0.6242151457517289, 0.6013581377765529, 0.5783117935816607, 0.5550833692552531, 0.5316801782130406, 0.5081095888956295, 0.4843790224485841, 0.4604959503859019, 0.4364678922376185, 0.41230241318230415, null, 0.9181175000000007, 0.8930260472719288, 0.8677142537293283, 0.8421883646785064, 0.8164546782506359, 0.7905195438477806, 0.7643893605762786, 0.738070575667858, 0.7115696828888777, 0.684893220938091, null, 0.788125691350966, 0.7700561831864746, 0.7519022296837525, 0.7336658216283759, 0.715348958847997, 0.6969536499930297, 0.6784819123163874, 0.6599357714522636, 0.6413172611939999, 0.6226284232710567, null, 0.8727010284175293, 0.8604063927930612, 0.8480698221748594, 0.8356919178299727, 0.8232732830399971, 0.8108145230716725, 0.7983162451473804, 0.7857790584155568, 0.7732035739209951, 0.760590404575068, null, 0.8723138426221616, 0.8631856689010441, 0.8540387971591888, 0.8448734255328769, 0.835689752559128, 0.8264879771713941, 0.8172682986952611, 0.808030916844122, 0.7987760317148535, 0.7895038437834854, null, 1.0003593676654048, 0.9926607826067597, 0.9849406948835463, 0.9771992717255586, 0.9694366808247488, 0.9616530903315996, 0.9538486688514753, 0.9460235854409788, 0.9381780096042799, 0.9303121112894518, null, 0.6520583893976534, 0.6401356221737046, 0.6279081850632301, 0.6153818976640586, 0.6025627218105707, 0.5894567587361882, 0.5760702461695184, 0.5624095553655317, 0.5484811880731904, 0.5342917734409675, null, 0.8632207303301167, 0.8477515165456969, 0.8320409976644602, 0.8160936455489813, 0.7999139994743562, 0.7835066648361352, 0.7668763118394389, 0.7500276741696239, 0.7329655476448809, 0.7156947888511463, null, 0.9344286659056978, 0.92843264269792, 0.9224165081126812, 0.916380392469348, 0.9103244265201093, 0.904248741447143, 0.898153468859778, 0.8920387407916393, 0.8859046896977895, 0.87975144845186, null, 1.0476992252320123, 1.0350213142289255, 1.0221738519929895, 1.009158943121502, 0.9959787196419055, 0.9826353406625274, 0.9691309920188925, 0.9554678859156477, 0.9416482605641741, 0.927674379815932, null, 1.4883371707649125, 1.4767611159091907, 1.465113085800079, 1.4533936481461314, 1.4416033741362055, 1.4297428384116244, 1.4178126190381646, 1.4058132974778883, 1.3937454585607993, 1.381609690456342, null, 1.5791098412207698, 1.5712663322010987, 1.5633887869693797, 1.5554773761661955, 1.5475322711657107, 1.5395536440719608, 1.5315416677151281, 1.5234965156477918, 1.5154183621411725, 1.5073073821813558, null, 1.1375800887719034, 1.132800561494444, 1.1279964958944049, 1.1231679960357457, 1.1183151665117115, 1.1134381124425676, 1.108536939473325, 1.103611753771447, 1.0986626620245532, 1.0936897714381082, null, 0.41084995385295026, 0.4273816481331519, 0.44008891570583797, 0.44885804552680053, 0.45361056699620117, 0.4543039521531061, 0.45093199623714664, 0.4435248732118465, 0.4321488657527667, 0.41690577211666746, null, 0.46852723009984937, 0.4649379589314494, 0.4610905823072417, 0.4569872360582079, 0.4526301981141958, 0.44802188723934977, 0.4431648616893598, 0.43806181779127196, 0.43271558844665087, 0.42712914155892395, null, 0.5899550325553833, 0.5849204896963716, 0.5796956985847282, 0.5742823586093391, 0.568682230485531, 0.5628971356823906, 0.5569289558303224, 0.5507796321090395, 0.5444511646161844, 0.5379456117167892, null, 0.8694593462045827, 0.8655860684487334, 0.8616706032490677, 0.8577131414398357, 0.8537138759021425, 0.8496730015545486, 0.8455907153435689, 0.8414672162340737, 0.8373027051995925, 0.8330973852125177, null, 0.8455989268356603, 0.8428544676246694, 0.8400917508001873, 0.837310836207203, 0.8345117840848983, 0.831694655065344, 0.8288595101721866, 0.8260064108193255, 0.823135418809583, 0.8202465963333669, null, 0.6668619759118474, 0.66455668778808, 0.6622073139452154, 0.6598140102372796, 0.6573769354325417, 0.6548962512029812, 0.6523721221135632, 0.6498047156113214, 0.6471942020142492, 0.6445407545000025, null, 1.3320456694231129, 1.3276372629099202, 1.32316414922955, 1.3186265463952522, 1.3140246755633884, 1.3093587610226498, 1.3046290301831287, 1.2998357135652334, 1.2949790447884537, 1.2900592605599737, null, 1.5042286623333756, 1.5005523501585656, 1.496843533552819, 1.4931022928552018, 1.4893287091071379, 1.4855228640506557, 1.4816848401266156, 1.4778147204729268, 1.4739125889227427, 1.4699785300026493, null, 0.6125665766704766, 0.6113576323082912, 0.6101188912376039, 0.6088504138329071, 0.6075522619179999, 0.6062244987629754, 0.6048671890811362, 0.6034803990258415, 0.6020641961872824, 0.6006186495891868, null, 0.7443110955003316, 0.7431774573792135, 0.7420277208125233, 0.7408619107054457, 0.739680052311344, 0.7384821712312144, 0.7372682934131302, 0.7360384451516808, 0.7347926530874016, 0.7335309442061967, null, 0.7413243706842332, 0.7495477745146271, 0.757491896540355, 0.7651537767783293, 0.7725305604088673, 0.7796194988393972, 0.7864179507285862, 0.7929233829705039, 0.7991333716384597, 0.8050456028881581, null, 0.8714706031768596, 0.8790359095562432, 0.8862896813515028, 0.8932293477907792, 0.8998524494226728, 0.9061566389878849, 0.912139682251098, 0.9177994587927997, 0.9231339627607694, 0.9281413035809621, null, 1.0014018174786528, 1.0105123386474393, 1.019055808436552, 1.027027432657789, 1.0344227380154374, 1.0412375746164717, 1.0474681182992769, 1.053110872779586, 1.058162671612427, 1.0626206799689832, null, 1.2086589450116239, 1.218653161844197, 1.2276393441480806, 1.2356100588140635, 1.242558712698293, 1.2484795580759347, 1.2533676973955226, 1.2572190873300706, 1.2600305421215976, 1.2617997362162914, null, 1.3790189874269936, 1.3853175047634139, 1.3904025251551615, 1.3942695942755656, 1.3969153246870556, 1.3983373988084564, 1.39853457094512, 1.3975066683801174, 1.3952545915255328, 1.39178031313373, null, 1.452284211955957, 1.4522660393255018, 1.451370482174684, 1.4495980815531184, 1.4469499082541908, 1.4434275621681396, 1.4390331713154838, 1.4337693905613835, 1.4276394000117059, 1.4206469030917683, null, 1.5432960568011111, 1.5419091492414614, 1.5404888413946132, 1.5390351640267694, 1.5375481486269724, 1.53602782740642, 1.5344742332977697, 1.5328873999544237, 1.5312673617498016, 1.5296141537765942, null, 1.5403394822552678, 1.5413397466910852, 1.5421416415037092, 1.5427450634896949, 1.543149934988947, 1.543356203894714, 1.5433638436602948, 1.5431728533024562, 1.5427832574015574, 1.542195106098388, null, 1.5872468141812475, 1.5875495946960765, 1.5875681329039706, 1.587302425485762, 1.58675252001495, 1.5859185149491832, 1.5848005596126302, 1.5833988541692452, 1.5817136495869286, 1.5797452475925933, null, 1.7169088070698224, 1.7158724232512323, 1.714647874685308, 1.7132352956575991, 1.7116348410733144, 1.7098466864403346, 1.7078710278499656, 1.7057080819554358, 1.7033580859481365, 1.7008212975316122, null, 1.7375338465211863, 1.7372374130803576, 1.736856309138892, 1.7363905532712576, 1.7358401681777385, 1.7352051806833277, 1.7344856217364197, 1.7336815264073024, 1.7327929338864483, 1.7318198874826025, null, 2.245455346157126, 2.2447735183060056, 2.244043064969886, 2.243264001971587, 2.242436346186894, 2.2415601155441927, 2.240635329024079, 2.239662006658949, 2.2386401695325655, 2.2375698397796016, null, 1.3680519066003116, 1.370699380750359, 1.3732280891350555, 1.375637812651664, 1.3779283425070221, 1.3800994802356352, 1.3821510377168706, 1.3840828371912595, 1.3858947112758975, 1.3875865029789487, null, 1.5772018268045571, 1.578268710521653, 1.5793014063436752, 1.5802998919007343, 1.5812641455639913, 1.5821941464461269, 1.5830898744017925, 1.5839513100280482, 1.5847784346647824, 1.585571230395115, null, 1.533498733599058, 1.5351561400286666, 1.5367802924523588, 1.538371155688323, 1.539928695275846, 1.5414528774760594, 1.542943669272671, 1.5444010383726794, 1.5458249532070742, 1.5472153829315187, null, 1.618874136189866, 1.621304727825565, 1.6237001993353006, 1.6260604988292215, 1.6283855751793603, 1.6306753780207406, 1.6329298577524678, 1.635148965538805, 1.6373326533102288, 1.639480873764472, null, 1.1625385738894682, 1.1648004233673883, 1.1670370413531101, 1.1692483793978115, 1.171434389600274, 1.173595024607923, 1.175730237617852, 1.1778399823778367, 1.179924213187337, 1.181982884898487, null, 0.7713211279865667, 0.7765241714445758, 0.7816420602765537, 0.7866742332483172, 0.7916201385253918, 0.7964792337335292, 0.8012509860181825, 0.805934872102941, 0.8105303783469129, 0.815037000801052, null, 0.8550749887090628, 0.8592030624596628, 0.8632892598651531, 0.8673333817700372, 0.8713352310695185, 0.8752946127191084, 0.8792113337441307, 0.8830852032491285, 0.8869160324271675, 0.8907036345690379, null, 1.2700845035760338, 1.2738221220269874, 1.2775321473965093, 1.2812144993193504, 1.2848690980297137, 1.288495864362983, 1.2920947197574368, 1.2956655862559503, 1.2992083865076844, 1.302723043769761, null, 0.1283477069646637, 0.14274374712255594, 0.1568139974932116, 0.17052634497909036, 0.1838494933387806, 0.19675303461566823, 0.20920751853923766, 0.22118451974060643, 0.23265670262888688, 0.24359788378030275, null, 0.3877480671443457, 0.39646989234867647, 0.40502379848821113, 0.4134061626802367, 0.4216134346961401, 0.4296421384650571, 0.43748887354611066, 0.4451503165686189, 0.4526232226396602, 0.4599044267184004, null, 0.4170644050972311, 0.4245773672527888, 0.43200230320546146, 0.4393376735681574, 0.44658195752311836, 0.4537336531372263, 0.46079127767339323, 0.46775336789797256, 0.47461848038412663, 0.48138519181108713, null, 0.5588402981314738, 0.5650414621367146, 0.5711806629781934, 0.5772572274233558, 0.5832704891084335, 0.5892197886115194, 0.5951044735248805, 0.6009238985265019, 0.6066774254508528, 0.61236442335887, null, 0.6622716428554893, 0.6665972505501856, 0.6708903692353185, 0.6751507896703399, 0.6793783042083686, 0.68357270680631, 0.6877337930348988, 0.6918613600886628, 0.695955206795807, 0.7000151336280184, null, 0.7204849672319131, 0.7237609354312972, 0.727021225778897, 0.7302657676514637, 0.7334944907668857, 0.7367073251857124, 0.7399042013126679, 0.7430850498981595, 0.7462498020397772, 0.7493983891837863, null, 0.5977026809650655, 0.6050560140780554, 0.6123601468332324, 0.6196144852922888, 0.6268184395659586, 0.6339714238619854, 0.6410728565327553, 0.6481221601225943, 0.6551187614147241, 0.6620620914778744, null, 0.688516815956613, 0.6974319918829657, 0.7062940556629189, 0.7151023324160048, 0.7238561513578458, 0.7325548458512381, 0.7411977534569171, 0.7497842159840069, 0.7583135795401417, 0.7667851945812642, null, 0.650513755645761, 0.6590374476345943, 0.6675174200426532, 0.6759531103209658, 0.6843439588581718, 0.6926894090176464, 0.700988907174427, 0.7092419027519397, 0.7174478482585236, 0.7256061993237506, null, 0.6189224999999999, 0.626391364748562, 0.6338297000657126, 0.6412371434174824, 0.6486133337755327, 0.6559579116347516, 0.663270519030776, 0.670550799557438, 0.6777983983841358, 0.6850129622731272, null, 0.6064387512643507, 0.6115662622294666, 0.6166805256638773, 0.6217814307842287, 0.6268688670965291, 0.631942724398544, 0.6370028927821826, 0.6420492626358785, 0.6470817246469633, 0.6521001698040367, null, 0.17798869942005646, 0.18495249273055975, 0.1918813471423153, 0.198773953743293, 0.20562901046894333, 0.2124452223481668, 0.2192213017479439, 0.22595596861657838, 0.2326479507255084, 0.2392959839096401, null, 0.20552183140091318, 0.2198060766821911, 0.23401767123031084, 0.24815191780132503, 0.2622041447164907, 0.2761697074063614, 0.29004398994591946, 0.30382240658024057, 0.3175004032401864, 0.33107345904762436, null, 0.18570612567828262, 0.2061061711838466, 0.22643253543606914, 0.24667795192766714, 0.26683518308951326, 0.28689702287800695, 0.3068562993511754, 0.3267058772325837, 0.34643866046213734, 0.36604759473286463, null, 0.34388644466677065, 0.3528126551251979, 0.3617154605078904, 0.37059427021575464, 0.37944849524153534, 0.388277548208889, 0.3970808434113498, 0.4058577968511842, 0.41460782627813275, 0.4233303512280356, null, 0.33154183464283954, 0.3398236486793246, 0.3480889001905928, 0.3563371863399459, 0.36456810511755355, 0.3727812553600467, 0.3809762367700695, 0.3891526499357894, 0.3973100963503639, 0.4054481784313634, null, 0.31634721441748936, 0.32207817956355356, 0.32780216796672534, 0.3335190556360052, 0.33922871873420707, 0.34493103358064126, 0.35062587665379286, 0.3563131245939984, 0.3619926542061171, 0.3676643424621998, null, 0.1628438247827753, 0.17363166489227283, 0.18440628227824657, 0.19516685641186685, 0.20591256783375214, 0.216642598216374, 0.2273561304263757, 0.2380523485868004, 0.2487304381392231, 0.2593895859057824, null, 0.14024632554761574, 0.15232568559003423, 0.16439494056916826, 0.17645328982828762, 0.18849993343413143, 0.20053407222997505, 0.21255490788864428, 0.22456164296547593, 0.2365534809512186, 0.24852962632487213, null, 0.0964170404054442, 0.10711350691068544, 0.11780475285471446, 0.12849025716128706, 0.13916949903399836, 0.14984195798166558, 0.16050711384369626, 0.17116444681544, 0.18181343747352294, 0.19245356680116393, null, 0.06476216414008773, 0.07195302369974209, 0.07914232463860642, 0.08632991122460255, 0.09351562776278809, 0.10069931859872885, 0.1078808281218708, 0.11506000076891064, 0.12223668102716567, 0.1294107134379425, null ] }, { "hoverinfo": "text", "marker": { "color": [ -1, 33, 58, 99, 72, 35, 33, 37, -1, -1, 100, 39, -1, -1, 55, -1, -1, 100, -1, -1, 99, -1, -1, 100, 56, 100, 46, -1, -1, -1, -1, 99, -1, -1, 100, -1, 40, -1, -1, 66, 100, -1, -1, 89, 83, 100, -1, -1, -1, 44, 73, -1, 44, 40, 32, -1, -1, -1, -1, -1, 33, 14, 2, 3, 4, 15, 32, 52, 76, 55, -1, 43, -1, 35, 68, 93, 75, -1, -1, -1, -1, -1, 38, 96, 81, -1, -1, -1, -1, 23, 99, -1, 100, -1, 100, -1, 100, -1, -1, 25, 86, 92, -1, 100, -1, -1, 84, 97, -1, -1, 95, -1, 100, -1, 65, -1, 77, 71, -1, -1, 100, -1, -1, 58, -1, 90, -1, 83, 99, -1, -1, 51, -1, 20, -1, 66, -1, -1, -1, -1, -1, 22, -1, -1, 9, 14, 92, 89, 61, -1, -1, 100, -1, -1, 94, 59, -1, -1, 100, -1, 60, 78, 42, -1, -1, -1, -1, 100, -1, 98, 52, -1, 63, 100, -1, -1, -1, 100, -1, -1, 23, 73, 100, -1, -1, 68, 100, -1, 65, -1, -1, 48, -1, -1, -1, 8, 6, 15, 100, 65, -1, -1, -1, 24, 100, 100, -1, -1, -1, -1, 29, 25, -1, -1, -1, 89, 28, 41, 35, 92, 57, 90, -1, -1, 66, 62, 94, -1, 61, 100, -1, -1, -1, -1, -1, 38, 100, -1, -1, 100, -1, -1, 100, -1, -1, 45, -1, -1, -1, 45, -1, 57, 100, -1, -1, -1, 29, 52, -1, 50, 87, 65, -1, 100, -1, -1, -1, 100, -1, 92, -1, 59, -1, 81, -1, 98, -1, -1, 73, -1, 64, -1, 92, 67, -1, 70, -1, 100, -1, -1, 78, -1, 100, -1, 49, -1, 37, -1, -1 ], "colorbar": { "dtick": 10, "thickness": 20, "ticklen": 4, "title": "confidence" }, "colorscale": [ [ 0, "rgb(10,10,150)" ], [ 0.001, "rgb(10,10,150)" ], [ 0.001, "rgb(214, 47, 38)" ], [ 0.1, "rgb(214, 47, 38)" ], [ 0.2, "rgb(244, 109, 67)" ], [ 0.3, "rgb(252, 172, 96)" ], [ 0.4, "rgb(254, 224, 139)" ], [ 0.5, "rgb(254, 254, 189)" ], [ 0.6, "rgb(217, 239, 139)" ], [ 0.7, "rgb(164, 216, 105)" ], [ 0.8, "rgb(102, 189, 99)" ], [ 0.9, "rgb(63, 170, 89)" ], [ 1, "rgb(25, 151, 79)" ] ], "size": [ 7, 9, 9, 9, 9, 9, 9, 9, 7, 7, 9, 9, 7, 7, 9, 7, 7, 9, 7, 7, 9, 7, 7, 9, 9, 9, 9, 7, 7, 7, 7, 9, 7, 7, 9, 7, 9, 7, 7, 9, 9, 7, 7, 9, 9, 9, 7, 7, 7, 9, 9, 7, 9, 9, 9, 7, 7, 7, 7, 7, 9, 9, 9, 9, 9, 9, 9, 9, 9, 9, 7, 9, 7, 9, 9, 9, 9, 7, 7, 7, 7, 7, 9, 9, 9, 7, 7, 7, 7, 9, 9, 7, 9, 7, 9, 7, 9, 7, 7, 9, 9, 9, 7, 9, 7, 7, 9, 9, 7, 7, 9, 7, 9, 7, 9, 7, 9, 9, 7, 7, 9, 7, 7, 9, 7, 9, 7, 9, 9, 7, 7, 9, 7, 9, 7, 9, 7, 7, 7, 7, 7, 9, 7, 7, 9, 9, 9, 9, 9, 7, 7, 9, 7, 7, 9, 9, 7, 7, 9, 7, 9, 9, 9, 7, 7, 7, 7, 9, 7, 9, 9, 7, 9, 9, 7, 7, 7, 9, 7, 7, 9, 9, 9, 7, 7, 9, 9, 7, 9, 7, 7, 9, 7, 7, 7, 9, 9, 9, 9, 9, 7, 7, 7, 9, 9, 9, 7, 7, 7, 7, 9, 9, 7, 7, 7, 9, 9, 9, 9, 9, 9, 9, 7, 7, 9, 9, 9, 7, 9, 9, 7, 7, 7, 7, 7, 9, 9, 7, 7, 9, 7, 7, 9, 7, 7, 9, 7, 7, 7, 9, 7, 9, 9, 7, 7, 7, 9, 9, 7, 9, 9, 9, 7, 9, 7, 7, 7, 9, 7, 9, 7, 9, 7, 9, 7, 9, 7, 7, 9, 7, 9, 7, 9, 9, 7, 9, 7, 9, 7, 7, 9, 7, 9, 7, 9, 7, 9, 7, 7 ] }, "mode": "markers", "opacity": 1, "text": [ "", "id: 1
branch-length: 0.21409500000000004
confidence: 33", "id: 2
branch-length: 0.22234
confidence: 58", "id: 3
branch-length: 0.68133
confidence: 99", "id: 4
branch-length: 0.0946
confidence: 72", "id: 5
branch-length: 0.24716
confidence: 35", "id: 6
branch-length: 0.18828
confidence: 33", "id: 7
branch-length: 0.10487
confidence: 37", "id: 8
name: 51_CHICK
branch-length: 0.28045", "id: 9
name: 145_XENLA
branch-length: 0.59876", "id: 10
branch-length: 0.38418
confidence: 100", "id: 11
branch-length: 0.0267
confidence: 39", "id: 12
name: 88_CANFA
branch-length: 0.08127", "id: 13
name: 115_MOUSE
branch-length: 0.14168", "id: 14
branch-length: 1e-05
confidence: 55", "id: 15
name: 74_BOVIN
branch-length: 0.09416", "id: 16
name: 9_HUMAN
branch-length: 0.06828", "id: 17
branch-length: 0.35342
confidence: 100", "id: 18
name: 159_BRARE
branch-length: 0.01275", "id: 19
name: 166_BRARE
branch-length: 0.02259", "id: 20
branch-length: 0.39739
confidence: 99", "id: 21
name: 52_CHICK
branch-length: 0.27747", "id: 22
name: 144_XENLA
branch-length: 0.34644", "id: 23
branch-length: 0.51997
confidence: 100", "id: 24
branch-length: 0.0983
confidence: 56", "id: 25
branch-length: 0.5126
confidence: 100", "id: 26
branch-length: 1e-05
confidence: 46", "id: 27
name: 90_CANFA
branch-length: 0.03744", "id: 28
name: 12_HUMAN
branch-length: 0.07368", "id: 29
name: 64_BOVIN
branch-length: 0.05675", "id: 30
name: 142_XENLA
branch-length: 0.26292", "id: 31
branch-length: 0.34592
confidence: 99", "id: 32
name: 155_BRARE
branch-length: 1e-05", "id: 33
name: 154_BRARE
branch-length: 1e-05", "id: 34
branch-length: 1.25362
confidence: 100", "id: 35
name: 125_MOUSE
branch-length: 0.04425", "id: 36
branch-length: 0.14928
confidence: 40", "id: 37
name: 95_CANFA
branch-length: 0.09977", "id: 38
name: 13_HUMAN
branch-length: 0.07433", "id: 39
branch-length: 0.57089
confidence: 66", "id: 40
branch-length: 0.53798
confidence: 100", "id: 41
name: 16_SPHGR
branch-length: 1e-05", "id: 42
name: 17_SPHGR
branch-length: 1e-05", "id: 43
branch-length: 0.69471
confidence: 89", "id: 44
branch-length: 0.15935
confidence: 83", "id: 45
branch-length: 0.24123
confidence: 100", "id: 46
name: 158_BRARE
branch-length: 1e-05", "id: 47
name: 169_BRARE
branch-length: 1e-05", "id: 48
name: 130_TETNG
branch-length: 0.37777", "id: 49
branch-length: 0.13835
confidence: 44", "id: 50
branch-length: 0.1765
confidence: 73", "id: 51
name: 122_MOUSE
branch-length: 0.10759", "id: 52
branch-length: 0.09256
confidence: 44", "id: 53
branch-length: 0.01016
confidence: 40", "id: 54
branch-length: 0.0243
confidence: 32", "id: 55
name: 11_HUMAN
branch-length: 0.02336", "id: 56
name: 68_BOVIN
branch-length: 0.24624", "id: 57
name: 92_CANFA
branch-length: 1e-05", "id: 58
name: 46_CHICK
branch-length: 1.06707", "id: 59
name: 147_XENLA
branch-length: 0.43513", "id: 60
branch-length: 0.21984499999999996
confidence: 33", "id: 61
branch-length: 0.13885
confidence: 14", "id: 62
branch-length: 0.07066
confidence: 2", "id: 63
branch-length: 0.0137
confidence: 3", "id: 64
branch-length: 0.10632
confidence: 4", "id: 65
branch-length: 0.09782
confidence: 15", "id: 66
branch-length: 0.08093
confidence: 32", "id: 67
branch-length: 0.17228
confidence: 52", "id: 68
branch-length: 0.22305
confidence: 76", "id: 69
branch-length: 0.00625
confidence: 55", "id: 70
name: 140_TETNG
branch-length: 0.92309", "id: 71
branch-length: 0.07662
confidence: 43", "id: 72
name: 152_XENLA
branch-length: 0.19286", "id: 73
branch-length: 0.0429
confidence: 35", "id: 74
branch-length: 0.06125
confidence: 68", "id: 75
branch-length: 1e-05
confidence: 93", "id: 76
branch-length: 1e-05
confidence: 75", "id: 77
name: 0_HUMAN
branch-length: 1e-05", "id: 78
name: 72_BOVIN
branch-length: 0.0105", "id: 79
name: 123_MOUSE
branch-length: 0.01053", "id: 80
name: 97_CANFA
branch-length: 1e-05", "id: 81
name: 41_CHICK
branch-length: 0.03818", "id: 82
branch-length: 0.07344
confidence: 38", "id: 83
branch-length: 0.18878
confidence: 96", "id: 84
branch-length: 0.02241
confidence: 81", "id: 85
name: 132_TETNG
branch-length: 1e-05", "id: 86
name: 135_TETNG
branch-length: 1e-05", "id: 87
name: 102_FUGRU
branch-length: 0.00904", "id: 88
name: 167_BRARE
branch-length: 0.26949", "id: 89
branch-length: 0.0375
confidence: 23", "id: 90
branch-length: 0.23552
confidence: 99", "id: 91
name: 151_XENLA
branch-length: 0.12315", "id: 92
branch-length: 0.22499
confidence: 100", "id: 93
name: 126_MOUSE
branch-length: 1e-05", "id: 94
branch-length: 0.01047
confidence: 100", "id: 95
name: 96_CANFA
branch-length: 1e-05", "id: 96
branch-length: 1e-05
confidence: 100", "id: 97
name: 8_HUMAN
branch-length: 1e-05", "id: 98
name: 79_BOVIN
branch-length: 1e-05", "id: 99
branch-length: 0.04974
confidence: 25", "id: 100
branch-length: 0.20281
confidence: 86", "id: 101
branch-length: 1e-05
confidence: 92", "id: 102
name: 164_BRARE
branch-length: 0.02901", "id: 103
branch-length: 0.06877
confidence: 100", "id: 104
name: 136_TETNG
branch-length: 0.01045", "id: 105
name: 100_FUGRU
branch-length: 1e-05", "id: 106
branch-length: 0.17649
confidence: 84", "id: 107
branch-length: 0.05352
confidence: 97", "id: 108
name: 129_TETNG
branch-length: 0.00069", "id: 109
name: 104_FUGRU
branch-length: 0.03078", "id: 110
branch-length: 0.23291
confidence: 95", "id: 111
name: 128_TETNG
branch-length: 0.36032", "id: 112
branch-length: 0.24906
confidence: 100", "id: 113
name: 103_FUGRU
branch-length: 0.24206", "id: 114
branch-length: 0.09945
confidence: 65", "id: 115
name: 106_FUGRU
branch-length: 0.04182", "id: 116
branch-length: 1e-05
confidence: 77", "id: 117
branch-length: 0.0141
confidence: 71", "id: 118
name: 112_FUGRU
branch-length: 0.03123", "id: 119
name: 113_FUGRU
branch-length: 0.09693", "id: 120
branch-length: 0.195
confidence: 100", "id: 121
name: 108_FUGRU
branch-length: 0.01027", "id: 122
name: 111_FUGRU
branch-length: 0.01081", "id: 123
branch-length: 0.03668
confidence: 58", "id: 124
name: 149_XENLA
branch-length: 0.32167", "id: 125
branch-length: 0.07846
confidence: 90", "id: 126
name: 49_CHICK
branch-length: 0.05537", "id: 127
branch-length: 0.03275
confidence: 83", "id: 128
branch-length: 0.192
confidence: 99", "id: 129
name: 63_BOVIN
branch-length: 0.1324", "id: 130
name: 80_BOVIN
branch-length: 0.13424", "id: 131
branch-length: 1e-05
confidence: 51", "id: 132
name: 57_BOVIN
branch-length: 0.01041", "id: 133
branch-length: 1e-05
confidence: 20", "id: 134
name: 117_MOUSE
branch-length: 1e-05", "id: 135
branch-length: 0.01043
confidence: 66", "id: 136
name: 87_CANFA
branch-length: 1e-05", "id: 137
name: 1_HUMAN
branch-length: 1e-05", "id: 138
name: 25_BRAFL
branch-length: 0.4534", "id: 139
name: 15_SPHGR
branch-length: 0.68488", "id: 140
name: 21_SPHGR
branch-length: 1.05022", "id: 141
branch-length: 0.08808
confidence: 22", "id: 142
name: 33_NEMVE
branch-length: 0.482", "id: 143
name: 30_NEMVE
branch-length: 0.47217", "id: 144
branch-length: 0.28685
confidence: 9", "id: 145
branch-length: 0.17977
confidence: 14", "id: 146
branch-length: 0.4495
confidence: 92", "id: 147
branch-length: 0.33029
confidence: 89", "id: 148
branch-length: 0.13116
confidence: 61", "id: 149
name: 165_BRARE
branch-length: 0.30255", "id: 150
name: 162_BRARE
branch-length: 0.62996", "id: 151
branch-length: 0.22822
confidence: 100", "id: 152
name: 137_TETNG
branch-length: 0.24501", "id: 153
name: 107_FUGRU
branch-length: 0.04204", "id: 154
branch-length: 0.25726
confidence: 94", "id: 155
branch-length: 0.15529
confidence: 59", "id: 156
name: 42_CHICK
branch-length: 0.29479", "id: 157
name: 143_XENLA
branch-length: 0.60398", "id: 158
branch-length: 0.13595
confidence: 100", "id: 159
name: 58_BOVIN
branch-length: 0.05604", "id: 160
branch-length: 1e-05
confidence: 60", "id: 161
branch-length: 0.02217
confidence: 78", "id: 162
branch-length: 1e-05
confidence: 42", "id: 163
name: 85_CANFA
branch-length: 0.01109", "id: 164
name: 2_HUMAN
branch-length: 0.01103", "id: 165
name: 124_MOUSE
branch-length: 0.04504", "id: 166
name: 73_BOVIN
branch-length: 1e-05", "id: 167
branch-length: 0.53052
confidence: 100", "id: 168
name: 45_CHICK
branch-length: 0.17601", "id: 169
branch-length: 0.40974
confidence: 98", "id: 170
branch-length: 0.05702
confidence: 52", "id: 171
name: 91_CANFA
branch-length: 0.10905", "id: 172
branch-length: 0.06948
confidence: 63", "id: 173
branch-length: 0.18193
confidence: 100", "id: 174
name: 118_MOUSE
branch-length: 0.18633", "id: 175
name: 127_MOUSE
branch-length: 1e-05", "id: 176
name: 3_HUMAN
branch-length: 0.04341", "id: 177
branch-length: 0.09486
confidence: 100", "id: 178
name: 76_BOVIN
branch-length: 1e-05", "id: 179
name: 71_BOVIN
branch-length: 1e-05", "id: 180
branch-length: 0.13006
confidence: 23", "id: 181
branch-length: 0.40777
confidence: 73", "id: 182
branch-length: 0.33571
confidence: 100", "id: 183
name: 157_BRARE
branch-length: 0.2958", "id: 184
name: 109_FUGRU
branch-length: 0.19527", "id: 185
branch-length: 0.1832
confidence: 68", "id: 186
branch-length: 0.78705
confidence: 100", "id: 187
name: 55_BOVIN
branch-length: 0.43001", "id: 188
branch-length: 0.08251
confidence: 65", "id: 189
name: 119_MOUSE
branch-length: 0.64738", "id: 190
name: 10_HUMAN
branch-length: 0.18995", "id: 191
branch-length: 0.09353
confidence: 48", "id: 192
name: 171_CHICK
branch-length: 0.56823", "id: 193
name: 141_XENLA
branch-length: 0.57176", "id: 194
name: 40_CAEEL
branch-length: 1.20795", "id: 195
branch-length: 0.09583
confidence: 8", "id: 196
branch-length: 0.03647
confidence: 6", "id: 197
branch-length: 0.15942
confidence: 15", "id: 198
branch-length: 0.37935
confidence: 100", "id: 199
branch-length: 1e-05
confidence: 65", "id: 200
name: 23_BRAFL
branch-length: 1e-05", "id: 201
name: 24_BRAFL
branch-length: 0.08958", "id: 202
name: 26_BRAFL
branch-length: 1e-05", "id: 203
branch-length: 0.07297
confidence: 24", "id: 204
branch-length: 0.74877
confidence: 100", "id: 205
branch-length: 0.22523
confidence: 100", "id: 206
name: 168_BRARE
branch-length: 0.13915", "id: 207
name: 131_TETNG
branch-length: 0.07883", "id: 208
name: 146_XENLA
branch-length: 0.27947", "id: 209
name: 14_SPHGR
branch-length: 0.61862", "id: 210
branch-length: 0.145
confidence: 29", "id: 211
branch-length: 0.14662
confidence: 25", "id: 212
name: 35_NEMVE
branch-length: 0.49481", "id: 213
name: 38_NEMVE
branch-length: 0.35293", "id: 214
name: 34_NEMVE
branch-length: 0.32221", "id: 215
branch-length: 0.40409
confidence: 89", "id: 216
branch-length: 0.10452
confidence: 28", "id: 217
branch-length: 0.1139
confidence: 41", "id: 218
branch-length: 0.18551
confidence: 35", "id: 219
branch-length: 0.13606
confidence: 92", "id: 220
branch-length: 0.05378
confidence: 57", "id: 221
branch-length: 0.11874
confidence: 90", "id: 222
name: 110_FUGRU
branch-length: 0.56162", "id: 223
name: 134_TETNG
branch-length: 0.03296", "id: 224
branch-length: 0.091
confidence: 66", "id: 225
branch-length: 0.04421
confidence: 62", "id: 226
branch-length: 0.13167
confidence: 94", "id: 227
name: 7_HUMAN
branch-length: 1e-05", "id: 228
branch-length: 0.01865
confidence: 61", "id: 229
branch-length: 0.51198
confidence: 100", "id: 230
name: 89_CANFA
branch-length: 0.01988", "id: 231
name: 62_BOVIN
branch-length: 1e-05", "id: 232
name: 114_MOUSE
branch-length: 0.01315", "id: 233
name: 48_CHICK
branch-length: 1e-05", "id: 234
name: 150_XENLA
branch-length: 0.0853", "id: 235
branch-length: 1e-05
confidence: 38", "id: 236
branch-length: 0.19569
confidence: 100", "id: 237
name: 101_FUGRU
branch-length: 0.02185", "id: 238
name: 133_TETNG
branch-length: 0.00907", "id: 239
branch-length: 0.1765
confidence: 100", "id: 240
name: 160_BRARE
branch-length: 1e-05", "id: 241
name: 161_BRARE
branch-length: 1e-05", "id: 242
branch-length: 0.43964
confidence: 100", "id: 243
name: 98_DROME
branch-length: 0.38195", "id: 244
name: 99_DROME
branch-length: 0.30802", "id: 245
branch-length: 0.18404
confidence: 45", "id: 246
name: 22_BRAFL
branch-length: 0.39195", "id: 247
name: 18_SPHGR
branch-length: 0.4734", "id: 248
name: 20_SPHGR
branch-length: 0.64378", "id: 249
branch-length: 0.06108
confidence: 45", "id: 250
name: 39_NEMVE
branch-length: 0.56478", "id: 251
branch-length: 0.12162
confidence: 57", "id: 252
branch-length: 0.46294
confidence: 100", "id: 253
name: 37_NEMVE
branch-length: 1e-05", "id: 254
name: 29_NEMVE
branch-length: 1e-05", "id: 255
name: 31_NEMVE
branch-length: 0.56073", "id: 256
branch-length: 0.11059
confidence: 29", "id: 257
branch-length: 0.24695
confidence: 52", "id: 258
name: 172_XENLA
branch-length: 0.53649", "id: 259
branch-length: 0.09295
confidence: 50", "id: 260
branch-length: 0.14603
confidence: 87", "id: 261
branch-length: 0.09214
confidence: 65", "id: 262
name: 19_SPHGR
branch-length: 0.37571", "id: 263
branch-length: 0.09991
confidence: 100", "id: 264
name: 28_BRAFL
branch-length: 1e-05", "id: 265
name: 27_BRAFL
branch-length: 1e-05", "id: 266
name: 36_NEMVE
branch-length: 0.36151", "id: 267
branch-length: 0.34289
confidence: 100", "id: 268
name: 50_CHICK
branch-length: 0.05827", "id: 269
branch-length: 0.22124
confidence: 92", "id: 270
name: 170_MOUSE
branch-length: 0.17237", "id: 271
branch-length: 1e-05
confidence: 59", "id: 272
name: 67_BOVIN
branch-length: 0.05006", "id: 273
branch-length: 0.00337
confidence: 81", "id: 274
name: 84_CANFA
branch-length: 0.01072", "id: 275
branch-length: 0.02097
confidence: 98", "id: 276
name: 6_HUMAN
branch-length: 0.02091", "id: 277
name: 5_HUMAN
branch-length: 0.01043", "id: 278
branch-length: 0.20775
confidence: 73", "id: 279
name: 32_NEMVE
branch-length: 0.30744", "id: 280
branch-length: 0.27579
confidence: 64", "id: 281
name: 53_CIOIN
branch-length: 0.40206", "id: 282
branch-length: 0.28261
confidence: 92", "id: 283
branch-length: 0.05338
confidence: 67", "id: 284
name: 156_BRAREb
branch-length: 0.64914", "id: 285
branch-length: 0.0829
confidence: 70", "id: 286
name: 156_BRAREa
branch-length: 0.18704", "id: 287
branch-length: 0.03919
confidence: 100", "id: 288
name: 138_TETNG
branch-length: 0.03397", "id: 289
name: 173_FUGRU
branch-length: 1e-05", "id: 290
branch-length: 0.15101
confidence: 78", "id: 291
name: 153_XENLA
branch-length: 0.15191", "id: 292
branch-length: 0.24267
confidence: 100", "id: 293
name: 116_MOUSE
branch-length: 1e-05", "id: 294
branch-length: 0.04527
confidence: 49", "id: 295
name: 4_HUMAN
branch-length: 1e-05", "id: 296
branch-length: 0.011
confidence: 37", "id: 297
name: 94_CANFA
branch-length: 1e-05", "id: 298
name: 82_BOVIN
branch-length: 1e-05" ], "type": "scatter", "uid": "5615437b-c555-11e8-bb2c-8af2f04e441a", "x": [ 0, 0.1578079409818431, 0.3704706342339276, 1.024082831887035, 1.1693956546285882, 1.436458094721308, 1.6420259159356294, 1.7522906094092747, 2.033125, 2.349372391993509, 2.0101865414957976, 2.0474073081662336, 2.132449876615273, 2.1830144647578313, 1.9960027820444421, 2.0963804041976397, 2.0543789521311937, 1.7461607596629802, 1.768337434356736, 1.7571934439025234, 1.5087943689945196, 1.7822506953214303, 1.8188241128121674, 1.3896348769327327, 1.5168991612173741, 2.0035484555183105, 2.0346348273924524, 2.088442567534885, 2.0801338135979948, 2.0202242755729225, 1.7098346646691456, 1.628876734444117, 1.6522367129531994, 1.6048186961467799, 1.2908572971741192, 1.3591634815074902, 1.3668922875694631, 1.4678928973895988, 1.395001748394395, 0.47111541775805055, 0.9056318619949466, 0.9256371079156701, 0.8852430639476099, 0.7523922838101064, 0.9772394001880166, 1.1679286425628, 1.1985387665646143, 1.1368186466889996, 1.1510236840094772, 0.6716347014154497, 0.8604087058329355, 1.0192149006673739, 0.7945387885848596, 0.8613402854883508, 0.9257209987752617, 0.9724624999999986, 1.0043354614130118, 0.807820405404123, 1.144788857607141, 0.7156794132599676, 0.023544836327340873, -0.2424644452940123, -0.42829964763304745, -0.41750117894923894, -0.4941569200964988, -0.5300346628176277, -0.4598423282231091, -0.15524120668112146, 0.10243183802607282, 0.2802299879655742, 0.6343485409679197, 0.22449146514162482, 0.37626857920757023, 0.12732657829057095, 0.18464754192340235, 0.2320668959177083, 0.27246723125821964, 0.2992549570343645, 0.24752977966116882, 0.19297787197637362, 0.13698298318531138, 0.08083682879463498, -0.0814071613207816, -0.04352510358558665, -2.586610182266101e-16, 0.029488916725654672, -0.02948891672565519, -0.08757487944532605, -0.15327897060873785, -0.39767345342423505, -0.2168595634497718, -0.1894076027583099, -0.31219631098145506, -0.26203871484954194, -0.364646270359266, -0.3217223991445524, -0.40721545355608085, -0.3788824798639511, -0.43537558845983554, -0.6285519390529037, -0.5411493731634495, -0.44980623227984645, -0.4250748974077709, -0.5121770167435561, -0.49202272738443864, -0.5361604440068602, -0.7218397081072679, -0.6843142326828929, -0.6584154767907675, -0.7256224999999994, -0.9164951319452446, -1.050314287847954, -1.125548137515659, -1.1933478021889554, -1.2575871677422763, -1.2032640894123765, -1.3337544675138087, -1.2823215998154824, -1.2708353954819112, -1.3780109163884642, -1.5313828797079598, -1.5068264549799064, -1.5703332826617942, -0.8073166797242599, -1.0189115599319862, -0.9014124190425679, -0.9076384960692079, -0.9635130469690216, -1.0901043153473118, -1.1811122256827888, -1.2175434466390054, -0.9922076790068072, -0.9802089507522339, -1.011786913574722, -0.9951031951240102, -1.0369182297202713, -1.0264811986755662, -1.0469185267311325, -1.0985541624891162, -1.2579801533840924, -1.5313234816548074, -0.517101830577536, -0.9813055009500559, -0.981380378554231, -0.6347577190586658, -0.8812378001519606, -1.3454101601595518, -1.6665849839918145, -1.7875409102391475, -2.079933990299303, -2.417669433912731, -1.9002279205265027, -2.141458172062889, -1.944318005443131, -1.5969370604728959, -1.7576394360658651, -2.052815, -2.359933120307654, -1.719362122069589, -1.788430646816567, -1.6987842550427208, -1.7330355992267592, -1.7419849193062023, -1.7579925267147087, -1.7470913080654134, -1.7664416429031833, -1.6840803851701567, -1.3283734483587595, -1.5341092813926256, -1.6510989106147809, -1.7566306268753997, -1.8909295280083596, -1.784589534490498, -1.977087636001552, -2.1673043397230844, -1.959258104369645, -1.7969276692454965, -1.6723773271211102, -1.6922402113661053, -1.651798199617255, -0.6007450103151444, -0.9724988042889932, -1.3054178494742603, -1.5705104808147246, -1.4441074702141967, -1.0425334341218453, -1.6989000495516051, -2.0801536253126898, -1.714282767687126, -2.236295868530027, -1.8200487756712718, -1.0478807506069292, -1.4685898534208517, -1.4068638281346584, -1.3094059211016047, 0.0073299211724926205, -0.1955873122814473, -0.3207735566410482, -0.5788137895938991, -0.6052865581794815, -0.6226070994985508, -0.638831085555407, -0.5517810377994962, -0.30457099185284214, -0.6683443841440724, -0.8177214601151402, -0.9182675000000005, -0.8229133670204247, -0.7458056515876704, -0.5200478545966545, -0.19018844867090978, -0.2573759707373163, -0.44527464755006957, -0.3509027028774996, -0.25768031671265035, 0.36724808752319793, 0.33487246529977244, 0.2876835649917768, 0.20586668687905826, 0.04804824735983767, -0.14330460023805075, -0.32665525523605216, -0.4870141764741501, -0.30057555600724206, 0.018182155571879695, -0.06232868720001843, -0.1707569695429975, -0.2511568989316397, -0.09095544339395575, -0.18826636132416005, -0.23725609271333786, -0.14127270384159937, -0.03667153847305001, 0.033248290518917076, 0.10226597729959999, 0.2332452706883415, 0.19981940093773812, 0.16893419855233482, 0.23422587592125677, 0.32748482288241526, 0.29514899313683973, 0.3596811642830469, 0.49198558928192543, 0.5604652103379968, 0.6211875071774913, 0.4642326702768304, 0.5761983085241437, 0.6721360968115112, 0.6841911303052887, 0.4640115329845541, 0.6877513817345567, 0.567140796746673, 0.7792447189845781, 0.7521324999999999, 0.8060254937490804, 0.9143088175410056, 0.2700963584799674, 0.39012208559250416, 0.673447839067328, 0.49668547261481644, 0.5681188501900846, 0.6008051362058643, 0.8185894489951135, 0.6903075698250786, 0.6747680317174316, 0.7055580041571906, 0.858633922023995, 0.7932332897028126, 0.8111164171555786, 0.9968001264317192, 1.1025273850369977, 1.0246294156431035, 1.039210644869423, 1.0520354205503246, 1.0399563089072053, 1.090165768664908, 1.0946310278339042, 1.1122478721122735, 0.49592793271006025, 0.7574362572524534, 0.7681716679430264, 1.1109032505844199, 1.0610546506958753, 1.084004722303817, 1.6727655246439825, 1.1764495026162196, 1.3409247299820506, 1.225195758907795, 1.2502831967643182, 1.232100738861092, 1.2295748115005625, 1.3689224579649648, 1.4775155763352414, 1.4694052441452468, 1.5287202413167904, 1.52343676902994, 1.5434832664498168, 1.5411210490080245, 1.5451884172752388 ], "y": [ 0, -0.14468352631889764, -0.23070981425875983, -0.44794301943353315, -0.31991045022126985, -0.2584596056149396, -0.1378847686322067, -0.03670525576906236, -4.979720047032925e-16, -0.09846787782672123, -0.2968385227933938, -0.21519117940216909, -0.17906681922820594, -0.2757788604717193, -0.38075789433161966, -0.35457620467417544, -0.4366717264322707, -0.4875368441853432, -0.4540318835474406, -0.5305279794044703, -0.561115596036529, -0.6206453573912224, -0.720123409339005, -0.8666549711604663, -0.8442952421534938, -1.0208589273818363, -0.9574264750813437, -0.9298345386859426, -1.0325873925006368, -1.1106276939689832, -1.0355126805214656, -1.1320988221050623, -1.0977434475297985, -1.1659690324887493, -1.0908589924263026, -1.0772597010755756, -1.2307553438470704, -1.267051160300234, -1.3099938374670246, -0.6278946674209438, -0.9643999801765685, -0.9452294933372076, -0.9831620254859561, -1.2741283861087205, -1.315853968624621, -1.4735592154733435, -1.4487844926926756, -1.4977032569121267, -1.6561060422189908, -1.4720653687522098, -1.5748297101438913, -1.6060256985747752, -1.7116872945894945, -1.6904754931142438, -1.683880245638487, -1.68435445845545, -1.9211165500753231, -1.716705745967467, -2.7233450758439584, -1.9244039487750144, 0.21858056800026554, 0.2643351959033585, 0.03008534298304405, -0.1482919370734484, -0.24004547266245715, -0.37138204619610216, -0.5645449927147971, -0.8869212658253206, -1.1187756055543936, -1.0943968845303855, -1.9523240613681097, -1.1852525417410276, -1.3476426160247814, -1.2427192132922926, -1.2974012528461059, -1.289773581309572, -1.2818575400236485, -1.2758800201097908, -1.2975965467763442, -1.3068435909291019, -1.3033060260516915, -1.2848646003121988, -1.1941233249169416, -1.3849912530347848, -1.4080849999999998, -1.4077861814975126, -1.4077861814975126, -1.3919628485398365, -1.4583519895396053, -0.8494242835395293, -1.153212105540596, -1.2826657751114865, -1.3631206753749172, -1.3736550486002665, -1.3608784077712737, -1.3716704483634812, -1.348762653475442, -1.3570045561740545, -1.3399482810908234, -0.7618169766668595, -1.0603492174514042, -1.1022165257458303, -1.1429919541356242, -1.15036841435458, -1.170475815624645, -1.1393989416825725, -1.160812676026849, -1.2447629682685066, -1.2594326476423365, -1.2568150371151479, -1.3113247859114339, -1.6550304913709126, -1.4668428911645686, -1.717002467568346, -1.4881534493307333, -1.5852418949029843, -1.4203042494521927, -1.4855838718401801, -1.5361761046883051, -1.5304361693122732, -1.4996409124728345, -1.5387205141277887, -1.4746411073849917, -0.6304613265411263, -0.8795008658676613, -0.6352876569089203, -0.7193854074682263, -0.6009012768712277, -0.7576422360759517, -0.8581282623056116, -0.8089339318951896, -0.5522557095629927, -0.5936356415261848, -0.5155311819317414, -0.547062610931314, -0.4879366814441998, -0.5095496921700305, -0.4661181592816517, -0.43494836211076404, -0.43807503845429874, -0.46233381723339106, -0.12128513939622301, -0.251956428832765, -0.20859883895591178, 0.3317110792850304, 0.1618367702604478, -0.013208957735151293, -0.17516514024771937, -0.26396107638513494, -0.35179450197895, -0.30542267687434854, -0.11955220732601968, -0.17982326693192932, -0.08149106904836473, 0.13620391005102053, 0.03681729771543888, 2.513973318991674e-16, 0.0989105034866386, 0.25849453073007184, 0.15017871737459038, 0.37039486746437056, 0.3118223212628433, 0.25723395291983636, 0.22208610321277292, 0.2954983761499951, 0.3754687620062464, 0.43239835026296897, 0.5199153457251076, 0.4631748997625006, 0.8035118932484347, 0.7061609843005637, 0.6584913310978993, 0.8170488807972186, 0.831091115218299, 0.8580964916852214, 0.8723179099885924, 0.892002641545947, 0.9655475000000007, 0.9303169288261928, 1.0003645479354986, 0.5960452019825822, 0.7917385028413602, 0.9072890406584869, 1.0434446687180412, 1.0492054921208491, 0.9893272885972124, 1.4356818529390674, 1.6487094474538184, 1.543547137095582, 1.9303188127924704, 1.7091395639919245, 1.115879660954737, 1.4996745821858561, 1.5624805741868584, 1.582799861008668, 0.4544658929783455, 0.45035729515521294, 0.5658126877199311, 0.8516986275678444, 0.8331054753824616, 0.8202545616325472, 0.9191574729898575, 0.8694677894838377, 0.6561420342782315, 1.3116997096165266, 1.4874298141062532, 1.590485964939254, 1.574088090484172, 1.5849176857757912, 1.2371449587475256, 0.6068920777347095, 0.7390831129934062, 1.1973074454266797, 1.0799674717963803, 0.9229071873183501, 0.7761111778833967, 0.9030445505117963, 1.0379029615810054, 1.2456479375242588, 1.3977794217796484, 1.4452978861728167, 1.5367921492029006, 2.076395537208218, 1.5756722445851288, 1.5432778970243046, 1.5863710217905906, 1.7107642144893878, 1.7008311902549418, 1.7355332478929952, 2.2420043015611637, 2.257340935059523, 2.2454653264244104, 1.7506809625088804, 1.5872568119880823, 1.6254711621901994, 1.3790288473873644, 1.5817334288791787, 1.6073015338089118, 1.5861745268645313, 1.5406949581298284, 1.547225205804026, 1.5335084693880867, 1.629534888906622, 2.007360816152837, 1.911818564339099, 1.1725178819415265, 1.549350560679834, 1.5989485898514644, 1.4539801630134337, 0.7940605709152948, 1.3155470582792572, 0.8733202424600892, 1.286685965167743, 1.302731704023799, 1.2700929468552888, 1.3155179847466048, 0.19035557874898465, 0.4256503219286399, 0.8872347624392014, 0.45016947199737606, 0.5862531750734455, 0.6814796573146206, 0.9895046640713101, 0.7351028984211625, 0.7494058206320411, 0.7204921119587095, 0.806310922395754, 0.6304013394118492, 0.7001369100723779, 0.7282124306620342, 0.8738524374678365, 0.6885223934077028, 0.7550307290535119, 0.6522895966765848, 0.6909453196810159, 0.6294074999999999, 0.6629321145700289, 0.6114634420852315, 0.2090420526662658, 0.3759946233982542, 0.26919804827418164, 0.49460599376268055, 0.27687847598116694, 0.38386620487876333, 0.6622947233577674, 0.36867692634480026, 0.46695939603734804, 0.3420808024127518, 0.37748275260440356, 0.31634970131636103, 0.21127959425452383, 0.29097345085790827, 0.1945186158488152, 0.24853129401233928, 0.14450660889154487, 0.19245482013349957, 0.09710773612026664, 0.12941155021637582, 0.06476258289662502 ] } ], "_js2py_layoutDelta": {}, "_js2py_pointsCallback": {}, "_js2py_relayout": {}, "_js2py_restyle": {}, "_js2py_traceDeltas": {}, "_js2py_update": {}, "_layout": { "autosize": false, "font": { "family": "Balto", "size": 14 }, "height": 750, "hovermode": "closest", "margin": { "t": 75 }, "plot_bgcolor": "rgb(245,245,245)", "showlegend": false, "title": "Bcl-2 gene family tree", "width": 700, "xaxis": { "visible": false }, "yaxis": { "visible": false } }, "_py2js_addTraces": {}, "_py2js_animate": {}, "_py2js_deleteTraces": {}, "_py2js_moveTraces": {}, "_py2js_relayout": {}, "_py2js_removeLayoutProps": {}, "_py2js_removeTraceProps": {}, "_py2js_restyle": {}, "_py2js_update": {}, "_view_count": 0 } }, "cb0c6cddd93141a780c2f624f05c8713": { "model_module": "plotlywidget", "model_module_version": "^0.4.0", "model_name": "FigureModel", "state": { "_data": [ { "hoverinfo": "none", "line": { "color": "rgb(20,20,20)", "width": 1 }, "mode": "lines", "type": "scatter", "uid": "61f297a4-c555-11e8-a197-8af2f04e441a", "x": [ 0, 0, null, 0, 0.1578079409818431, null, 0.18173590669014342, 0.3704706342339276, null, 0.3998564910644171, 1.024082831887035, null, 1.0781485228424805, 1.1693956546285882, null, 1.19320430825563, 1.436458094721308, null, 1.4544062403961326, 1.6420259159356294, null, 1.6474436091332678, 1.7522906094092747, null, 1.752675, 2.033125, null, 1.7511376062435167, 2.349372391993509, null, 1.6301278966180768, 2.0101865414957976, null, 2.020853573559901, 2.0474073081662336, null, 2.051464901944066, 2.132449876615273, null, 2.042451653875596, 2.1830144647578313, null, 1.9959929591719348, 1.9960027820444421, null, 2.0035390173470806, 2.0963804041976397, null, 1.9875910339530896, 2.0543789521311937, null, 1.405759845305352, 1.7461607596629802, null, 1.755987999052346, 1.768337434356736, null, 1.735567596453274, 1.7571934439025234, null, 1.1363278791903368, 1.5087943689945196, null, 1.5202145838716363, 1.7822506953214303, null, 1.4967123470410415, 1.8188241128121674, null, 0.9484350204488002, 1.3896348769327327, null, 1.4310073516929878, 1.5168991612173741, null, 1.546818511219353, 2.0035484555183105, null, 2.0346257791219275, 2.0346348273924524, null, 2.0542394256007457, 2.088442567534885, null, 2.0141377711035546, 2.0801338135979948, null, 1.9704938714804334, 2.0202242755729225, null, 1.484942293387745, 1.7098346646691456, null, 1.3448248000205862, 1.628876734444117, null, 1.6522283837407923, 1.6522367129531994, null, 1.6048106059768361, 1.6048186961467799, null, 0.3333473197571598, 1.2908572971741192, null, 1.324485046020822, 1.3591634815074902, null, 1.2559556280221975, 1.3668922875694631, null, 1.3923675006872231, 1.4678928973895988, null, 1.3408175103181614, 1.395001748394395, null, 0.12849093341262552, 0.47111541775805055, null, 0.5373592099474311, 0.9056318619949466, null, 0.9256301112822649, 0.9256371079156701, null, 0.8852363726415463, 0.8852430639476099, null, 0.39914756548253283, 0.7523922838101064, null, 0.882230966362246, 0.9772394001880166, null, 1.018089163526263, 1.1679286425628, null, 1.1985323923247166, 1.1985387665646143, null, 1.136812600697851, 1.1368186466889996, null, 0.9354252195453294, 1.1510236840094772, null, 0.6142069655114251, 0.6716347014154497, null, 0.7757843934977681, 0.8604087058329355, null, 0.9615652957955837, 1.0192149006673739, null, 0.7555677136995645, 0.7945387885848596, null, 0.8567277420109971, 0.8613402854883508, null, 0.91401438449459, 0.9257209987752617, null, 0.9607824999999985, 0.9724624999999986, null, 0.8902534457250971, 1.0043354614130118, null, 0.8078161476112073, 0.807820405404123, null, 0.7312826007716955, 1.144788857607141, null, 0.5640052583088262, 0.7156794132599676, null, 0, 0.023544836327340873, null, -0.14860702261158398, -0.2424644452940123, null, -0.3578133295471951, -0.42829964763304745, null, -0.4045913457420647, -0.41750117894923894, null, -0.3985232204475163, -0.4941569200964988, null, -0.4499228097952459, -0.5300346628176277, null, -0.408731544191389, -0.4598423282231091, null, -0.12553795638039722, -0.15524120668112146, null, 0.08209508980588105, 0.10243183802607282, null, 0.2786796386046482, 0.2802299879655742, null, 0.34909804363034974, 0.6343485409679197, null, 0.21023283992938827, 0.22449146514162482, null, 0.32440470260371007, 0.37626857920757023, null, 0.12295401913696334, 0.12732657829057095, null, 0.17601734146722547, 0.18464754192340235, null, 0.23206512507030508, 0.2320668959177083, null, 0.27246515214131145, 0.27246723125821964, null, 0.29925267352566337, 0.2992549570343645, null, 0.2455622758580187, 0.24752977966116882, null, 0.19143961768561144, 0.19297787197637362, null, 0.1369819379006787, 0.13698298318531138, null, 0.0784394867590058, 0.08083682879463498, null, -0.07641211837432581, -0.0814071613207816, null, -0.037595380486817424, -0.04352510358558665, null, -2.5454436801127623e-16, -2.586610182266101e-16, null, 0.029488707301455835, 0.029488916725654672, null, -0.029488707301456356, -0.02948891672565519, null, -0.08700725314878106, -0.08757487944532605, null, -0.12510959504273794, -0.15327897060873785, null, -0.3817733841172063, -0.39767345342423505, null, -0.17333333520025415, -0.2168595634497718, null, -0.1714174777908488, -0.1894076027583099, null, -0.261967267380151, -0.31219631098145506, null, -0.2620368410363961, -0.26203871484954194, null, -0.36193643495704264, -0.364646270359266, null, -0.3217201156358513, -0.3217223991445524, null, -0.4072125632381114, -0.40721545355608085, null, -0.37887979066574495, -0.3788824798639511, null, -0.4353724982898918, -0.43537558845983554, null, -0.5968966646896544, -0.6285519390529037, null, -0.44895730847282345, -0.5411493731634495, null, -0.44980245387197826, -0.44980623227984645, null, -0.414962822314965, -0.4250748974077709, null, -0.4842057377992333, -0.5121770167435561, null, -0.48797318950601415, -0.49202272738443864, null, -0.5361561862139446, -0.5361604440068602, null, -0.6286410131459844, -0.7218397081072679, null, -0.6585307760449691, -0.6843142326828929, null, -0.6580958025265348, -0.6584154767907675, null, -0.7102324999999994, -0.7256224999999994, null, -0.783069989553361, -0.9164951319452446, null, -0.857245177081122, -1.050314287847954, null, -0.973930016006747, -1.125548137515659, null, -1.0552008759952618, -1.1933478021889554, null, -1.1933964006981292, -1.2575871677422763, null, -1.177979754428832, -1.2032640894123765, null, -1.3337476220427493, -1.3337544675138087, null, -1.273108369299222, -1.2823215998154824, null, -1.2509286442820595, -1.2708353954819112, null, -1.3131520867141, -1.3780109163884642, null, -1.3920607071795632, -1.5313828797079598, null, -1.4996409124728343, -1.5068264549799064, null, -1.5624531317993686, -1.5703332826617942, null, -0.7784075192407357, -0.8073166797242599, null, -0.7754089603804857, -1.0189115599319862, null, -0.8372795024739893, -0.9014124190425679, null, -0.8642453893370762, -0.9076384960692079, null, -0.9357243374283774, -0.9635130469690216, null, -0.9324436671936407, -1.0901043153473118, null, -1.0739983756275457, -1.1811122256827888, null, -1.1057320992860815, -1.2175434466390054, null, -0.9921989412845769, -0.9922076790068072, null, -0.971304608803963, -0.9802089507522339, null, -1.01177800350948, -1.011786913574722, null, -0.9950944320572097, -0.9951031951240102, null, -1.027480883563051, -1.0369182297202713, null, -1.0264722415579637, -1.0264811986755662, null, -1.046909391276556, -1.0469185267311325, null, -0.676993503787383, -1.0985541624891162, null, -0.6111956649358464, -1.2579801533840924, null, -0.5259273989566795, -1.5313234816548074, null, -0.431349000812468, -0.517101830577536, null, -0.5144484172860555, -0.9813055009500559, null, -0.5195284259157499, -0.981380378554231, null, -0.380528480625566, -0.6347577190586658, null, -0.7044246978518764, -0.8812378001519606, null, -0.8959318220323339, -1.3454101601595518, null, -1.3381043471706275, -1.6665849839918145, null, -1.657787951047722, -1.7875409102391475, null, -1.7816208892836218, -2.079933990299303, null, -1.7926768566726627, -2.417669433912731, null, -1.6724582605646023, -1.9002279205265027, null, -1.8973074566181676, -2.141458172062889, null, -1.902314881665775, -1.944318005443131, null, -1.340607705852664, -1.5969370604728959, null, -1.6023834937290564, -1.7576394360658651, null, -1.758025, -2.052815, null, -1.7564829133845454, -2.359933120307654, null, -1.5849230025652734, -1.719362122069589, null, -1.7325871869842246, -1.788430646816567, null, -1.6987744845869763, -1.6987842550427208, null, -1.711215982598081, -1.7330355992267592, null, -1.7419750265828726, -1.7419849193062023, null, -1.7469899746771311, -1.7579925267147087, null, -1.7362157717765256, -1.7470913080654134, null, -1.7223858749661327, -1.7664416429031833, null, -1.6840706993385453, -1.6840803851701567, null, -0.834345301170519, -1.3283734483587595, null, -1.3656114766320064, -1.5341092813926256, null, -1.282670431887766, -1.6510989106147809, null, -1.7037254036780831, -1.7566306268753997, null, -1.7879452848339623, -1.8909295280083596, null, -1.7214158096339078, -1.784589534490498, null, -1.809373072833056, -1.977087636001552, null, -1.9940590871075268, -2.1673043397230844, null, -1.9592489689150685, -1.959258104369645, null, -1.7580448217335038, -1.7969276692454965, null, -1.5902261573181184, -1.6723773271211102, null, -1.6922314482993048, -1.6922402113661053, null, -1.6517896459746535, -1.651798199617255, null, -0.5084182615525373, -0.6007450103151444, null, -0.6562749050956511, -0.9724988042889932, null, -1.0297498484759846, -1.3054178494742603, null, -1.324132377812677, -1.5705104808147246, null, -1.2861307217226006, -1.4441074702141967, null, -0.9096448493523941, -1.0425334341218453, null, -1.09775438521471, -1.6989000495516051, null, -1.7431576017280055, -2.0801536253126898, null, -1.6529658881369862, -1.714282767687126, null, -1.7462324094021933, -2.236295868530027, null, -1.6815811848925746, -1.8200487756712718, null, -0.983855059789419, -1.0478807506069292, null, -1.071020153440942, -1.4685898534208517, null, -1.0242817126429178, -1.4068638281346584, null, -0.5394296126846749, -1.3094059211016047, null, 0.005784513668042991, 0.0073299211724926205, null, -0.18105952833475866, -0.1955873122814473, null, -0.2421503385422714, -0.3207735566410482, null, -0.3655874602056933, -0.5788137895938991, null, -0.6052806803269585, -0.6052865581794815, null, -0.6226010535074021, -0.6226070994985508, null, -0.5877065641622357, -0.638831085555407, null, -0.5517756795315463, -0.5517810377994962, null, -0.2738480085514164, -0.30457099185284214, null, -0.328409917654092, -0.6683443841440724, null, -0.7092160800972108, -0.8177214601151402, null, -0.8486925000000003, -0.9182675000000005, null, -0.7863917405719261, -0.8229133670204247, null, -0.6268131129739796, -0.7458056515876704, null, -0.2803229625056545, -0.5200478545966545, null, -0.14682753379377722, -0.19018844867090978, null, -0.2091575429925052, -0.2573759707373163, null, -0.2727977128147622, -0.44527464755006957, null, -0.2418413350527494, -0.3509027028774996, null, -0.17103166131220568, -0.25768031671265035, null, 0.19441011044703568, 0.36724808752319793, null, 0.29853190029784415, 0.33487246529977244, null, 0.25726008009800505, 0.2876835649917768, null, 0.17561799943985087, 0.20586668687905826, null, 0.0433739865529769, 0.04804824735983767, null, -0.13799821012743796, -0.14330460023805075, null, -0.3019678210683514, -0.32665525523605216, null, -0.35876776080260375, -0.4870141764741501, null, -0.2943994678784966, -0.30057555600724206, null, 0.017110111877635517, 0.018182155571879695, null, -0.06059301074531001, -0.06232868720001843, null, -0.15767953809425253, -0.1707569695429975, null, -0.2511554381013541, -0.2511568989316397, null, -0.08997937781002485, -0.09095544339395575, null, -0.14542497909488117, -0.18826636132416005, null, -0.2351780668635769, -0.23725609271333786, null, -0.14127207593640406, -0.14127270384159937, null, -0.03639614565158387, -0.03667153847305001, null, 0.03324808109471824, 0.033248290518917076, null, 0.09690994598374955, 0.10226597729959999, null, 0.23324360300087432, 0.2332452706883415, null, 0.17529294046153943, 0.19981940093773812, null, 0.1666502516299366, 0.16893419855233482, null, 0.23290090285219572, 0.23422587592125677, null, 0.29078840945308065, 0.32748482288241526, null, 0.29514711932369386, 0.29514899313683973, null, 0.3596788807743458, 0.3596811642830469, null, 0.36491565007325794, 0.49198558928192543, null, 0.4577512848539961, 0.5604652103379968, null, 0.5260040925701199, 0.6211875071774913, null, 0.3964830276007422, 0.4642326702768304, null, 0.4395754945763582, 0.5761983085241437, null, 0.4886862181850857, 0.6721360968115112, null, 0.4100829379815262, 0.6841911303052887, null, 0.4331949857219327, 0.4640115329845541, null, 0.42609104701956124, 0.6877513817345567, null, 0.5009017973081453, 0.567140796746673, null, 0.5394292952653812, 0.7792447189845781, null, 0.7521274999999998, 0.7521324999999999, null, 0.8060201354811305, 0.8060254937490804, null, 0.5942925987333141, 0.9143088175410056, null, 0.1797004976168639, 0.2700963584799674, null, 0.2232652239887754, 0.39012208559250416, null, 0.34908645993481235, 0.673447839067328, null, 0.427814065513073, 0.49668547261481644, null, 0.46649470450370895, 0.5681188501900846, null, 0.539871860934943, 0.6008051362058643, null, 0.5791028818066333, 0.8185894489951135, null, 0.6219144684717433, 0.6903075698250786, null, 0.6747613404113679, 0.6747680317174316, null, 0.7055510075237854, 0.7055580041571906, null, 0.5951044735248806, 0.858633922023995, null, 0.5247916674508968, 0.7932332897028126, null, 0.7670063152627508, 0.8111164171555786, null, 0.8181542677222755, 0.9968001264317192, null, 0.9674421437977426, 1.1025273850369977, null, 1.0246211155202527, 1.0246294156431035, null, 0.998711254131013, 1.039210644869423, null, 1.0491712821749588, 1.0520354205503246, null, 1.0310273932067928, 1.0399563089072053, null, 1.0720052159475484, 1.090165768664908, null, 1.0767453611539481, 1.0946310278339042, null, 1.103107993439416, 1.1122478721122735, null, 0.3044899921867922, 0.49592793271006025, null, 0.48205863368444835, 0.7574362572524534, null, 0.507900696104816, 0.7681716679430264, null, 0.743603163884636, 1.1109032505844199, null, 0.7876014712039423, 1.0610546506958753, null, 1.0336865195093163, 1.084004722303817, null, 1.069210416594483, 1.6727655246439825, null, 1.0973429793822203, 1.1764495026162196, null, 1.1642885736928321, 1.3409247299820506, null, 1.1874494179149948, 1.225195758907795, null, 1.2177630534331538, 1.2502831967643182, null, 1.2320910530294806, 1.232100738861092, null, 1.0807459910222021, 1.2295748115005625, null, 1.2203320559374924, 1.3689224579649648, null, 1.236921651825659, 1.4775155763352414, null, 1.4693953841848761, 1.4694052441452468, null, 1.483651151179209, 1.5287202413167904, null, 1.5234268478829267, 1.52343676902994, null, 1.5325049724371058, 1.5434832664498168, null, 1.541111084079432, 1.5411210490080245, null, 1.5451784260469377, 1.5451884172752388, null ], "y": [ 0, 0, null, 0, -0.14468352631889764, null, -0.11317565658970795, -0.23070981425875983, null, -0.17490081697536966, -0.44794301943353315, null, -0.2949480596945455, -0.31991045022126985, null, -0.21469134119755137, -0.2584596056149396, null, -0.12212990428959827, -0.1378847686322067, null, -0.03450902419589474, -0.03670525576906236, null, -4.2928156573911747e-16, -4.979720047032925e-16, null, -0.07339441139982548, -0.09846787782672123, null, -0.24071634488028615, -0.2968385227933938, null, -0.21240026943292273, -0.21519117940216909, null, -0.17226632090058866, -0.17906681922820594, null, -0.2580216479403288, -0.2757788604717193, null, -0.3807560205184738, -0.38075789433161966, null, -0.3388732594833872, -0.35457620467417544, null, -0.42247551618323403, -0.4366717264322707, null, -0.3924952011834959, -0.4875368441853432, null, -0.45086108748608866, -0.4540318835474406, null, -0.5239987511114946, -0.5305279794044703, null, -0.4225965501513128, -0.561115596036529, null, -0.5293947289206677, -0.6206453573912224, null, -0.5925903393069248, -0.720123409339005, null, -0.5914977660239163, -0.8666549711604663, null, -0.7964884742578647, -0.8442952421534938, null, -0.7881433972153444, -1.0208589273818363, null, -0.957422217288428, -0.9574264750813437, null, -0.9146063187691845, -0.9298345386859426, null, -0.9998266724982913, -1.0325873925006368, null, -1.0832881729637107, -1.1106276939689832, null, -0.8993130192170823, -1.0355126805214656, null, -0.9346775847716635, -1.1320988221050623, null, -1.097737913614306, -1.0977434475297985, null, -1.1659631546362261, -1.1659690324887493, null, -0.28170032594180267, -1.0908589924263026, null, -1.0497739117982603, -1.0772597010755756, null, -1.13086752692982, -1.2307553438470704, null, -1.2018593866401412, -1.267051160300234, null, -1.2591114510833452, -1.3099938374670246, null, -0.1712505446874615, -0.6278946674209438, null, -0.5722294379963972, -0.9643999801765685, null, -0.9452223486104112, -0.9452294933372076, null, -0.9831545940377012, -0.9831620254859561, null, -0.675930966293428, -1.2741283861087205, null, -1.187925003952917, -1.315853968624621, null, -1.284508842762631, -1.4735592154733435, null, -1.4487767875602477, -1.4487844926926756, null, -1.4976952916129465, -1.4977032569121267, null, -1.3459005054845516, -1.6561060422189908, null, -1.3461972725207279, -1.4720653687522098, null, -1.4199395046375392, -1.5748297101438913, null, -1.5151844570700133, -1.6060256985747752, null, -1.6277313006266767, -1.7116872945894945, null, -1.68142286682849, -1.6904754931142438, null, -1.662585993313421, -1.683880245638487, null, -1.6641241050230453, -1.68435445845545, null, -1.7028977807254289, -1.9211165500753231, null, -1.7166966976969424, -1.716705745967467, null, -1.7396525626784172, -2.7233450758439584, null, -1.5165644366874076, -1.9244039487750144, null, 0, 0.21858056800026554, null, 0.16201165654211472, 0.2643351959033585, null, 0.02513412467841992, 0.03008534298304405, null, -0.1437065028995733, -0.1482919370734484, null, -0.19358970992576102, -0.24004547266245715, null, -0.3152496722455884, -0.37138204619610216, null, -0.5017966648035064, -0.5645449927147971, null, -0.7172211912184646, -0.8869212658253206, null, -0.8966546493799963, -1.1187756055543936, null, -1.088342223775308, -1.0943968845303855, null, -1.0744133017412165, -1.9523240613681097, null, -1.1099709636023025, -1.1852525417410276, null, -1.1618870833921848, -1.3476426160247814, null, -1.2000426304107146, -1.2427192132922926, null, -1.2367623038109667, -1.2974012528461059, null, -1.2897637393534922, -1.289773581309572, null, -1.281847758547641, -1.2818575400236485, null, -1.275870284320762, -1.2758800201097908, null, -1.2872825306436928, -1.2975965467763442, null, -1.2964265532630017, -1.3068435909291019, null, -1.3032960808327378, -1.3033060260516915, null, -1.2467599398208074, -1.2848646003121988, null, -1.120853391479255, -1.1941233249169416, null, -1.196304404568942, -1.3849912530347848, null, -1.3856749999999998, -1.4080849999999998, null, -1.4077761836906777, -1.4077861814975126, null, -1.4077761836906777, -1.4077861814975126, null, -1.382940686914845, -1.3919628485398365, null, -1.1903382839568095, -1.4583519895396053, null, -0.8154619839113875, -0.8494242835395293, null, -0.9217490677691821, -1.153212105540596, null, -1.1608368873070944, -1.2826657751114865, null, -1.1438091542938342, -1.3631206753749172, null, -1.3736452257277592, -1.3736550486002665, null, -1.3507651643700271, -1.3608784077712737, null, -1.3716607125744524, -1.3716704483634812, null, -1.3487530802804666, -1.348762653475442, null, -1.3569949245483865, -1.3570045561740545, null, -1.3399387705256602, -1.3399482810908234, null, -0.7234501784555493, -0.7618169766668595, null, -0.8797044851504611, -1.0603492174514042, null, -1.102207267039982, -1.1022165257458303, null, -1.1158014036204644, -1.1429919541356242, null, -1.0875438932324983, -1.15036841435458, null, -1.1608423456905452, -1.170475815624645, null, -1.1393898934120479, -1.1393989416825725, null, -1.010936983009223, -1.160812676026849, null, -1.197863034752559, -1.2447629682685066, null, -1.258821167172667, -1.2594326476423365, null, -1.2301587751866627, -1.2568150371151479, null, -1.120419575197568, -1.3113247859114339, null, -1.3508022532540265, -1.6550304913709126, null, -1.2692503082316335, -1.4668428911645686, null, -1.5182350900054418, -1.717002467568346, null, -1.4121939342830183, -1.4881534493307333, null, -1.5519310137312123, -1.5852418949029843, null, -1.4202969597659185, -1.4203042494521927, null, -1.4749102415554904, -1.4855838718401801, null, -1.5121129761164172, -1.5361761046883051, null, -1.4584031413787495, -1.5304361693122732, null, -1.3632065610727284, -1.4996409124728345, null, -1.53138287970796, -1.5387205141277887, null, -1.4672411531699023, -1.4746411073849917, null, -0.6078851700892887, -0.6304613265411263, null, -0.6693150601821644, -0.8795008658676613, null, -0.5900887563425598, -0.6352876569089203, null, -0.6849924548742163, -0.7193854074682263, null, -0.5835706645893229, -0.6009012768712277, null, -0.6480652310805409, -0.7576422360759517, null, -0.7803054949020881, -0.8581282623056116, null, -0.7346466503247631, -0.8089339318951896, null, -0.5522508462091885, -0.5522557095629927, null, -0.5882429803586104, -0.5936356415261848, null, -0.515526642026744, -0.5155311819317414, null, -0.547057793394573, -0.547062610931314, null, -0.4834958034331761, -0.4879366814441998, null, -0.5095452458182387, -0.5095496921700305, null, -0.4661140919152209, -0.4661181592816517, null, -0.2680406899235311, -0.43494836211076404, null, -0.21284084943597759, -0.43807503845429874, null, -0.15878684344636876, -0.46233381723339106, null, -0.10117199475687647, -0.12128513939622301, null, -0.13208790321930505, -0.251956428832765, null, -0.11042917590249046, -0.20859883895591178, null, 0.19885620799411374, 0.3317110792850304, null, 0.12936555600812968, 0.1618367702604478, null, -0.008796072693102569, -0.013208957735151293, null, -0.1406404341150461, -0.17516514024771937, null, -0.24480082635888908, -0.26396107638513494, null, -0.30133861765999326, -0.35179450197895, null, -0.2264677530581797, -0.30542267687434854, null, -0.10522215495903978, -0.11955220732601968, null, -0.15932135853707868, -0.17982326693192932, null, -0.07973061656558919, -0.08149106904836473, null, 0.11434139510018615, 0.13620391005102053, null, 0.03356514933175236, 0.03681729771543888, null, 2.1529596890710257e-16, 2.513973318991674e-16, null, 0.0736184461472765, 0.0989105034866386, null, 0.2382825133417851, 0.25849453073007184, null, 0.1454894110342474, 0.15017871737459038, null, 0.3703927371605078, 0.37039486746437056, null, 0.3078963525699581, 0.3118223212628433, null, 0.25723249208955073, 0.25723395291983636, null, 0.22069615765254477, 0.22208610321277292, null, 0.2936589168737164, 0.2954983761499951, null, 0.3661044194518145, 0.3754687620062464, null, 0.4323958633640973, 0.43239835026296897, null, 0.3265564561292211, 0.5199153457251076, null, 0.41230241318230415, 0.4631748997625006, null, 0.6242151457517289, 0.8035118932484347, null, 0.684893220938091, 0.7061609843005637, null, 0.6226284232710567, 0.6584913310978993, null, 0.788125691350966, 0.8170488807972186, null, 0.760590404575068, 0.831091115218299, null, 0.7895038437834854, 0.8580964916852214, null, 0.8723138426221616, 0.8723179099885924, null, 0.8727010284175293, 0.892002641545947, null, 0.9181175000000007, 0.9655475000000007, null, 0.9303121112894518, 0.9303169288261928, null, 1.0003593676654048, 1.0003645479354986, null, 0.504440753057181, 0.5960452019825822, null, 0.5342917734409675, 0.7917385028413602, null, 0.7156947888511463, 0.9072890406584869, null, 0.87975144845186, 1.0434446687180412, null, 0.9344286659056978, 1.0492054921208491, null, 0.8632207303301167, 0.9893272885972124, null, 0.927674379815932, 1.4356818529390674, null, 1.381609690456342, 1.6487094474538184, null, 1.4883371707649125, 1.543547137095582, null, 1.5073073821813558, 1.9303188127924704, null, 1.5791098412207698, 1.7091395639919245, null, 1.0476992252320123, 1.115879660954737, null, 1.0936897714381082, 1.4996745821858561, null, 1.1375800887719034, 1.5624805741868584, null, 0.6520583893976534, 1.582799861008668, null, 0.3586483548360765, 0.4544658929783455, null, 0.41690577211666746, 0.45035729515521294, null, 0.42712914155892395, 0.5658126877199311, null, 0.5379456117167892, 0.8516986275678444, null, 0.8330973852125177, 0.8331054753824616, null, 0.8202465963333669, 0.8202545616325472, null, 0.8455989268356603, 0.9191574729898575, null, 0.8694593462045827, 0.8694677894838377, null, 0.5899550325553833, 0.6561420342782315, null, 0.6445407545000025, 1.3116997096165266, null, 1.2900592605599737, 1.4874298141062532, null, 1.4699785300026493, 1.590485964939254, null, 1.5042286623333756, 1.574088090484172, null, 1.3320456694231129, 1.5849176857757912, null, 0.6668619759118474, 1.2371449587475256, null, 0.46852723009984937, 0.6068920777347095, null, 0.6006186495891868, 0.7390831129934062, null, 0.7335309442061967, 1.1973074454266797, null, 0.7443110955003316, 1.0799674717963803, null, 0.6125665766704766, 0.9229071873183501, null, 0.41084995385295026, 0.7761111778833967, null, 0.8050456028881581, 0.9030445505117963, null, 0.9281413035809621, 1.0379029615810054, null, 1.0626206799689832, 1.2456479375242588, null, 1.2617997362162914, 1.3977794217796484, null, 1.39178031313373, 1.4452978861728167, null, 1.4206469030917683, 1.5367921492029006, null, 1.5296141537765942, 2.076395537208218, null, 1.5432960568011111, 1.5756722445851288, null, 1.452284211955957, 1.5432778970243046, null, 1.542195106098388, 1.5863710217905906, null, 1.5797452475925933, 1.7107642144893878, null, 1.7008212975316122, 1.7008311902549418, null, 1.7169088070698224, 1.7355332478929952, null, 1.7318198874826025, 2.2420043015611637, null, 2.2375698397796016, 2.257340935059523, null, 2.245455346157126, 2.2454653264244104, null, 1.7375338465211863, 1.7506809625088804, null, 1.5872468141812475, 1.5872568119880823, null, 1.5403394822552678, 1.6254711621901994, null, 1.3790189874269936, 1.3790288473873644, null, 1.3875865029789487, 1.5817334288791787, null, 1.585571230395115, 1.6073015338089118, null, 1.5772018268045571, 1.5861745268645313, null, 1.3680519066003116, 1.5406949581298284, null, 1.5472153829315187, 1.547225205804026, null, 1.533498733599058, 1.5335084693880867, null, 1.2086589450116239, 1.629534888906622, null, 1.639480873764472, 2.007360816152837, null, 1.618874136189866, 1.911818564339099, null, 1.0014018174786528, 1.1725178819415265, null, 1.181982884898487, 1.549350560679834, null, 1.1625385738894682, 1.5989485898514644, null, 0.8714706031768596, 1.4539801630134337, null, 0.7413243706842332, 0.7940605709152948, null, 0.815037000801052, 1.3155470582792572, null, 0.7713211279865667, 0.8733202424600892, null, 0.8907036345690379, 1.286685965167743, null, 1.302723043769761, 1.302731704023799, null, 1.2700845035760338, 1.2700929468552888, null, 0.8550749887090628, 1.3155179847466048, null, 0.12664736547299935, 0.19035557874898465, null, 0.24359788378030275, 0.4256503219286399, null, 0.4599044267184004, 0.8872347624392014, null, 0.3877480671443457, 0.45016947199737606, null, 0.48138519181108713, 0.5862531750734455, null, 0.61236442335887, 0.6814796573146206, null, 0.7000151336280184, 0.9895046640713101, null, 0.6622716428554893, 0.7351028984211625, null, 0.7493983891837863, 0.7494058206320411, null, 0.7204849672319131, 0.7204921119587095, null, 0.5588402981314738, 0.806310922395754, null, 0.4170644050972311, 0.6304013394118492, null, 0.6620620914778744, 0.7001369100723779, null, 0.5977026809650655, 0.7282124306620342, null, 0.7667851945812642, 0.8738524374678365, null, 0.688516815956613, 0.6885223934077028, null, 0.7256061993237506, 0.7550307290535119, null, 0.650513755645761, 0.6522895966765848, null, 0.6850129622731272, 0.6909453196810159, null, 0.6189224999999999, 0.6294074999999999, null, 0.6521001698040367, 0.6629321145700289, null, 0.6064387512643507, 0.6114634420852315, null, 0.1283477069646637, 0.2090420526662658, null, 0.2392959839096401, 0.3759946233982542, null, 0.17798869942005646, 0.26919804827418164, null, 0.33107345904762436, 0.49460599376268055, null, 0.20552183140091318, 0.27687847598116694, null, 0.36604759473286463, 0.38386620487876333, null, 0.4233303512280356, 0.6622947233577674, null, 0.34388644466677065, 0.36867692634480026, null, 0.4054481784313634, 0.46695939603734804, null, 0.33154183464283954, 0.3420808024127518, null, 0.3676643424621998, 0.37748275260440356, null, 0.31634721441748936, 0.31634970131636103, null, 0.18570612567828262, 0.21127959425452383, null, 0.2593895859057824, 0.29097345085790827, null, 0.1628438247827753, 0.1945186158488152, null, 0.24852962632487213, 0.24853129401233928, null, 0.14024632554761574, 0.14450660889154487, null, 0.19245356680116393, 0.19245482013349957, null, 0.0964170404054442, 0.09710773612026664, null, 0.1294107134379425, 0.12941155021637582, null, 0.06476216414008773, 0.06476258289662502, null ] }, { "hoverinfo": "none", "line": { "color": "rgb(20,20,20)", "shape": "spline", "width": 1 }, "mode": "lines", "type": "scatter", "uid": "61f297a5-c555-11e8-a580-8af2f04e441a", "x": [ 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, null, 0.12849093341262552, 0.135422873544206, 0.14212581746960434, 0.1485884307023415, 0.15479978514826592, 0.16074937758464927, 0.166427147420835, 0.1718234937104096, 0.1769292913861285, 0.18173590669014342, null, 0.3333473197571598, 0.34222830625951667, 0.3507557391112413, 0.3589208086815696, 0.36671507969468814, 0.37413049994416014, 0.38115940861160147, 0.38779454418101805, 0.3940290519406287, 0.3998564910644171, null, 0.9484350204488002, 0.9670359776130955, 0.9846288359901423, 1.0011952556840074, 1.0167179668226378, 1.0311807875610608, 1.044568640950348, 1.0568675706547703, 1.068064755500755, 1.0781485228424805, null, 1.1363278791903368, 1.1444641671977043, 1.1521526820026826, 1.1593904154631256, 1.1661745358057176, 1.172502388733908, 1.178371498466409, 1.1837795687058483, 1.1887244835371977, 1.19320430825563, null, 1.405759845305352, 1.4136713382462651, 1.4209627482159493, 1.4276308769610078, 1.433672799619789, 1.4390858660053285, 1.4438677017678054, 1.4480162094360132, 1.451529569337379, 1.4544062403961326, null, 1.6301278966180768, 1.6333299233041914, 1.6362135290854918, 1.6387781517973175, 1.641023291461389, 1.6429485103832802, 1.644553433237748, 1.6458377471419017, 1.646801201716201, 1.6474436091332678, null, 1.7511376062435167, 1.7514602318522188, 1.7517449179527538, 1.751991658378353, 1.752200447784213, 1.7523712816476118, 1.7525041562680073, 1.7525990687671165, 1.752656017088979, 1.752675, null, 1.9959929591719348, 1.9994506734554378, 2.002735143121742, 2.0058460835843355, 2.0087832252923383, 2.0115463137538563, 2.014135109558029, 2.0165493883957795, 2.018788941079244, 2.020853573559901, null, 2.042451653875596, 2.0436304153891314, 2.044764908507972, 2.0458551086571326, 2.046900992221085, 2.047902536544272, 2.0488597199315963, 2.049772521648893, 2.050640921923375, 2.051464901944066, null, 1.9875910339530896, 1.9895357899471802, 1.9914374493251004, 1.9932959708937805, 1.9951113143945882, 1.9968834405041986, 1.998612310835446, 2.000297887938158, 2.0019401352999617, 2.0035390173470806, null, 1.735567596453274, 1.7379875909536122, 1.740369937785336, 1.7427145853428956, 1.7450214828373698, 1.747290580297567, 1.7495218285711045, 1.7517151793254773, 1.7538705850491019, 1.755987999052346, null, 1.4967123470410415, 1.4994541671350519, 1.502163506586575, 1.5048403067068663, 1.5074845095120313, 1.510096057724292, 1.5126748947732198, 1.5152209647969648, 1.5177342126434632, 1.5202145838716363, null, 1.3448248000205862, 1.3550741256178909, 1.3651578825840023, 1.3750748388432672, 1.3848237827004402, 1.3944035229887377, 1.4038128892153736, 1.4130507317045808, 1.4221159217380783, 1.4310073516929878, null, 1.484942293387745, 1.4922177454405399, 1.4993942059497003, 1.5064711988393278, 1.5134482546320591, 1.520324910480214, 1.5271007101964962, 1.5337752042842603, 1.5403479499673256, 1.546818511219353, null, 1.9704938714804334, 1.9780085686479238, 1.9854268604683334, 1.992748385384583, 1.9999727865558758, 2.007099711875096, 2.0141288139859523, 2.0210597502999272, 2.027892183012962, 2.0346257791219275, null, 2.0141377711035546, 2.0187693441715386, 2.0233571873765053, 2.0279012013382274, 2.032401287625891, 2.0368573487602295, 2.041269288215632, 2.045637010422237, 2.049960420768, 2.0542394256007457, null, 1.6048106059768361, 1.6102198439018434, 1.6155942018176965, 1.6209335633069701, 1.626237812710311, 1.6315068351289614, 1.6367405164272313, 1.6419387432349788, 1.6471014029500644, 1.6522283837407923, null, 1.2559556280221975, 1.263819901837496, 1.2716225788537636, 1.27936327877953, 1.2870416243439988, 1.294657241315445, 1.3022097585194368, 1.309698807856942, 1.3171240243222617, 1.324485046020822, null, 1.3408175103181614, 1.3466631377977385, 1.352479594339724, 1.3582667539501097, 1.364024491269502, 1.3697526815758447, 1.3754512007871167, 1.3811199254640247, 1.3867587328126734, 1.3923675006872231, null, 0.39914756548253283, 0.41559131176896663, 0.43178546254088973, 0.447720291927523, 0.4633862298011321, 0.4787738675246421, 0.49387396360227115, 0.5086774492297811, 0.5231754337410107, 0.5373592099474311, null, 0.8852363726415463, 0.8898025775432097, 0.8943495078581364, 0.8988770650923376, 0.90338515117148, 0.9078736684430092, 0.9123425196782606, 0.9167916080745696, 0.9212208372573659, 0.9256301112822649, null, 0.6142069655114251, 0.6455589270986604, 0.6765569239139466, 0.7071839595245578, 0.7374232408985663, 0.7672581876125769, 0.796672440942911, 0.8256498728352011, 0.8541745947475315, 0.882230966362246, null, 0.9354252195453294, 0.9447985056565184, 0.9541257436214547, 0.9634064788437162, 0.9726402589933628, 0.9818266340289792, 0.9909651562196015, 1.0000553801665528, 1.0090968628251429, 1.018089163526263, null, 1.136812600697851, 1.143770853325188, 1.15070432999539, 1.1576128805179513, 1.1644963552423093, 1.1713546050610837, 1.1781874814133102, 1.1849948362876503, 1.1917765222256098, 1.1985323923247166, null, 0.5640052583088262, 0.5881953316448885, 0.6122348518044511, 0.6361176656850878, 0.6598376602945634, 0.6833887643155114, 0.7067649496594189, 0.7299602330095721, 0.7529686773525345, 0.7757843934977681, null, 0.7555677136995645, 0.7791613561991377, 0.8025901779084774, 0.8258492227849373, 0.84893357069981, 0.8718383384791077, 0.8945586809365377, 0.9170897918984223, 0.9394269052203928, 0.9615652957955837, null, 0.7312826007716955, 0.7454274316953209, 0.7595228120529329, 0.7735678067776014, 0.7875614841449113, 0.8015029158347647, 0.8153911769929655, 0.8292253462925726, 0.8430045059950186, 0.8567277420109971, null, 0.8078161476112073, 0.8197811682007936, 0.8317062338127789, 0.8435907632362906, 0.8554341772361312, 0.867235898581014, 0.8789953520716844, 0.8907119645689723, 0.9023851650217142, 0.91401438449459, null, 0.8902534457250971, 0.8981694210942957, 0.9060659406371716, 0.9139428333021233, 0.9217999284627083, 0.9296370559213292, 0.9374540459129189, 0.9452507291086206, 0.9530269366194599, 0.9607824999999985, null, 0.1797004976168639, 0.15273895606504567, 0.12034945775350525, 0.08368304365327868, 0.0440427455212763, 0.0028372794424200358, -0.038469016382333784, -0.07840822051750307, -0.11556099451369374, -0.14860702261158398, null, 0.005784513668042991, -0.054455719977707734, -0.113152888979209, -0.16864374241918673, -0.21935588397164374, -0.2638523275367584, -0.3008722158733026, -0.32936654841991075, -0.3485279059168218, -0.3578133295471951, null, -0.380528480625566, -0.39709459819300386, -0.4103437987990552, -0.42016541234542343, -0.42647739924580247, -0.4292270356996038, -0.42839135409197504, -0.42397733484146455, -0.416021848092835, -0.4045913457420647, null, -0.431349000812468, -0.4287247734312969, -0.42584014183858626, -0.4226968581379282, -0.4192968315362648, -0.41564212718425037, -0.4117349649218949, -0.40757771793024866, -0.4031729112899516, -0.3985232204475163, null, -0.5259273989566795, -0.5199905545597995, -0.5134047472117573, -0.5061781961867975, -0.4983199204254352, -0.4898397272785619, -0.4807482002675954, -0.4710566858759435, -0.4607772793882721, -0.4499228097952459, null, -0.6111956649358464, -0.5969961779015727, -0.580550397563033, -0.5619202037908623, -0.5411756956595211, -0.5183949276883528, -0.4936636161490085, -0.46707481654430844, -0.4387285734720762, -0.408731544191389, null, -0.676993503787383, -0.6423173286859968, -0.5993912663965691, -0.5487666568183973, -0.4910937195537037, -0.42711320252409535, -0.3576468678464485, -0.28358693716707833, -0.20588463201772925, -0.12553795638039722, null, -0.3817733841172063, -0.3331955864257859, -0.2834662821497965, -0.23275733317352618, -0.18124398698230212, -0.12910427101630792, -0.07651837741703311, -0.023668040292615353, 0.02926409234576049, 0.08209508980588105, null, -0.07641211837432581, -0.036676760884473546, 0.0031045942670104654, 0.04288205583375069, 0.08260573745246202, 0.12222582020724693, 0.16169261510932026, 0.20095662541377193, 0.23996860869524525, 0.2786796386046482, null, 0.21023283992938827, 0.2258709557250423, 0.24146411539284132, 0.25700921535500487, 0.27250316159929205, 0.2879428702948231, 0.3033252684058643, 0.31864729430346916, 0.3339058983748488, 0.34909804363034974, null, 0.12295401913696334, 0.14562077599849774, 0.16823547463573896, 0.19079003048076448, 0.21327638046620737, 0.23568648590773078, 0.25801233537779256, 0.28024594756966414, 0.30237937415068183, 0.32440470260371007, null, 0.0784394867590058, 0.0893163948964993, 0.10018650124471784, 0.1110489780029799, 0.12190299795162231, 0.13274773451500516, 0.14358236182445094, 0.154406054781141, 0.1652179891189521, 0.17601734146722547, null, 0.1369819379006787, 0.14759245388859094, 0.1581931788088899, 0.16878340942498243, 0.17936244319645106, 0.18992957832566407, 0.2004841138043248, 0.211025349459979, 0.22155258600246666, 0.23206512507030508, null, 0.19143961768561144, 0.2004856436626865, 0.20952189825233367, 0.21854794104025133, 0.2275633321098467, 0.23656763206367903, 0.24556040204487398, 0.2545412037585051, 0.2635095994929702, 0.27246515214131145, null, 0.2455622758580187, 0.2515508795366832, 0.25753403420972537, 0.2635116102721805, 0.26948347823992236, 0.2754495087524724, 0.28140957257580007, 0.2873635406051263, 0.29331128386771255, 0.29925267352566337, null, -0.12510959504273794, -0.11541040205130633, -0.10570355290252964, -0.0959896915345902, -0.08626946235084967, -0.0765435101771013, -0.06681248021879309, -0.05707701801822589, -0.04733776941173006, -0.037595380486817424, null, -0.08700725314878106, -0.07735046393140137, -0.06768990476153613, -0.058026046481207794, -0.048359360093237734, -0.03869031673828161, -0.02901938767187033, -0.019347044241445403, -0.009673757863377526, -2.5454436801127623e-16, null, -0.029488707301456356, -0.022936323692949092, -0.016383443245960184, -0.009830207906654839, -0.0032767596288858104, 0.003276759628885293, 0.00983020790665432, 0.01638344324595967, 0.022936323692947326, 0.029488707301455835, null, -0.5968966646896544, -0.5554719747578679, -0.5123060298434874, -0.4675341435538159, -0.42129666368968915, -0.37373853229292575, -0.3250088312920878, -0.27526031517078964, -0.22464893212355877, -0.17333333520025415, null, -0.261967267380151, -0.25197580128101216, -0.2419651462490408, -0.23193606463437635, -0.22188932019041407, -0.2118256780156388, -0.20174590449536725, -0.19165076724337632, -0.1815410350434547, -0.1714174777908488, null, -0.36193643495704264, -0.35092274497919596, -0.3398857752994906, -0.3288262580943591, -0.3177449270360041, -0.30664251724372726, -0.29551976523516266, -0.28437740887741725, -0.27321618733812075, -0.2620368410363961, null, -0.4072125632381114, -0.39778664342407616, -0.38834133605023247, -0.3788771014675376, -0.3693944009494342, -0.3598936966693663, -0.3503754516782571, -0.34084012988193796, -0.3312881960185432, -0.3217201156358513, null, -0.4353724982898918, -0.42913144714394086, -0.42288110030531617, -0.41662159316680736, -0.41035306131963156, -0.40407564055049205, -0.39778946683864463, -0.3914946763529479, -0.3851914054489106, -0.37887979066574495, null, -0.7784075192407357, -0.7480646005874392, -0.7159672564910708, -0.6821907644037305, -0.6468143398598105, -0.6099209506929124, -0.5715971224525479, -0.5319327354769751, -0.4910208140981028, -0.44895730847282345, null, -0.6286410131459844, -0.6095639886994966, -0.5902723896954515, -0.5707730070309454, -0.5510727047456614, -0.5311784176056372, -0.5110971486621358, -0.49083596678648045, -0.4704020041817146, -0.44980245387197826, null, -0.4842057377992333, -0.4766015110428452, -0.4689740554011924, -0.461323742625703, -0.4536509455818298, -0.445956038230874, -0.43823939561176584, -0.43050139382277824, -0.4227424100032036, -0.414962822314965, null, -0.5361561862139446, -0.5308474369858002, -0.5255271887294126, -0.5201955566901072, -0.5148526563597994, -0.5094986034744957, -0.504133514011782, -0.4987575041883186, -0.4933706904573151, -0.48797318950601415, null, -0.783069989553361, -0.7696520247145174, -0.7561245863219784, -0.7424895984878184, -0.7287490006217, -0.7149047471550147, -0.7009588072628908, -0.6869131645841053, -0.6727698169389291, -0.6585307760449691, null, -0.7102324999999994, -0.7044994093487142, -0.6987510580819685, -0.6929875707184994, -0.6872090721049207, -0.6814156874130107, -0.6756075421370089, -0.6697847620908889, -0.6639474734056416, -0.6580958025265348, null, -0.973930016006747, -0.9613294498065971, -0.9486348509348235, -0.9358474611166719, -0.9229685311537567, -0.9099993208017122, -0.8969410986469745, -0.8837951419826867, -0.8705627366837656, -0.857245177081122, null, -1.1933964006981292, -1.1785427760062008, -1.1635599108179109, -1.1484494481732737, -1.1332130451047941, -1.1178523724557687, -1.1023691146970533, -1.086764969742338, -1.0710416487619652, -1.0552008759952618, null, -1.3337476220427493, -1.3171318053599435, -1.300337670114711, -1.2833674899641325, -1.2662235623989497, -1.2489082084325227, -1.2314237722866024, -1.2137726210739608, -1.195957144477921, -1.177979754428832, null, -1.3920607071795632, -1.37931127923904, -1.366442339345687, -1.353455002543048, -1.3403503941333008, -1.3271296495797476, -1.3137939144084374, -1.300344344108908, -1.2867821040340666, -1.273108369299222, null, -1.3131520867141, -1.30635017226614, -1.299519960125701, -1.2926615982464065, -1.2857752351916532, -1.2788610201313841, -1.2719191028388674, -1.2649496336874422, -1.257952763647271, -1.2509286442820595, null, -1.5624531317993686, -1.5556073833899697, -1.5487279379670993, -1.5418149445508562, -1.5348685528880437, -1.527888913448925, -1.5208761774239654, -1.5138304967205571, -1.5067520239597272, -1.4996409124728343, null, -0.8372795024739893, -0.8307929463862422, -0.8242075342460532, -0.8175240496516114, -0.8107432878707465, -0.8038660557463003, -0.7968931716001219, -0.7898254651356935, -0.7826637773394054, -0.7754089603804857, null, -0.9357243374283774, -0.9283519149087709, -0.9208342490847821, -0.913172516116667, -0.9053679147043969, -0.8974216659001184, -0.8893350129171154, -0.8811092209353087, -0.8727455769033091, -0.8642453893370762, null, -0.9921989412845769, -0.9860340062286324, -0.9797485934086777, -0.9733434708027728, -0.9668194210156198, -0.9601772411829415, -0.9534177428740849, -0.9465417519928596, -0.939550108676625, -0.9324436671936407, null, -1.1057320992860815, -1.1023009348729058, -1.098845892809207, -1.0953670479368762, -1.091864475613414, -1.088338251710294, -1.084788452611325, -1.0812151552109899, -1.0776184369127864, -1.0739983756275457, null, -1.01177800350948, -1.0075455925978722, -1.003246342584666, -0.998880538675822, -0.9944484704923887, -0.9899504320512901, -0.9853867217458202, -0.9807576423258481, -0.9760635008777354, -0.971304608803963, null, -1.027480883563051, -1.0240804345219592, -1.0206300732452507, -1.0171299678986665, -1.0135802890724035, -1.0099812097727994, -1.006332905413902, -1.0026355538089191, -0.998889335161551, -0.9950944320572097, null, -1.046909391276556, -1.0447286667276596, -1.0425253116382212, -1.0402993737365354, -1.0380509012400765, -1.0357799428544554, -1.0334865477723645, -1.0311707656725115, -1.0288326467185447, -1.0264722415579637, null, -0.5195284259157499, -0.5190088401287606, -0.5184780117570006, -0.5179359522990854, -0.5173826734969139, -0.5168181873354148, -0.5162425060422863, -0.5156556420877315, -0.5150576081841888, -0.5144484172860555, null, -0.5084182615525373, -0.5408854034566183, -0.5709507186089487, -0.5984807005814177, -0.6233531012106358, -0.6454574734465818, -0.664695661797856, -0.6809822381956996, -0.6942448813412998, -0.7044246978518764, null, -0.834345301170519, -0.8474786980367681, -0.8590785119485292, -0.8691237520809815, -0.8775962407394209, -0.884480646253307, -0.88976451072019, -0.8934382725493201, -0.8954952837641367, -0.8959318220323339, null, -1.340607705852664, -1.3427208029418438, -1.3442367301869806, -1.3451548133853408, -1.3454746442229992, -1.345196080456438, -1.3443192459758062, -1.342844530749822, -1.340772590652335, -1.3381043471706275, null, -1.6724582605646023, -1.6714063664167709, -1.6702096514139015, -1.6688682192466915, -1.6673821861450155, -1.665751680867857, -1.663976844692151, -1.6620578314005425, -1.659994807268063, -1.657787951047722, null, -1.7926768566726627, -1.7916034155298641, -1.7904911653115407, -1.7893401301108618, -1.788150334861142, -1.7869218053353024, -1.7856545681453122, -1.784348650741613, -1.783004081412522, -1.7816208892836218, null, -1.902314881665775, -1.9019231962318808, -1.9014903120146374, -1.9010162383910292, -1.90050098563027, -1.8999445648935813, -1.8993469882339513, -1.8987082685958736, -1.8980284198150648, -1.8973074566181676, null, -1.5849230025652734, -1.5881582566158488, -1.5910708612985958, -1.5936602248903318, -1.5959258213373566, -1.5978671903623287, -1.5994839375577723, -1.6007757344662061, -1.601742318646873, -1.6023834937290564, null, -1.7564829133845454, -1.7568065238004746, -1.7570920788987634, -1.757339572493819, -1.7575489992245232, -1.7577203545543485, -1.757853634771457, -1.75794883698878, -1.7580059591440809, -1.758025, null, -1.6987744845869763, -1.7039817625436147, -1.7088285867657165, -1.713313931974767, -1.7174368493581278, -1.7211964667697464, -1.7245919889146455, -1.7276226975171585, -1.7302879514728677, -1.7325871869842246, null, -1.6840706993385453, -1.687536609033401, -1.6908905700167634, -1.6941323597917648, -1.6972617633028102, -1.7002785729498462, -1.7031825886021317, -1.7059736176115134, -1.7086514748252073, -1.711215982598081, null, -1.7223858749661327, -1.7248997718857488, -1.7273295996239542, -1.7296752397543727, -1.7319365779538127, -1.7341135040078417, -1.7362059118161548, -1.738213699397747, -1.7401367688958842, -1.7419750265828726, null, -1.7362157717765256, -1.7375637128587382, -1.7388740154542321, -1.7401466511796988, -1.7413815924677565, -1.7425788125675463, -1.7437382855453127, -1.7448599862849647, -1.74594389048862, -1.7469899746771311, null, -1.282670431887766, -1.293544114112432, -1.3040105269626325, -1.3140663751124737, -1.3237084925014078, -1.3329338433310614, -1.3417395230210498, -1.3501227591234752, -1.3580809121958275, -1.3656114766320064, null, -1.5902261573181184, -1.604451137965527, -1.6182802443025606, -1.6317100642041598, -1.644737284063218, -1.657358689608166, -1.6695711666960436, -1.6813717020808685, -1.6927573841571102, -1.7037254036780831, null, -1.7214158096339078, -1.7295745054091423, -1.7375435338493255, -1.7453220210606868, -1.7529091140444466, -1.7603039807903615, -1.7675058103679597, -1.7745138130154712, -1.781327220226432, -1.7879452848339623, null, -1.7580448217335038, -1.764094532462995, -1.770058263713741, -1.775935724821893, -1.7817266293282887, -1.787430694992412, -1.7930476438061504, -1.7985772020073425, -1.8040191000931227, -1.809373072833056, null, -1.9592489689150685, -1.9632876669578654, -1.9672838369619894, -1.9712373923638278, -1.97514824752287, -1.979016317723565, -1.9828415191771516, -1.986623769023478, -1.9903629853327942, -1.9940590871075268, null, -1.6517896459746535, -1.656427622837634, -1.6610297187550007, -1.6655958340377888, -1.6701258697764354, -1.6746197278429167, -1.679077310892881, -1.6834985223677492, -1.687883266496813, -1.6922314482993048, null, -0.5394296126846749, -0.5535258218450917, -0.5673585826931681, -0.5809213115839204, -0.5942075533929511, -0.6072109845887402, -0.6199254162423014, -0.6323447969727789, -0.6444632158275767, -0.6562749050956511, null, -0.9096448493523941, -0.924078539637985, -0.9382491990034044, -0.9521527938936972, -0.9657853667714892, -0.9791430372434643, -0.9922220031648864, -1.0050185417218453, -1.0175290104909245, -1.0297498484759846, null, -1.2861307217226006, -1.2904658046604551, -1.2947729339873488, -1.2990520164037789, -1.3033029592177845, -1.3075256703469564, -1.311720058320428, -1.3158860322808608, -1.320023501986409, -1.324132377812677, null, -0.983855059789419, -0.997183696375361, -1.0103489800691707, -1.0233487542098703, -1.0361808892493003, -1.0488432831009784, -1.0613338614844423, -1.073650578265053, -1.085791415789177, -1.09775438521471, null, -1.6529658881369862, -1.663316075724527, -1.6735851956331267, -1.6837727473603674, -1.6938782343793508, -1.7039011641628958, -1.7138410482075461, -1.7236974020573759, -1.7334697453276038, -1.7431576017280055, null, -1.6815811848925746, -1.6889124563802314, -1.6962071432473724, -1.7034650874790855, -1.7106861318563662, -1.7178701199595232, -1.7250168961715606, -1.732126305681557, -1.7391981944880137, -1.7462324094021933, null, -1.0242817126429178, -1.0295651378630069, -1.0348262610095205, -1.0400649681178806, -1.0452811457090785, -1.0504746807921324, -1.0556454608665327, -1.0607933739246826, -1.0659183084543218, -1.071020153440942, null, 0.19441011044703568, 0.1547187851037835, 0.1136429579774296, 0.0715501963020411, 0.028817167355325548, -0.014173732150292325, -0.05703779794646672, -0.0993914607369034, -0.14085571856902795, -0.18105952833475866, null, -0.14682753379377722, -0.15782517026652582, -0.1687351917430645, -0.17955154163882783, -0.1902682153700502, -0.2008792636871494, -0.21137879597738873, -0.22176098353499063, -0.23202006279688112, -0.2421503385422714, null, -0.2738480085514164, -0.28444277624569203, -0.2949450275345627, -0.30535134650938495, -0.31565834846397034, -0.3258626809954773, -0.3359610250947968, -0.34595009622607586, -0.35582664539503, -0.3655874602056933, null, -0.5517756795315463, -0.5578321551618055, -0.5638614428398059, -0.5698632487065721, -0.5758372802425534, -0.5817832462818812, -0.5877008570265587, -0.5935898240605871, -0.599449860364021, -0.6052806803269585, null, -0.5877065641622357, -0.5916357807216661, -0.5955521814773884, -0.5994556815937226, -0.603346196514439, -0.6072236419645883, -0.6110879339523266, -0.6149389887707365, -0.6187767229996396, -0.6226010535074021, null, -0.2803229625056545, -0.28574510834157135, -0.29114829826475513, -0.2965321738354863, -0.30189637789532975, -0.30724055459083144, -0.312564349397122, -0.31786740914143713, -0.32314938202654686, -0.328409917654092, null, -0.6268131129739796, -0.6360971955275824, -0.6453502756012743, -0.6545719022129877, -0.6637616259136491, -0.672918998809092, -0.6820435745818803, -0.6911349085130631, -0.7001925575038511, -0.7092160800972108, null, -0.7863917405719261, -0.7933841961235459, -0.8003594656690893, -0.8073173981127493, -0.8142578427342692, -0.8211806491922083, -0.828085667527198, -0.8349727481651872, -0.8418417419206876, -0.8486925000000003, null, -0.17103166131220568, -0.17530398011283216, -0.17956775484478502, -0.18382277769769914, -0.1880688412877634, -0.19230573866782888, -0.19653326333749463, -0.20075120925317239, -0.20495937083812885, -0.2091575429925052, null, -0.2418413350527494, -0.24530288434579675, -0.24875911997507114, -0.2522099670728264, -0.25565535088804064, -0.25909519678803616, -0.2625294302600958, -0.2659579769130756, -0.26938076247901854, -0.2727977128147622, null, 0.4331949857219327, 0.41880526733216916, 0.4042595019300055, 0.3895631092735277, 0.37472156524459793, 0.3597403998085382, 0.34462519495366384, 0.3293815826114317, 0.3140152425579805, 0.29853190029784415, null, 0.4100829379815262, 0.39360500242708796, 0.3769875713532892, 0.36023653405819184, 0.34335782719055025, 0.3263574326458335, 0.309241375446213, 0.2920157216052652, 0.27468657597814655, 0.25726008009800505, null, 0.3964830276007422, 0.37265158615828103, 0.3486110304002523, 0.32437485074116096, 0.29995664737032524, 0.27537012262009736, 0.250629073276769, 0.22574738283847012, 0.20073901372441436, 0.17561799943985087, null, 0.36491565007325794, 0.33000658804354466, 0.29482455414139147, 0.2593986499242178, 0.2237581786718893, 0.18793262114789655, 0.15195161121372164, 0.11584491131657079, 0.07964238787073799, 0.0433739865529769, null, 0.23324360300087432, 0.19233137295061553, 0.1512506663362202, 0.1100374686352342, 0.06872788138345687, 0.0273580905510662, -0.014035665155211973, -0.055417126036135134, -0.09675004316236223, -0.13799821012743796, null, 0.017110111877635517, -0.01858868598960875, -0.05427625352790567, -0.08993103014265334, -0.12553147504984108, -0.1610560802898851, -0.1964833837216305, -0.23179198198867654, -0.2669605434501825, -0.3019678210683514, null, -0.2943994678784966, -0.3015790793647219, -0.30875215815226764, -0.31591854886045373, -0.32307809625347506, -0.33023064524376483, -0.3373760408953519, -0.3445141284272194, -0.3516447532166552, -0.35876776080260375, null, 0.09690994598374955, 0.07942948756766234, 0.06193880661786506, 0.04444015417589239, 0.026935782309206947, 0.009427943821357315, -0.008081108037955254, -0.025589119862869235, -0.04309383838137532, -0.06059301074531001, null, 0.03324808109471824, 0.012007014838149789, -0.009236201210531234, -0.030477763566535438, -0.051713869041156886, -0.0729407154227177, -0.09415450215732885, -0.115351431029363, -0.13652770684150312, -0.15767953809425253, null, -0.08997937781002485, -0.10795354255856462, -0.12591586898463777, -0.14386438731673348, -0.16179712929755524, -0.17971212839986164, -0.1976074200421181, -0.215481041803933, -0.23333103364126417, -0.2511554381013541, null, -0.03639614565158387, -0.04852543476227079, -0.060652358811726564, -0.07277632675078197, -0.08489674767434285, -0.0970130308501943, -0.1091245857477867, -0.12123082206702158, -0.1333311497670201, -0.14542497909488117, null, -0.14127207593640406, -0.15172133184584555, -0.16216730122179782, -0.17260975778738824, -0.18304847534184077, -0.19348322776537016, -0.20391378902408372, -0.21433993317487643, -0.22476143437032406, -0.2351780668635769, null, 0.29078840945308065, 0.2780415901184265, 0.2652706795623755, 0.2524767843346118, 0.23966101297635223, 0.22682447592429325, 0.2139682854144, 0.20109355538553209, 0.18820140138292618, 0.17529294046153943, null, 0.23290090285219572, 0.22555777622001533, 0.2182097636355661, 0.21085702426888164, 0.20349971739238554, 0.19613800237744006, 0.18877203869089637, 0.18140198589163747, 0.1740280036271247, 0.1666502516299366, null, 0.3596788807743458, 0.3525377837300363, 0.3453890501377297, 0.3382328348507487, 0.3310692928844828, 0.3238985794130278, 0.3167208497658264, 0.3095362594243042, 0.30234496401849903, 0.29514711932369386, null, 0.5260040925701199, 0.5184638403548222, 0.510912357360345, 0.5033498071642256, 0.4957763535837346, 0.488192160672327, 0.4805973927160917, 0.47299221423018806, 0.46537678995528636, 0.4577512848539961, null, 0.4886862181850857, 0.483270244633531, 0.4778438026539411, 0.47240700979197114, 0.46695998381749326, 0.46150284272204495, 0.4560357047162747, 0.45055868822737977, 0.44507191189654244, 0.4395754945763582, null, 0.5009017973081453, 0.4927972242082082, 0.484638610339317, 0.47642685038542093, 0.4681628448585378, 0.45984749999999985, 0.451481727681077, 0.44306644530297706, 0.43460257569624466, 0.42609104701956124, null, 0.5942925987333141, 0.5883086151714394, 0.5822959582776408, 0.5762549211003328, 0.5701857980711451, 0.5640888849905714, 0.5579644790135541, 0.551812878635, 0.5456343836752331, 0.5394292952653812, null, 0.8060201354811305, 0.8001001852641102, 0.7941629035616457, 0.7882084189850214, 0.7822368605181619, 0.7762483575148419, 0.7702430396958816, 0.7642210371463383, 0.758182480312688, 0.7521274999999998, null, 0.3044899921867922, 0.2980126035630234, 0.290855048804725, 0.28303366388659884, 0.27456629986958275, 0.26547228215865704, 0.2557723663956966, 0.24548869108803612, 0.23464472708086503, 0.2232652239887754, null, 0.427814065513073, 0.41974404425319584, 0.41149624649950434, 0.4030741654869506, 0.39448136826562996, 0.3857214941900083, 0.3767982533775271, 0.3677154251372361, 0.3584768563691225, 0.34908645993481235, null, 0.5247916674508968, 0.5187321769870175, 0.5125651395190434, 0.5062918336381884, 0.4999135599679404, 0.49343164089440705, 0.48684742029215033, 0.48016226324556555, 0.4733775557658625, 0.46649470450370895, null, 0.5951044735248806, 0.5892197886115195, 0.5832704891084335, 0.5772572274233558, 0.5711806629781935, 0.5650414621367146, 0.558840298131474, 0.5525778509899852, 0.5462548074601492, 0.539871860934943, null, 0.6219144684717433, 0.617275822128109, 0.6126070906317506, 0.6079085015300544, 0.6031802838256247, 0.5984226679651218, 0.5936358858280308, 0.5888201707153596, 0.5839757573382693, 0.5791028818066333, null, 0.7055510075237854, 0.7021900886288651, 0.6988139591421666, 0.6954226921962053, 0.692016361251399, 0.6885950400944757, 0.6851588028368771, 0.6817077239131515, 0.6782418780793421, 0.6747613404113679, null, 0.8181542677222755, 0.812731271979229, 0.8072421886865068, 0.8016874641909848, 0.7960675501771797, 0.7903829036305167, 0.7846339868001723, 0.7788212671614855, 0.7729452173779441, 0.7670063152627508, null, 1.0246211155202527, 1.0185737346521155, 1.012448785450516, 1.0062467343540493, 0.9999680536729194, 0.9936132215529683, 0.987182721939266, 0.9806770445392546, 0.9740966847854563, 0.9674421437977426, null, 1.0491712821749588, 1.0438381906408094, 1.0384358524071668, 1.0329646258572514, 1.0274248739442335, 1.0218169641671562, 1.016141268546555, 1.0103981635997799, 1.0045880303160166, 0.998711254131013, null, 1.0720052159475484, 1.0676582328598574, 1.063259213616138, 1.0588083726183821, 1.0543059267943007, 1.0497520955867508, 1.0451471009430418, 1.040491167304115, 1.0357845215936083, 1.0310273932067928, null, 1.103107993439416, 1.100273561950699, 1.0974152967276898, 1.094533259685112, 1.0916275132526267, 1.0886981203734785, 1.0857451445031336, 1.082768649607904, 1.0797687001635634, 1.0767453611539481, null, 0.507900696104816, 0.5054064400635909, 0.5028167089942917, 0.5001319921163403, 0.4973527965926834, 0.49447964743398476, 0.4915130873994474, 0.48845367689428215, 0.4853019938638428, 0.48205863368444835, null, 0.7876014712039423, 0.7837350249150427, 0.7796095369971702, 0.7752263710146374, 0.7705869757000137, 0.7656928844752866, 0.7605457149450329, 0.7551471683617643, 0.7494990290636265, 0.743603163884636, null, 1.0807459910222021, 1.0770417394070366, 1.072952454268591, 1.0684795974925172, 1.063624768088157, 1.058389701616912, 1.0527762695717935, 1.046786478708379, 1.0404224703274145, 1.0336865195093163, null, 1.0973429793822203, 1.0945057019534015, 1.0915958166164639, 1.0886135164089468, 1.0855589991722856, 1.0824324675386883, 1.0792341289176925, 1.0759641954824066, 1.072622884155434, 1.069210416594483, null, 1.1874494179149948, 1.1851059007629954, 1.1827046232213279, 1.180245702324872, 1.177729257917963, 1.1751554126485515, 1.1725242919622243, 1.169836024096092, 1.1670907400725379, 1.1642885736928321, null, 1.2320910530294806, 1.2306053669938333, 1.22909302402272, 1.227554056875976, 1.2259884988901601, 1.2243963839778318, 1.2227777466268182, 1.221132621899465, 1.2194610454318786, 1.2177630534331538, null, 1.236921651825659, 1.2354534912216395, 1.2338912460510105, 1.2322350352847908, 1.2304849850498423, 1.2286412286192656, 1.226703906402252, 1.2246731659333883, 1.222549161861424, 1.2203320559374924, null, 1.483651151179209, 1.482459664117215, 1.4811698328484346, 1.4797817429383882, 1.4782954864709315, 1.4767111620421451, 1.475028874753796, 1.473248736206363, 1.471370864491635, 1.4693953841848761, null, 1.5325049724371058, 1.531794513915719, 1.531009397890764, 1.5301496626276876, 1.529215350028774, 1.528206505631101, 1.5271231786043213, 1.5259654217482663, 1.524733291490371, 1.5234268478829267, null, 1.5451784260469377, 1.5448602747839248, 1.5445086593074824, 1.5441235872341799, 1.543705066905311, 1.5432531073867146, 1.542767718468577, 1.54224891066522, 1.5416966952148734, 1.541111084079432, null ], "y": [ 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, null, -0.1712505446874615, -0.1658231417686627, -0.1601153366595365, -0.15413678109528392, -0.1478975846423826, -0.14140829760359847, -0.1346798931777259, -0.12772374890422236, -0.1205516274241142, -0.11317565658970795, null, -0.28170032594180267, -0.27084182767759946, -0.2597035246305426, -0.2482969237029893, -0.2366338089739472, -0.2247262295250218, -0.21258648699259844, -0.20022712285910832, -0.18766090549650813, -0.17490081697536966, null, -0.5914977660239163, -0.5605711491210412, -0.5290601577908671, -0.4969976410616404, -0.4644170229061822, -0.4313522673986424, -0.3978378433082288, -0.3639086881668037, -0.32960017184781976, -0.2949480596945455, null, -0.4225965501513128, -0.40003832719561416, -0.3773235886861901, -0.3544612217961801, -0.33146017145853107, -0.3083294368662829, -0.28507806795162116, -0.2617151618450785, -0.2382498593162693, -0.21469134119755137, null, -0.3924952011834959, -0.3629691075642855, -0.333283803698255, -0.3034523105407897, -0.2734877131707311, -0.24340315505081983, -0.2132118322625538, -0.18292698771794175, -0.15256190535072314, -0.12212990428959827, null, -0.24071634488028615, -0.21793274114763905, -0.19510665099529517, -0.17224252441475563, -0.14934481881280298, -0.1264179981425137, -0.10346653203300003, -0.08049489491806029, -0.05750756516386437, -0.03450902419589474, null, -0.07339441139982548, -0.06524348139984848, -0.05709113811879556, -0.048937558149831584, -0.04078291811289913, -0.032627394650911426, -0.024471164425911903, -0.016314404115258297, -0.008157290407789331, -4.2928156573911747e-16, null, -0.3807560205184738, -0.3621602471884462, -0.3435330940828505, -0.32487617517199313, -0.30619110700526664, -0.2874795085710867, -0.2687430011566207, -0.24998320820728975, -0.23120175518612648, -0.21240026943292273, null, -0.2580216479403288, -0.24851288602695656, -0.2389987409158992, -0.22947941869917635, -0.2199551255809668, -0.21042606787310916, -0.2008924519906636, -0.19135448444742595, -0.18181237185145263, -0.17226632090058866, null, -0.42247551618323403, -0.413220305096749, -0.4039561429790856, -0.39468323050722803, -0.38540176854770586, -0.3761119581522447, -0.3668140005534126, -0.3575080971602544, -0.3481944495539406, -0.3388732594833872, null, -0.5239987511114946, -0.5159154065505891, -0.5078208864137687, -0.4997153660416492, -0.4915990210131294, -0.48347202714158355, -0.4753345604710636, -0.467186797272473, -0.4590289140397598, -0.45086108748608866, null, -0.5925903393069248, -0.585617930639361, -0.5786328365246166, -0.5716352082713104, -0.5646251974595802, -0.5576029559377813, -0.5505686358192116, -0.5435223894788097, -0.5364643695498574, -0.5293947289206677, null, -0.9346775847716635, -0.9197554263530651, -0.9047208883648941, -0.8895758077899616, -0.8743220351176355, -0.8589614341177354, -0.8434958816128181, -0.8279272672488497, -0.8122574932643314, -0.7964884742578647, null, -0.8993130192170823, -0.8871886616821429, -0.8750054493484414, -0.8627641904324718, -0.850465697001457, -0.8381107849194697, -0.825700273793316, -0.8132349869181573, -0.8007157512229025, -0.7881433972153444, null, -1.0832881729637107, -1.0695052433627394, -1.0556701875850516, -1.0417836799317495, -1.0278463972116285, -1.0138590187081773, -0.9998222261464994, -0.9857367036600581, -0.9716031377573473, -0.957422217288428, null, -0.9998266724982913, -0.9904416545451917, -0.9810351819974851, -0.9716074586148334, -0.9621586886172275, -0.9526890766805559, -0.9431988279321858, -0.9336881479465041, -0.9241572427404795, -0.9146063187691845, null, -1.1659631546362261, -1.1584814255436826, -1.1509746018388243, -1.1434428461317903, -1.1358863215727986, -1.128305191848588, -1.1206996211788955, -1.1130697743128855, -1.1054158165255867, -1.097737913614306, null, -1.13086752692982, -1.1220718153239846, -1.1132214155208766, -1.104316758876497, -1.0953582793912506, -1.0863464136887835, -1.0772816009947217, -1.0681642831152451, -1.0589949044155644, -1.0497739117982603, null, -1.2591114510833452, -1.2528573883414464, -1.2465761866487166, -1.2402679820663085, -1.233932911240306, -1.2275711113987586, -1.2211827203487113, -1.2147678764732164, -1.208326718728337, -1.2018593866401412, null, -0.675930966293428, -0.6659469286716094, -0.6555629371489438, -0.644785228135178, -0.6336202744986088, -0.622074781678615, -0.6101556836585091, -0.5978701388011309, -0.5852255255496853, -0.5722294379963972, null, -0.9831545940377012, -0.9790238833769379, -0.9748719654492631, -0.9706989301920474, -0.9665048680000956, -0.9622898697236882, -0.9580540266666189, -0.9537974305842118, -0.9495201736813377, -0.9452223486104112, null, -1.3461972725207279, -1.3314469439929728, -1.3159665731807546, -1.2997646480867866, -1.282850052347372, -1.2652320603614435, -1.2469203322053353, -1.2279249083360988, -1.2082562040862401, -1.187925003952917, null, -1.3459005054845516, -1.3393372598917008, -1.332708736890325, -1.3260152595452859, -1.3192571540872247, -1.312434749896666, -1.3055483794879685, -1.2985983784931086, -1.2915850856453301, -1.284508842762631, null, -1.4976952916129465, -1.4923881233475327, -1.4870486275017574, -1.4816769197378798, -1.4762731164159215, -1.4708373345911478, -1.465369692011528, -1.4598703071151917, -1.4543392990278539, -1.4487767875602477, null, -1.5165644366874076, -1.5073472970275164, -1.4977443400864454, -1.4877580238158201, -1.4773909042910736, -1.4666456350571935, -1.4555249664495347, -1.4440317448898452, -1.4321689121577017, -1.4199395046375392, null, -1.6277313006266767, -1.616570239126936, -1.6050672145894198, -1.593224660319603, -1.5810450814457726, -1.5685310543891018, -1.555685226318641, -1.5425103145913508, -1.5290091061772766, -1.5151844570700133, null, -1.7396525626784172, -1.7336387239275424, -1.7275098781182714, -1.721266431829277, -1.7149087992416576, -1.7084374021114643, -1.7018526697417218, -1.6951550389539483, -1.6883449540591797, -1.68142286682849, null, -1.7166966976969424, -1.7110152882099976, -1.705250486251789, -1.6994025727906297, -1.6934718328455725, -1.687458555472513, -1.6813630337501104, -1.675185564765492, -1.6689264495997818, -1.662585993313421, null, -1.7028977807254289, -1.6987359242201645, -1.6945372703019181, -1.6903019099204397, -1.6860299348205965, -1.681721437540392, -1.6773765114089616, -1.6729952505445493, -1.6685777498524685, -1.6641241050230453, null, 0.12664736547299935, 0.15812221641869315, 0.18397780312700018, 0.20329528334401525, 0.21538816260869137, 0.21982669053225906, 0.2164531330417181, 0.205387377850438, 0.18702267395159877, 0.16201165654211472, null, 0.3586483548360765, 0.35453727249290656, 0.34037997405937204, 0.3165776226580947, 0.2838046849366986, 0.2429898192896878, 0.19528956126861668, 0.1420555518343249, 0.08479623707591624, 0.02513412467841992, null, 0.19885620799411374, 0.16328379010464208, 0.12634746856253393, 0.08835577113918644, 0.0496260411229465, 0.010481786561985834, -0.028750021986844336, -0.06774168263136568, -0.10616749942624687, -0.1437065028995733, null, -0.10117199475687647, -0.11177120233442579, -0.12230252092206728, -0.1327595538758857, -0.1431359496725026, -0.15342540576694405, -0.16362167242075848, -0.17371855649806275, -0.1837099252272038, -0.19358970992576102, null, -0.15878684344636876, -0.17726453055699612, -0.195520986508946, -0.21353342672771375, -0.23127937117734443, -0.2487366724161598, -0.26588354323738794, -0.28269858386021773, -0.29916080863733163, -0.3152496722455884, null, -0.21284084943597759, -0.2499138483476132, -0.28604650655864394, -0.32110286918156905, -0.35495103106264303, -0.38746363309604603, -0.418518341432827, -0.44799830778151456, -0.4757926090684438, -0.5017966648035064, null, -0.2680406899235311, -0.3429204935472434, -0.4133958458820274, -0.4785615655162449, -0.537580667658267, -0.5896951143214695, -0.6342355505209597, -0.6706299014308827, -0.698410720080902, -0.7172211912184646, null, -0.8154619839113875, -0.8364866198639261, -0.8546204016457668, -0.8698006598519846, -0.8819749323012298, -0.8911011453422937, -0.8971477592584536, -0.900093877267092, -0.8999293177378869, -0.8966546493799963, null, -1.120853391479255, -1.122856158301687, -1.1234507103204114, -1.1226363018860874, -1.1204139543779945, -1.1167864549230822, -1.1117583529005344, -1.1053359542362262, -1.0975273134942327, -1.088342223775308, null, -1.1099709636023025, -1.1068946193675602, -1.103597964841614, -1.10008165617267, -1.0963463932277016, -1.092392919453151, -1.0882220217269591, -1.0838345302019483, -1.0792313181405946, -1.0744133017412165, null, -1.2000426304107146, -1.1975034844302521, -1.1945362408479232, -1.1911419604287932, -1.1873218566000683, -1.1830772950173056, -1.178409793076202, -1.1733210193701384, -1.1678127930936713, -1.1618870833921848, null, -1.2467599398208074, -1.2460279620569084, -1.2452010944395053, -1.2442793999377686, -1.243262948742303, -1.2421518182598024, -1.240946093107155, -1.2396458651049995, -1.2382512332707323, -1.2367623038109667, null, -1.3032960808327378, -1.3021371637351205, -1.3008918647617633, -1.2995602665239803, -1.298142457358051, -1.2966385313193631, -1.295048588176171, -1.293372733402979, -1.2916110781735417, -1.2897637393534922, null, -1.2964265532630017, -1.295058470459986, -1.2936272683341745, -1.2921330166403404, -1.2905757882062034, -1.2889556589288802, -1.2872727077711854, -1.2855270167577852, -1.283718670971196, -1.281847758547641, null, -1.2872825306436928, -1.2861256937132237, -1.2849409971857322, -1.2837284667236926, -1.282488128592508, -1.2812200096599418, -1.2799241373955355, -1.278600539870012, -1.2772492457546702, -1.275870284320762, null, -1.1903382839568095, -1.191317791407211, -1.1922182685770177, -1.1930396557298897, -1.1937818983762045, -1.1944449472766703, -1.195028758445592, -1.1955332931537903, -1.1959585179311705, -1.196304404568942, null, -1.382940686914845, -1.3835144059078663, -1.3840206943605915, -1.3844595275972353, -1.3848308842296853, -1.3851347461585428, -1.3853710985740062, -1.3855399299565925, -1.3856412320776976, -1.3856749999999998, null, -1.4077761836906777, -1.4078981824977443, -1.4079896839154773, -1.4080506859618056, -1.4080811873153245, -1.4080811873153245, -1.4080506859618056, -1.4079896839154773, -1.4078981824977443, -1.4077761836906777, null, -0.7234501784555493, -0.7557226172899647, -0.7856260693300621, -0.8130667953104466, -0.8379587759483975, -0.860223981591149, -0.879792616817822, -0.8966033392292699, -0.9106034517399682, -0.9217490677691821, null, -1.1438091542938342, -1.1460516682042707, -1.1482069058430542, -1.1502747030804938, -1.1522549024458242, -1.1541473531391973, -1.1559519110431653, -1.157668438733658, -1.1592968054904451, -1.1608368873070944, null, -1.3507651643700271, -1.3536682530373778, -1.356481541331862, -1.3592048426240475, -1.361837976254108, -1.3643807675438078, -1.3668330478080908, -1.3691946543662687, -1.371465430552816, -1.3736452257277592, null, -1.3487530802804666, -1.3515630690198688, -1.3543071844820584, -1.3569852929227189, -1.3595972638146225, -1.3621429698539937, -1.3646222869667113, -1.3670350943143572, -1.369381274300105, -1.3716607125744524, null, -1.3399387705256602, -1.3419505661898083, -1.3439332929984156, -1.3458869080023594, -1.3478113688831264, -1.3497066339537307, -1.3515726621596142, -1.3534094130795384, -1.355216846926459, -1.3569949245483865, null, -0.6078851700892887, -0.6448581234449596, -0.6803187000646455, -0.7141837347540573, -0.746373804321077, -0.7768134138458564, -0.8054311737379966, -0.8321599671655578, -0.8569371074632234, -0.8797044851504611, null, -1.010936983009223, -1.0225531041005937, -1.0338092730229405, -1.0447015274564557, -1.0552260331840286, -1.0653790854409386, -1.075157110218983, -1.084556665524573, -1.0935744425903642, -1.102207267039982, null, -1.0875438932324983, -1.090897756848311, -1.0941984516464822, -1.097445816755804, -1.100639693904282, -1.1037799274268503, -1.1068663642729568, -1.1098988540140244, -1.112877248850781, -1.1158014036204644, null, -1.1393898934120479, -1.1418729280750142, -1.1443312278930258, -1.1467647396152663, -1.1491734105278708, -1.1515571884550668, -1.1539160217603066, -1.1562498593473813, -1.1585586506615329, -1.1608423456905452, null, -1.120419575197568, -1.1296788897194827, -1.1387775212851792, -1.147714175725994, -1.1564875819125222, -1.1650964919354208, -1.1735396812829062, -1.1818159490149256, -1.1899241179339797, -1.197863034752559, null, -1.2301587751866627, -1.2334510117764355, -1.2367165297893972, -1.2399552584890603, -1.2431671277192353, -1.246352067905555, -1.2495100100569778, -1.252640885767286, -1.2557446272165629, -1.258821167172667, null, -1.2692503082316335, -1.2788204369494354, -1.2882654775382536, -1.2975845061291686, -1.3067766111791548, -1.3158408935602441, -1.324776466647471, -1.3335824564056031, -1.3422580014746315, -1.3508022532540265, null, -1.4121939342830183, -1.4246134922667963, -1.4368768253272146, -1.4489825886516037, -1.4609294547065985, -1.4727161133837061, -1.484341272142978, -1.4958036561547556, -1.5071020084394589, -1.5182350900054418, null, -1.4202969597659185, -1.43571932512391, -1.4509473170675924, -1.465978873970618, -1.480811960800801, -1.4954445693956249, -1.5098747187341184, -1.5241004552050519, -1.538119852871426, -1.5519310137312123, null, -1.3632065610727284, -1.3761052051311202, -1.3888846150305239, -1.40154368348482, -1.4140813136350063, -1.4264964191442389, -1.438787924291956, -1.4509547640670861, -1.4629958842603286, -1.4749102415554904, null, -1.4584031413787495, -1.4644990109403373, -1.4705631570455913, -1.4765954483351376, -1.482595754139627, -1.4885639444825725, -1.4944998900831576, -1.5004034623590436, -1.5062745334291465, -1.5121129761164172, null, -1.4672411531699023, -1.474497222570328, -1.4817213519367178, -1.488913384782553, -1.4960731653165769, -1.5032005384461722, -1.5102953497807197, -1.5173574456349401, -1.524386673032228, -1.53138287970796, null, -0.5900887563425598, -0.5991867704312791, -0.6082134872863646, -0.6171678328187798, -0.6260487415509528, -0.6348551567435565, -0.6435860305212495, -0.6522403239973631, -0.6608170073975197, -0.6693150601821644, null, -0.5835706645893229, -0.5952289293290591, -0.6067940688054434, -0.6182642736194249, -0.6296377492247519, -0.640912716208733, -0.6520874105706336, -0.6631600839976522, -0.6741290041384587, -0.6849924548742163, null, -0.5522508462091885, -0.5631844056663087, -0.574049152894347, -0.5848437603929888, -0.595566909231886, -0.6062172892118101, -0.616793599024735, -0.6272945464128377, -0.6377188483263938, -0.6480652310805409, null, -0.7346466503247631, -0.7397849857920323, -0.7449072963002421, -0.7500134708917252, -0.7551033989583444, -0.7601769702438903, -0.7652340748464662, -0.7702746032208739, -0.7752984461809804, -0.7803054949020881, null, -0.515526642026744, -0.5237502514191305, -0.5319391159855523, -0.5400926924887058, -0.548210440032246, -0.5562918200966683, -0.5643362965750348, -0.5723433358085371, -0.5803124066218981, -0.5882429803586104, null, -0.4834958034331761, -0.49065713248083515, -0.49779454759207087, -0.5049077008993405, -0.5119962457175866, -0.5190598365611355, -0.5260981291605348, -0.5331107804793319, -0.5400974487307961, -0.547057793394573, null, -0.4661140919152209, -0.4709815634846516, -0.475838832819086, -0.48068579470208234, -0.48552234414047835, -0.4903483763666614, -0.4951637868408393, -0.49996847125330457, -0.5047623255266921, -0.5095452458182387, null, -0.11042917590249046, -0.11284596622475576, -0.11526031211786478, -0.11767216128311564, -0.12008146147589036, -0.12248816050678592, -0.1248922062427438, -0.12729354660818207, -0.12969212958611925, -0.13208790321930505, null, 0.504440753057181, 0.469459883645633, 0.4323943558199218, 0.39340876077761083, 0.3526762158639037, 0.31037759583603197, 0.26670072968049807, 0.2218395665497376, 0.17599331452190045, 0.12936555600812968, null, 0.3265564561292211, 0.29077664452102153, 0.254470648471097, 0.217704166688827, 0.18054373117069514, 0.1430565868051255, 0.105310569687286, 0.06737398436404624, 0.029315480231241153, -0.008796072693102569, null, 0.11434139510018615, 0.08604545875413908, 0.05771125402566117, 0.029351382441875656, 0.0009784569451438021, -0.027394903716502203, -0.055756080601487484, -0.08409246018692673, -0.11239143997843641, -0.1406404341150461, null, -0.10522215495903978, -0.12078531999579756, -0.13633801945478327, -0.15187890575513305, -0.16740663233954733, -0.18291985379096692, -0.19841722594914288, -0.21389740602710816, -0.22935905272752244, -0.24480082635888908, null, -0.2264677530581797, -0.23480876705678017, -0.24314469471144196, -0.2514753554522664, -0.2598005688234439, -0.2681201544871687, -0.27643393222753565, -0.2847417219544495, -0.2930433437075271, -0.30133861765999326, null, -0.07973061656558919, -0.08858349654482542, -0.09743445765988876, -0.1062833081844089, -0.11512985643773355, -0.12397391078908647, -0.13281527966170836, -0.14165377153701264, -0.15048919495873497, -0.15932135853707868, null, 0.2382825133417851, 0.21566833835291724, 0.19301034830170188, 0.17031314637307726, 0.1475813437182474, 0.12481955851787743, 0.10203241504387087, 0.07922454271990574, 0.056400575180921925, 0.03356514933175236, null, 0.0736184461472765, 0.06544263562153102, 0.057265407500704114, 0.049086938917002464, 0.04090740702950012, 0.03272698902030792, 0.024545862090726112, 0.016364203457416, 0.008182190348555681, 2.1529596890710257e-16, null, 0.3703927371605078, 0.3456467591975322, 0.3208276644513129, 0.2959407030574936, 0.2709911395079693, 0.24598425153725095, 0.22092532900603937, 0.19581967278222281, 0.17067259361955858, 0.1454894110342474, null, 0.4323958633640973, 0.41866513611363726, 0.4049066352301296, 0.391121273432406, 0.37730996522121707, 0.36347362681855544, 0.349613176106883, 0.3357295325682362, 0.3218236172232305, 0.3078963525699581, null, 0.3661044194518145, 0.35407107361869056, 0.34202047086095666, 0.32995319850799193, 0.31786984470162793, 0.3057709983674792, 0.29365724918624925, 0.28152918756498263, 0.2693874046082933, 0.25723249208955073, null, 0.2936589168737164, 0.2855750503485162, 0.2774849977982156, 0.26938893446665535, 0.26128703572787687, 0.25317947708232713, 0.2450664341530558, 0.23694808268191056, 0.22882459852573292, 0.22069615765254477, null, 0.6242151457517289, 0.6013581377765529, 0.5783117935816607, 0.5550833692552531, 0.5316801782130406, 0.5081095888956295, 0.4843790224485841, 0.4604959503859019, 0.4364678922376185, 0.41230241318230415, null, 0.9181175000000007, 0.8930260472719288, 0.8677142537293283, 0.8421883646785064, 0.8164546782506359, 0.7905195438477806, 0.7643893605762786, 0.738070575667858, 0.7115696828888777, 0.684893220938091, null, 0.788125691350966, 0.7700561831864746, 0.7519022296837525, 0.7336658216283759, 0.715348958847997, 0.6969536499930297, 0.6784819123163874, 0.6599357714522636, 0.6413172611939999, 0.6226284232710567, null, 0.8727010284175293, 0.8604063927930612, 0.8480698221748594, 0.8356919178299727, 0.8232732830399971, 0.8108145230716725, 0.7983162451473804, 0.7857790584155568, 0.7732035739209951, 0.760590404575068, null, 0.8723138426221616, 0.8631856689010441, 0.8540387971591888, 0.8448734255328769, 0.835689752559128, 0.8264879771713941, 0.8172682986952611, 0.808030916844122, 0.7987760317148535, 0.7895038437834854, null, 1.0003593676654048, 0.9926607826067597, 0.9849406948835463, 0.9771992717255586, 0.9694366808247488, 0.9616530903315996, 0.9538486688514753, 0.9460235854409788, 0.9381780096042799, 0.9303121112894518, null, 0.6520583893976534, 0.6401356221737046, 0.6279081850632301, 0.6153818976640586, 0.6025627218105707, 0.5894567587361882, 0.5760702461695184, 0.5624095553655317, 0.5484811880731904, 0.5342917734409675, null, 0.8632207303301167, 0.8477515165456969, 0.8320409976644602, 0.8160936455489813, 0.7999139994743562, 0.7835066648361352, 0.7668763118394389, 0.7500276741696239, 0.7329655476448809, 0.7156947888511463, null, 0.9344286659056978, 0.92843264269792, 0.9224165081126812, 0.916380392469348, 0.9103244265201093, 0.904248741447143, 0.898153468859778, 0.8920387407916393, 0.8859046896977895, 0.87975144845186, null, 1.0476992252320123, 1.0350213142289255, 1.0221738519929895, 1.009158943121502, 0.9959787196419055, 0.9826353406625274, 0.9691309920188925, 0.9554678859156477, 0.9416482605641741, 0.927674379815932, null, 1.4883371707649125, 1.4767611159091907, 1.465113085800079, 1.4533936481461314, 1.4416033741362055, 1.4297428384116244, 1.4178126190381646, 1.4058132974778883, 1.3937454585607993, 1.381609690456342, null, 1.5791098412207698, 1.5712663322010987, 1.5633887869693797, 1.5554773761661955, 1.5475322711657107, 1.5395536440719608, 1.5315416677151281, 1.5234965156477918, 1.5154183621411725, 1.5073073821813558, null, 1.1375800887719034, 1.132800561494444, 1.1279964958944049, 1.1231679960357457, 1.1183151665117115, 1.1134381124425676, 1.108536939473325, 1.103611753771447, 1.0986626620245532, 1.0936897714381082, null, 0.41084995385295026, 0.4273816481331519, 0.44008891570583797, 0.44885804552680053, 0.45361056699620117, 0.4543039521531061, 0.45093199623714664, 0.4435248732118465, 0.4321488657527667, 0.41690577211666746, null, 0.46852723009984937, 0.4649379589314494, 0.4610905823072417, 0.4569872360582079, 0.4526301981141958, 0.44802188723934977, 0.4431648616893598, 0.43806181779127196, 0.43271558844665087, 0.42712914155892395, null, 0.5899550325553833, 0.5849204896963716, 0.5796956985847282, 0.5742823586093391, 0.568682230485531, 0.5628971356823906, 0.5569289558303224, 0.5507796321090395, 0.5444511646161844, 0.5379456117167892, null, 0.8694593462045827, 0.8655860684487334, 0.8616706032490677, 0.8577131414398357, 0.8537138759021425, 0.8496730015545486, 0.8455907153435689, 0.8414672162340737, 0.8373027051995925, 0.8330973852125177, null, 0.8455989268356603, 0.8428544676246694, 0.8400917508001873, 0.837310836207203, 0.8345117840848983, 0.831694655065344, 0.8288595101721866, 0.8260064108193255, 0.823135418809583, 0.8202465963333669, null, 0.6668619759118474, 0.66455668778808, 0.6622073139452154, 0.6598140102372796, 0.6573769354325417, 0.6548962512029812, 0.6523721221135632, 0.6498047156113214, 0.6471942020142492, 0.6445407545000025, null, 1.3320456694231129, 1.3276372629099202, 1.32316414922955, 1.3186265463952522, 1.3140246755633884, 1.3093587610226498, 1.3046290301831287, 1.2998357135652334, 1.2949790447884537, 1.2900592605599737, null, 1.5042286623333756, 1.5005523501585656, 1.496843533552819, 1.4931022928552018, 1.4893287091071379, 1.4855228640506557, 1.4816848401266156, 1.4778147204729268, 1.4739125889227427, 1.4699785300026493, null, 0.6125665766704766, 0.6113576323082912, 0.6101188912376039, 0.6088504138329071, 0.6075522619179999, 0.6062244987629754, 0.6048671890811362, 0.6034803990258415, 0.6020641961872824, 0.6006186495891868, null, 0.7443110955003316, 0.7431774573792135, 0.7420277208125233, 0.7408619107054457, 0.739680052311344, 0.7384821712312144, 0.7372682934131302, 0.7360384451516808, 0.7347926530874016, 0.7335309442061967, null, 0.7413243706842332, 0.7495477745146271, 0.757491896540355, 0.7651537767783293, 0.7725305604088673, 0.7796194988393972, 0.7864179507285862, 0.7929233829705039, 0.7991333716384597, 0.8050456028881581, null, 0.8714706031768596, 0.8790359095562432, 0.8862896813515028, 0.8932293477907792, 0.8998524494226728, 0.9061566389878849, 0.912139682251098, 0.9177994587927997, 0.9231339627607694, 0.9281413035809621, null, 1.0014018174786528, 1.0105123386474393, 1.019055808436552, 1.027027432657789, 1.0344227380154374, 1.0412375746164717, 1.0474681182992769, 1.053110872779586, 1.058162671612427, 1.0626206799689832, null, 1.2086589450116239, 1.218653161844197, 1.2276393441480806, 1.2356100588140635, 1.242558712698293, 1.2484795580759347, 1.2533676973955226, 1.2572190873300706, 1.2600305421215976, 1.2617997362162914, null, 1.3790189874269936, 1.3853175047634139, 1.3904025251551615, 1.3942695942755656, 1.3969153246870556, 1.3983373988084564, 1.39853457094512, 1.3975066683801174, 1.3952545915255328, 1.39178031313373, null, 1.452284211955957, 1.4522660393255018, 1.451370482174684, 1.4495980815531184, 1.4469499082541908, 1.4434275621681396, 1.4390331713154838, 1.4337693905613835, 1.4276394000117059, 1.4206469030917683, null, 1.5432960568011111, 1.5419091492414614, 1.5404888413946132, 1.5390351640267694, 1.5375481486269724, 1.53602782740642, 1.5344742332977697, 1.5328873999544237, 1.5312673617498016, 1.5296141537765942, null, 1.5403394822552678, 1.5413397466910852, 1.5421416415037092, 1.5427450634896949, 1.543149934988947, 1.543356203894714, 1.5433638436602948, 1.5431728533024562, 1.5427832574015574, 1.542195106098388, null, 1.5872468141812475, 1.5875495946960765, 1.5875681329039706, 1.587302425485762, 1.58675252001495, 1.5859185149491832, 1.5848005596126302, 1.5833988541692452, 1.5817136495869286, 1.5797452475925933, null, 1.7169088070698224, 1.7158724232512323, 1.714647874685308, 1.7132352956575991, 1.7116348410733144, 1.7098466864403346, 1.7078710278499656, 1.7057080819554358, 1.7033580859481365, 1.7008212975316122, null, 1.7375338465211863, 1.7372374130803576, 1.736856309138892, 1.7363905532712576, 1.7358401681777385, 1.7352051806833277, 1.7344856217364197, 1.7336815264073024, 1.7327929338864483, 1.7318198874826025, null, 2.245455346157126, 2.2447735183060056, 2.244043064969886, 2.243264001971587, 2.242436346186894, 2.2415601155441927, 2.240635329024079, 2.239662006658949, 2.2386401695325655, 2.2375698397796016, null, 1.3680519066003116, 1.370699380750359, 1.3732280891350555, 1.375637812651664, 1.3779283425070221, 1.3800994802356352, 1.3821510377168706, 1.3840828371912595, 1.3858947112758975, 1.3875865029789487, null, 1.5772018268045571, 1.578268710521653, 1.5793014063436752, 1.5802998919007343, 1.5812641455639913, 1.5821941464461269, 1.5830898744017925, 1.5839513100280482, 1.5847784346647824, 1.585571230395115, null, 1.533498733599058, 1.5351561400286666, 1.5367802924523588, 1.538371155688323, 1.539928695275846, 1.5414528774760594, 1.542943669272671, 1.5444010383726794, 1.5458249532070742, 1.5472153829315187, null, 1.618874136189866, 1.621304727825565, 1.6237001993353006, 1.6260604988292215, 1.6283855751793603, 1.6306753780207406, 1.6329298577524678, 1.635148965538805, 1.6373326533102288, 1.639480873764472, null, 1.1625385738894682, 1.1648004233673883, 1.1670370413531101, 1.1692483793978115, 1.171434389600274, 1.173595024607923, 1.175730237617852, 1.1778399823778367, 1.179924213187337, 1.181982884898487, null, 0.7713211279865667, 0.7765241714445758, 0.7816420602765537, 0.7866742332483172, 0.7916201385253918, 0.7964792337335292, 0.8012509860181825, 0.805934872102941, 0.8105303783469129, 0.815037000801052, null, 0.8550749887090628, 0.8592030624596628, 0.8632892598651531, 0.8673333817700372, 0.8713352310695185, 0.8752946127191084, 0.8792113337441307, 0.8830852032491285, 0.8869160324271675, 0.8907036345690379, null, 1.2700845035760338, 1.2738221220269874, 1.2775321473965093, 1.2812144993193504, 1.2848690980297137, 1.288495864362983, 1.2920947197574368, 1.2956655862559503, 1.2992083865076844, 1.302723043769761, null, 0.1283477069646637, 0.14274374712255594, 0.1568139974932116, 0.17052634497909036, 0.1838494933387806, 0.19675303461566823, 0.20920751853923766, 0.22118451974060643, 0.23265670262888688, 0.24359788378030275, null, 0.3877480671443457, 0.39646989234867647, 0.40502379848821113, 0.4134061626802367, 0.4216134346961401, 0.4296421384650571, 0.43748887354611066, 0.4451503165686189, 0.4526232226396602, 0.4599044267184004, null, 0.4170644050972311, 0.4245773672527888, 0.43200230320546146, 0.4393376735681574, 0.44658195752311836, 0.4537336531372263, 0.46079127767339323, 0.46775336789797256, 0.47461848038412663, 0.48138519181108713, null, 0.5588402981314738, 0.5650414621367146, 0.5711806629781934, 0.5772572274233558, 0.5832704891084335, 0.5892197886115194, 0.5951044735248805, 0.6009238985265019, 0.6066774254508528, 0.61236442335887, null, 0.6622716428554893, 0.6665972505501856, 0.6708903692353185, 0.6751507896703399, 0.6793783042083686, 0.68357270680631, 0.6877337930348988, 0.6918613600886628, 0.695955206795807, 0.7000151336280184, null, 0.7204849672319131, 0.7237609354312972, 0.727021225778897, 0.7302657676514637, 0.7334944907668857, 0.7367073251857124, 0.7399042013126679, 0.7430850498981595, 0.7462498020397772, 0.7493983891837863, null, 0.5977026809650655, 0.6050560140780554, 0.6123601468332324, 0.6196144852922888, 0.6268184395659586, 0.6339714238619854, 0.6410728565327553, 0.6481221601225943, 0.6551187614147241, 0.6620620914778744, null, 0.688516815956613, 0.6974319918829657, 0.7062940556629189, 0.7151023324160048, 0.7238561513578458, 0.7325548458512381, 0.7411977534569171, 0.7497842159840069, 0.7583135795401417, 0.7667851945812642, null, 0.650513755645761, 0.6590374476345943, 0.6675174200426532, 0.6759531103209658, 0.6843439588581718, 0.6926894090176464, 0.700988907174427, 0.7092419027519397, 0.7174478482585236, 0.7256061993237506, null, 0.6189224999999999, 0.626391364748562, 0.6338297000657126, 0.6412371434174824, 0.6486133337755327, 0.6559579116347516, 0.663270519030776, 0.670550799557438, 0.6777983983841358, 0.6850129622731272, null, 0.6064387512643507, 0.6115662622294666, 0.6166805256638773, 0.6217814307842287, 0.6268688670965291, 0.631942724398544, 0.6370028927821826, 0.6420492626358785, 0.6470817246469633, 0.6521001698040367, null, 0.17798869942005646, 0.18495249273055975, 0.1918813471423153, 0.198773953743293, 0.20562901046894333, 0.2124452223481668, 0.2192213017479439, 0.22595596861657838, 0.2326479507255084, 0.2392959839096401, null, 0.20552183140091318, 0.2198060766821911, 0.23401767123031084, 0.24815191780132503, 0.2622041447164907, 0.2761697074063614, 0.29004398994591946, 0.30382240658024057, 0.3175004032401864, 0.33107345904762436, null, 0.18570612567828262, 0.2061061711838466, 0.22643253543606914, 0.24667795192766714, 0.26683518308951326, 0.28689702287800695, 0.3068562993511754, 0.3267058772325837, 0.34643866046213734, 0.36604759473286463, null, 0.34388644466677065, 0.3528126551251979, 0.3617154605078904, 0.37059427021575464, 0.37944849524153534, 0.388277548208889, 0.3970808434113498, 0.4058577968511842, 0.41460782627813275, 0.4233303512280356, null, 0.33154183464283954, 0.3398236486793246, 0.3480889001905928, 0.3563371863399459, 0.36456810511755355, 0.3727812553600467, 0.3809762367700695, 0.3891526499357894, 0.3973100963503639, 0.4054481784313634, null, 0.31634721441748936, 0.32207817956355356, 0.32780216796672534, 0.3335190556360052, 0.33922871873420707, 0.34493103358064126, 0.35062587665379286, 0.3563131245939984, 0.3619926542061171, 0.3676643424621998, null, 0.1628438247827753, 0.17363166489227283, 0.18440628227824657, 0.19516685641186685, 0.20591256783375214, 0.216642598216374, 0.2273561304263757, 0.2380523485868004, 0.2487304381392231, 0.2593895859057824, null, 0.14024632554761574, 0.15232568559003423, 0.16439494056916826, 0.17645328982828762, 0.18849993343413143, 0.20053407222997505, 0.21255490788864428, 0.22456164296547593, 0.2365534809512186, 0.24852962632487213, null, 0.0964170404054442, 0.10711350691068544, 0.11780475285471446, 0.12849025716128706, 0.13916949903399836, 0.14984195798166558, 0.16050711384369626, 0.17116444681544, 0.18181343747352294, 0.19245356680116393, null, 0.06476216414008773, 0.07195302369974209, 0.07914232463860642, 0.08632991122460255, 0.09351562776278809, 0.10069931859872885, 0.1078808281218708, 0.11506000076891064, 0.12223668102716567, 0.1294107134379425, null ] }, { "hoverinfo": "text", "marker": { "color": [ "magenta", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "magenta", "magenta", "magenta", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "magenta", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "magenta", "magenta", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "magenta", "magenta", "magenta", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)", "rgb(150, 160, 150)" ], "colorbar": { "dtick": 10, "thickness": 20, "ticklen": 4, "title": "confidence" }, "colorscale": [ [ 0, "rgb(10,10,150)" ], [ 0.001, "rgb(10,10,150)" ], [ 0.001, "rgb(214, 47, 38)" ], [ 0.1, "rgb(214, 47, 38)" ], [ 0.2, "rgb(244, 109, 67)" ], [ 0.3, "rgb(252, 172, 96)" ], [ 0.4, "rgb(254, 224, 139)" ], [ 0.5, "rgb(254, 254, 189)" ], [ 0.6, "rgb(217, 239, 139)" ], [ 0.7, "rgb(164, 216, 105)" ], [ 0.8, "rgb(102, 189, 99)" ], [ 0.9, "rgb(63, 170, 89)" ], [ 1, "rgb(25, 151, 79)" ] ], "showscale": false, "size": [ 7, 9, 9, 9, 9, 9, 9, 9, 7, 7, 9, 9, 7, 7, 9, 7, 7, 9, 7, 7, 9, 7, 7, 9, 9, 9, 9, 7, 7, 7, 7, 9, 7, 7, 9, 7, 9, 7, 7, 9, 9, 7, 7, 9, 9, 9, 7, 7, 7, 9, 9, 7, 9, 9, 9, 7, 7, 7, 7, 7, 9, 9, 9, 9, 9, 9, 9, 9, 9, 9, 7, 9, 7, 9, 9, 9, 9, 7, 7, 7, 7, 7, 9, 9, 9, 7, 7, 7, 7, 9, 9, 7, 9, 7, 9, 7, 9, 7, 7, 9, 9, 9, 7, 9, 7, 7, 9, 9, 7, 7, 9, 7, 9, 7, 9, 7, 9, 9, 7, 7, 9, 7, 7, 9, 7, 9, 7, 9, 9, 7, 7, 9, 7, 9, 7, 9, 7, 7, 7, 7, 7, 9, 7, 7, 9, 9, 9, 9, 9, 7, 7, 9, 7, 7, 9, 9, 7, 7, 9, 7, 9, 9, 9, 7, 7, 7, 7, 9, 7, 9, 9, 7, 9, 9, 7, 7, 7, 9, 7, 7, 9, 9, 9, 7, 7, 9, 9, 7, 9, 7, 7, 9, 7, 7, 7, 9, 9, 9, 9, 9, 7, 7, 7, 9, 9, 9, 7, 7, 7, 7, 9, 9, 7, 7, 7, 9, 9, 9, 9, 9, 9, 9, 7, 7, 9, 9, 9, 7, 9, 9, 7, 7, 7, 7, 7, 9, 9, 7, 7, 9, 7, 7, 9, 7, 7, 9, 7, 7, 7, 9, 7, 9, 9, 7, 7, 7, 9, 9, 7, 9, 9, 9, 7, 9, 7, 7, 7, 9, 7, 9, 7, 9, 7, 9, 7, 9, 7, 7, 9, 7, 9, 7, 9, 9, 7, 9, 7, 9, 7, 7, 9, 7, 9, 7, 9, 7, 9, 7, 7 ] }, "mode": "markers", "opacity": 1, "text": [ "", "id: 1
branch-length: 0.21409500000000004
confidence: 33", "id: 2
branch-length: 0.22234
confidence: 58", "id: 3
branch-length: 0.68133
confidence: 99", "id: 4
branch-length: 0.0946
confidence: 72", "id: 5
branch-length: 0.24716
confidence: 35", "id: 6
branch-length: 0.18828
confidence: 33", "id: 7
branch-length: 0.10487
confidence: 37", "id: 8
name: 51_CHICK
branch-length: 0.28045", "id: 9
name: 145_XENLA
branch-length: 0.59876", "id: 10
branch-length: 0.38418
confidence: 100", "id: 11
branch-length: 0.0267
confidence: 39", "id: 12
name: 88_CANFA
branch-length: 0.08127", "id: 13
name: 115_MOUSE
branch-length: 0.14168", "id: 14
branch-length: 1e-05
confidence: 55", "id: 15
name: 74_BOVIN
branch-length: 0.09416", "id: 16
name: 9_HUMAN
branch-length: 0.06828", "id: 17
branch-length: 0.35342
confidence: 100", "id: 18
name: 159_BRARE
branch-length: 0.01275", "id: 19
name: 166_BRARE
branch-length: 0.02259", "id: 20
branch-length: 0.39739
confidence: 99", "id: 21
name: 52_CHICK
branch-length: 0.27747", "id: 22
name: 144_XENLA
branch-length: 0.34644", "id: 23
branch-length: 0.51997
confidence: 100", "id: 24
branch-length: 0.0983
confidence: 56", "id: 25
branch-length: 0.5126
confidence: 100", "id: 26
branch-length: 1e-05
confidence: 46", "id: 27
name: 90_CANFA
branch-length: 0.03744", "id: 28
name: 12_HUMAN
branch-length: 0.07368", "id: 29
name: 64_BOVIN
branch-length: 0.05675", "id: 30
name: 142_XENLA
branch-length: 0.26292", "id: 31
branch-length: 0.34592
confidence: 99", "id: 32
name: 155_BRARE
branch-length: 1e-05", "id: 33
name: 154_BRARE
branch-length: 1e-05", "id: 34
branch-length: 1.25362
confidence: 100", "id: 35
name: 125_MOUSE
branch-length: 0.04425", "id: 36
branch-length: 0.14928
confidence: 40", "id: 37
name: 95_CANFA
branch-length: 0.09977", "id: 38
name: 13_HUMAN
branch-length: 0.07433", "id: 39
branch-length: 0.57089
confidence: 66", "id: 40
branch-length: 0.53798
confidence: 100", "id: 41
name: 16_SPHGR
branch-length: 1e-05", "id: 42
name: 17_SPHGR
branch-length: 1e-05", "id: 43
branch-length: 0.69471
confidence: 89", "id: 44
branch-length: 0.15935
confidence: 83", "id: 45
branch-length: 0.24123
confidence: 100", "id: 46
name: 158_BRARE
branch-length: 1e-05", "id: 47
name: 169_BRARE
branch-length: 1e-05", "id: 48
name: 130_TETNG
branch-length: 0.37777", "id: 49
branch-length: 0.13835
confidence: 44", "id: 50
branch-length: 0.1765
confidence: 73", "id: 51
name: 122_MOUSE
branch-length: 0.10759", "id: 52
branch-length: 0.09256
confidence: 44", "id: 53
branch-length: 0.01016
confidence: 40", "id: 54
branch-length: 0.0243
confidence: 32", "id: 55
name: 11_HUMAN
branch-length: 0.02336", "id: 56
name: 68_BOVIN
branch-length: 0.24624", "id: 57
name: 92_CANFA
branch-length: 1e-05", "id: 58
name: 46_CHICK
branch-length: 1.06707", "id: 59
name: 147_XENLA
branch-length: 0.43513", "id: 60
branch-length: 0.21984499999999996
confidence: 33", "id: 61
branch-length: 0.13885
confidence: 14", "id: 62
branch-length: 0.07066
confidence: 2", "id: 63
branch-length: 0.0137
confidence: 3", "id: 64
branch-length: 0.10632
confidence: 4", "id: 65
branch-length: 0.09782
confidence: 15", "id: 66
branch-length: 0.08093
confidence: 32", "id: 67
branch-length: 0.17228
confidence: 52", "id: 68
branch-length: 0.22305
confidence: 76", "id: 69
branch-length: 0.00625
confidence: 55", "id: 70
name: 140_TETNG
branch-length: 0.92309", "id: 71
branch-length: 0.07662
confidence: 43", "id: 72
name: 152_XENLA
branch-length: 0.19286", "id: 73
branch-length: 0.0429
confidence: 35", "id: 74
branch-length: 0.06125
confidence: 68", "id: 75
branch-length: 1e-05
confidence: 93", "id: 76
branch-length: 1e-05
confidence: 75", "id: 77
name: 0_HUMAN
branch-length: 1e-05", "id: 78
name: 72_BOVIN
branch-length: 0.0105", "id: 79
name: 123_MOUSE
branch-length: 0.01053", "id: 80
name: 97_CANFA
branch-length: 1e-05", "id: 81
name: 41_CHICK
branch-length: 0.03818", "id: 82
branch-length: 0.07344
confidence: 38", "id: 83
branch-length: 0.18878
confidence: 96", "id: 84
branch-length: 0.02241
confidence: 81", "id: 85
name: 132_TETNG
branch-length: 1e-05", "id: 86
name: 135_TETNG
branch-length: 1e-05", "id: 87
name: 102_FUGRU
branch-length: 0.00904", "id: 88
name: 167_BRARE
branch-length: 0.26949", "id: 89
branch-length: 0.0375
confidence: 23", "id: 90
branch-length: 0.23552
confidence: 99", "id: 91
name: 151_XENLA
branch-length: 0.12315", "id: 92
branch-length: 0.22499
confidence: 100", "id: 93
name: 126_MOUSE
branch-length: 1e-05", "id: 94
branch-length: 0.01047
confidence: 100", "id: 95
name: 96_CANFA
branch-length: 1e-05", "id: 96
branch-length: 1e-05
confidence: 100", "id: 97
name: 8_HUMAN
branch-length: 1e-05", "id: 98
name: 79_BOVIN
branch-length: 1e-05", "id: 99
branch-length: 0.04974
confidence: 25", "id: 100
branch-length: 0.20281
confidence: 86", "id: 101
branch-length: 1e-05
confidence: 92", "id: 102
name: 164_BRARE
branch-length: 0.02901", "id: 103
branch-length: 0.06877
confidence: 100", "id: 104
name: 136_TETNG
branch-length: 0.01045", "id: 105
name: 100_FUGRU
branch-length: 1e-05", "id: 106
branch-length: 0.17649
confidence: 84", "id: 107
branch-length: 0.05352
confidence: 97", "id: 108
name: 129_TETNG
branch-length: 0.00069", "id: 109
name: 104_FUGRU
branch-length: 0.03078", "id: 110
branch-length: 0.23291
confidence: 95", "id: 111
name: 128_TETNG
branch-length: 0.36032", "id: 112
branch-length: 0.24906
confidence: 100", "id: 113
name: 103_FUGRU
branch-length: 0.24206", "id: 114
branch-length: 0.09945
confidence: 65", "id: 115
name: 106_FUGRU
branch-length: 0.04182", "id: 116
branch-length: 1e-05
confidence: 77", "id: 117
branch-length: 0.0141
confidence: 71", "id: 118
name: 112_FUGRU
branch-length: 0.03123", "id: 119
name: 113_FUGRU
branch-length: 0.09693", "id: 120
branch-length: 0.195
confidence: 100", "id: 121
name: 108_FUGRU
branch-length: 0.01027", "id: 122
name: 111_FUGRU
branch-length: 0.01081", "id: 123
branch-length: 0.03668
confidence: 58", "id: 124
name: 149_XENLA
branch-length: 0.32167", "id: 125
branch-length: 0.07846
confidence: 90", "id: 126
name: 49_CHICK
branch-length: 0.05537", "id: 127
branch-length: 0.03275
confidence: 83", "id: 128
branch-length: 0.192
confidence: 99", "id: 129
name: 63_BOVIN
branch-length: 0.1324", "id: 130
name: 80_BOVIN
branch-length: 0.13424", "id: 131
branch-length: 1e-05
confidence: 51", "id: 132
name: 57_BOVIN
branch-length: 0.01041", "id: 133
branch-length: 1e-05
confidence: 20", "id: 134
name: 117_MOUSE
branch-length: 1e-05", "id: 135
branch-length: 0.01043
confidence: 66", "id: 136
name: 87_CANFA
branch-length: 1e-05", "id: 137
name: 1_HUMAN
branch-length: 1e-05", "id: 138
name: 25_BRAFL
branch-length: 0.4534", "id: 139
name: 15_SPHGR
branch-length: 0.68488", "id: 140
name: 21_SPHGR
branch-length: 1.05022", "id: 141
branch-length: 0.08808
confidence: 22", "id: 142
name: 33_NEMVE
branch-length: 0.482", "id: 143
name: 30_NEMVE
branch-length: 0.47217", "id: 144
branch-length: 0.28685
confidence: 9", "id: 145
branch-length: 0.17977
confidence: 14", "id: 146
branch-length: 0.4495
confidence: 92", "id: 147
branch-length: 0.33029
confidence: 89", "id: 148
branch-length: 0.13116
confidence: 61", "id: 149
name: 165_BRARE
branch-length: 0.30255", "id: 150
name: 162_BRARE
branch-length: 0.62996", "id: 151
branch-length: 0.22822
confidence: 100", "id: 152
name: 137_TETNG
branch-length: 0.24501", "id: 153
name: 107_FUGRU
branch-length: 0.04204", "id: 154
branch-length: 0.25726
confidence: 94", "id: 155
branch-length: 0.15529
confidence: 59", "id: 156
name: 42_CHICK
branch-length: 0.29479", "id: 157
name: 143_XENLA
branch-length: 0.60398", "id: 158
branch-length: 0.13595
confidence: 100", "id: 159
name: 58_BOVIN
branch-length: 0.05604", "id: 160
branch-length: 1e-05
confidence: 60", "id: 161
branch-length: 0.02217
confidence: 78", "id: 162
branch-length: 1e-05
confidence: 42", "id: 163
name: 85_CANFA
branch-length: 0.01109", "id: 164
name: 2_HUMAN
branch-length: 0.01103", "id: 165
name: 124_MOUSE
branch-length: 0.04504", "id: 166
name: 73_BOVIN
branch-length: 1e-05", "id: 167
branch-length: 0.53052
confidence: 100", "id: 168
name: 45_CHICK
branch-length: 0.17601", "id: 169
branch-length: 0.40974
confidence: 98", "id: 170
branch-length: 0.05702
confidence: 52", "id: 171
name: 91_CANFA
branch-length: 0.10905", "id: 172
branch-length: 0.06948
confidence: 63", "id: 173
branch-length: 0.18193
confidence: 100", "id: 174
name: 118_MOUSE
branch-length: 0.18633", "id: 175
name: 127_MOUSE
branch-length: 1e-05", "id: 176
name: 3_HUMAN
branch-length: 0.04341", "id: 177
branch-length: 0.09486
confidence: 100", "id: 178
name: 76_BOVIN
branch-length: 1e-05", "id: 179
name: 71_BOVIN
branch-length: 1e-05", "id: 180
branch-length: 0.13006
confidence: 23", "id: 181
branch-length: 0.40777
confidence: 73", "id: 182
branch-length: 0.33571
confidence: 100", "id: 183
name: 157_BRARE
branch-length: 0.2958", "id: 184
name: 109_FUGRU
branch-length: 0.19527", "id: 185
branch-length: 0.1832
confidence: 68", "id: 186
branch-length: 0.78705
confidence: 100", "id: 187
name: 55_BOVIN
branch-length: 0.43001", "id: 188
branch-length: 0.08251
confidence: 65", "id: 189
name: 119_MOUSE
branch-length: 0.64738", "id: 190
name: 10_HUMAN
branch-length: 0.18995", "id: 191
branch-length: 0.09353
confidence: 48", "id: 192
name: 171_CHICK
branch-length: 0.56823", "id: 193
name: 141_XENLA
branch-length: 0.57176", "id: 194
name: 40_CAEEL
branch-length: 1.20795", "id: 195
branch-length: 0.09583
confidence: 8", "id: 196
branch-length: 0.03647
confidence: 6", "id: 197
branch-length: 0.15942
confidence: 15", "id: 198
branch-length: 0.37935
confidence: 100", "id: 199
branch-length: 1e-05
confidence: 65", "id: 200
name: 23_BRAFL
branch-length: 1e-05", "id: 201
name: 24_BRAFL
branch-length: 0.08958", "id: 202
name: 26_BRAFL
branch-length: 1e-05", "id: 203
branch-length: 0.07297
confidence: 24", "id: 204
branch-length: 0.74877
confidence: 100", "id: 205
branch-length: 0.22523
confidence: 100", "id: 206
name: 168_BRARE
branch-length: 0.13915", "id: 207
name: 131_TETNG
branch-length: 0.07883", "id: 208
name: 146_XENLA
branch-length: 0.27947", "id: 209
name: 14_SPHGR
branch-length: 0.61862", "id: 210
branch-length: 0.145
confidence: 29", "id: 211
branch-length: 0.14662
confidence: 25", "id: 212
name: 35_NEMVE
branch-length: 0.49481", "id: 213
name: 38_NEMVE
branch-length: 0.35293", "id: 214
name: 34_NEMVE
branch-length: 0.32221", "id: 215
branch-length: 0.40409
confidence: 89", "id: 216
branch-length: 0.10452
confidence: 28", "id: 217
branch-length: 0.1139
confidence: 41", "id: 218
branch-length: 0.18551
confidence: 35", "id: 219
branch-length: 0.13606
confidence: 92", "id: 220
branch-length: 0.05378
confidence: 57", "id: 221
branch-length: 0.11874
confidence: 90", "id: 222
name: 110_FUGRU
branch-length: 0.56162", "id: 223
name: 134_TETNG
branch-length: 0.03296", "id: 224
branch-length: 0.091
confidence: 66", "id: 225
branch-length: 0.04421
confidence: 62", "id: 226
branch-length: 0.13167
confidence: 94", "id: 227
name: 7_HUMAN
branch-length: 1e-05", "id: 228
branch-length: 0.01865
confidence: 61", "id: 229
branch-length: 0.51198
confidence: 100", "id: 230
name: 89_CANFA
branch-length: 0.01988", "id: 231
name: 62_BOVIN
branch-length: 1e-05", "id: 232
name: 114_MOUSE
branch-length: 0.01315", "id: 233
name: 48_CHICK
branch-length: 1e-05", "id: 234
name: 150_XENLA
branch-length: 0.0853", "id: 235
branch-length: 1e-05
confidence: 38", "id: 236
branch-length: 0.19569
confidence: 100", "id: 237
name: 101_FUGRU
branch-length: 0.02185", "id: 238
name: 133_TETNG
branch-length: 0.00907", "id: 239
branch-length: 0.1765
confidence: 100", "id: 240
name: 160_BRARE
branch-length: 1e-05", "id: 241
name: 161_BRARE
branch-length: 1e-05", "id: 242
branch-length: 0.43964
confidence: 100", "id: 243
name: 98_DROME
branch-length: 0.38195", "id: 244
name: 99_DROME
branch-length: 0.30802", "id: 245
branch-length: 0.18404
confidence: 45", "id: 246
name: 22_BRAFL
branch-length: 0.39195", "id: 247
name: 18_SPHGR
branch-length: 0.4734", "id: 248
name: 20_SPHGR
branch-length: 0.64378", "id: 249
branch-length: 0.06108
confidence: 45", "id: 250
name: 39_NEMVE
branch-length: 0.56478", "id: 251
branch-length: 0.12162
confidence: 57", "id: 252
branch-length: 0.46294
confidence: 100", "id: 253
name: 37_NEMVE
branch-length: 1e-05", "id: 254
name: 29_NEMVE
branch-length: 1e-05", "id: 255
name: 31_NEMVE
branch-length: 0.56073", "id: 256
branch-length: 0.11059
confidence: 29", "id: 257
branch-length: 0.24695
confidence: 52", "id: 258
name: 172_XENLA
branch-length: 0.53649", "id: 259
branch-length: 0.09295
confidence: 50", "id: 260
branch-length: 0.14603
confidence: 87", "id: 261
branch-length: 0.09214
confidence: 65", "id: 262
name: 19_SPHGR
branch-length: 0.37571", "id: 263
branch-length: 0.09991
confidence: 100", "id: 264
name: 28_BRAFL
branch-length: 1e-05", "id: 265
name: 27_BRAFL
branch-length: 1e-05", "id: 266
name: 36_NEMVE
branch-length: 0.36151", "id: 267
branch-length: 0.34289
confidence: 100", "id: 268
name: 50_CHICK
branch-length: 0.05827", "id: 269
branch-length: 0.22124
confidence: 92", "id: 270
name: 170_MOUSE
branch-length: 0.17237", "id: 271
branch-length: 1e-05
confidence: 59", "id: 272
name: 67_BOVIN
branch-length: 0.05006", "id: 273
branch-length: 0.00337
confidence: 81", "id: 274
name: 84_CANFA
branch-length: 0.01072", "id: 275
branch-length: 0.02097
confidence: 98", "id: 276
name: 6_HUMAN
branch-length: 0.02091", "id: 277
name: 5_HUMAN
branch-length: 0.01043", "id: 278
branch-length: 0.20775
confidence: 73", "id: 279
name: 32_NEMVE
branch-length: 0.30744", "id: 280
branch-length: 0.27579
confidence: 64", "id: 281
name: 53_CIOIN
branch-length: 0.40206", "id: 282
branch-length: 0.28261
confidence: 92", "id: 283
branch-length: 0.05338
confidence: 67", "id: 284
name: 156_BRAREb
branch-length: 0.64914", "id: 285
branch-length: 0.0829
confidence: 70", "id: 286
name: 156_BRAREa
branch-length: 0.18704", "id: 287
branch-length: 0.03919
confidence: 100", "id: 288
name: 138_TETNG
branch-length: 0.03397", "id: 289
name: 173_FUGRU
branch-length: 1e-05", "id: 290
branch-length: 0.15101
confidence: 78", "id: 291
name: 153_XENLA
branch-length: 0.15191", "id: 292
branch-length: 0.24267
confidence: 100", "id: 293
name: 116_MOUSE
branch-length: 1e-05", "id: 294
branch-length: 0.04527
confidence: 49", "id: 295
name: 4_HUMAN
branch-length: 1e-05", "id: 296
branch-length: 0.011
confidence: 37", "id: 297
name: 94_CANFA
branch-length: 1e-05", "id: 298
name: 82_BOVIN
branch-length: 1e-05" ], "type": "scatter", "uid": "61f297a6-c555-11e8-92dc-8af2f04e441a", "x": [ 0, 0.1578079409818431, 0.3704706342339276, 1.024082831887035, 1.1693956546285882, 1.436458094721308, 1.6420259159356294, 1.7522906094092747, 2.033125, 2.349372391993509, 2.0101865414957976, 2.0474073081662336, 2.132449876615273, 2.1830144647578313, 1.9960027820444421, 2.0963804041976397, 2.0543789521311937, 1.7461607596629802, 1.768337434356736, 1.7571934439025234, 1.5087943689945196, 1.7822506953214303, 1.8188241128121674, 1.3896348769327327, 1.5168991612173741, 2.0035484555183105, 2.0346348273924524, 2.088442567534885, 2.0801338135979948, 2.0202242755729225, 1.7098346646691456, 1.628876734444117, 1.6522367129531994, 1.6048186961467799, 1.2908572971741192, 1.3591634815074902, 1.3668922875694631, 1.4678928973895988, 1.395001748394395, 0.47111541775805055, 0.9056318619949466, 0.9256371079156701, 0.8852430639476099, 0.7523922838101064, 0.9772394001880166, 1.1679286425628, 1.1985387665646143, 1.1368186466889996, 1.1510236840094772, 0.6716347014154497, 0.8604087058329355, 1.0192149006673739, 0.7945387885848596, 0.8613402854883508, 0.9257209987752617, 0.9724624999999986, 1.0043354614130118, 0.807820405404123, 1.144788857607141, 0.7156794132599676, 0.023544836327340873, -0.2424644452940123, -0.42829964763304745, -0.41750117894923894, -0.4941569200964988, -0.5300346628176277, -0.4598423282231091, -0.15524120668112146, 0.10243183802607282, 0.2802299879655742, 0.6343485409679197, 0.22449146514162482, 0.37626857920757023, 0.12732657829057095, 0.18464754192340235, 0.2320668959177083, 0.27246723125821964, 0.2992549570343645, 0.24752977966116882, 0.19297787197637362, 0.13698298318531138, 0.08083682879463498, -0.0814071613207816, -0.04352510358558665, -2.586610182266101e-16, 0.029488916725654672, -0.02948891672565519, -0.08757487944532605, -0.15327897060873785, -0.39767345342423505, -0.2168595634497718, -0.1894076027583099, -0.31219631098145506, -0.26203871484954194, -0.364646270359266, -0.3217223991445524, -0.40721545355608085, -0.3788824798639511, -0.43537558845983554, -0.6285519390529037, -0.5411493731634495, -0.44980623227984645, -0.4250748974077709, -0.5121770167435561, -0.49202272738443864, -0.5361604440068602, -0.7218397081072679, -0.6843142326828929, -0.6584154767907675, -0.7256224999999994, -0.9164951319452446, -1.050314287847954, -1.125548137515659, -1.1933478021889554, -1.2575871677422763, -1.2032640894123765, -1.3337544675138087, -1.2823215998154824, -1.2708353954819112, -1.3780109163884642, -1.5313828797079598, -1.5068264549799064, -1.5703332826617942, -0.8073166797242599, -1.0189115599319862, -0.9014124190425679, -0.9076384960692079, -0.9635130469690216, -1.0901043153473118, -1.1811122256827888, -1.2175434466390054, -0.9922076790068072, -0.9802089507522339, -1.011786913574722, -0.9951031951240102, -1.0369182297202713, -1.0264811986755662, -1.0469185267311325, -1.0985541624891162, -1.2579801533840924, -1.5313234816548074, -0.517101830577536, -0.9813055009500559, -0.981380378554231, -0.6347577190586658, -0.8812378001519606, -1.3454101601595518, -1.6665849839918145, -1.7875409102391475, -2.079933990299303, -2.417669433912731, -1.9002279205265027, -2.141458172062889, -1.944318005443131, -1.5969370604728959, -1.7576394360658651, -2.052815, -2.359933120307654, -1.719362122069589, -1.788430646816567, -1.6987842550427208, -1.7330355992267592, -1.7419849193062023, -1.7579925267147087, -1.7470913080654134, -1.7664416429031833, -1.6840803851701567, -1.3283734483587595, -1.5341092813926256, -1.6510989106147809, -1.7566306268753997, -1.8909295280083596, -1.784589534490498, -1.977087636001552, -2.1673043397230844, -1.959258104369645, -1.7969276692454965, -1.6723773271211102, -1.6922402113661053, -1.651798199617255, -0.6007450103151444, -0.9724988042889932, -1.3054178494742603, -1.5705104808147246, -1.4441074702141967, -1.0425334341218453, -1.6989000495516051, -2.0801536253126898, -1.714282767687126, -2.236295868530027, -1.8200487756712718, -1.0478807506069292, -1.4685898534208517, -1.4068638281346584, -1.3094059211016047, 0.0073299211724926205, -0.1955873122814473, -0.3207735566410482, -0.5788137895938991, -0.6052865581794815, -0.6226070994985508, -0.638831085555407, -0.5517810377994962, -0.30457099185284214, -0.6683443841440724, -0.8177214601151402, -0.9182675000000005, -0.8229133670204247, -0.7458056515876704, -0.5200478545966545, -0.19018844867090978, -0.2573759707373163, -0.44527464755006957, -0.3509027028774996, -0.25768031671265035, 0.36724808752319793, 0.33487246529977244, 0.2876835649917768, 0.20586668687905826, 0.04804824735983767, -0.14330460023805075, -0.32665525523605216, -0.4870141764741501, -0.30057555600724206, 0.018182155571879695, -0.06232868720001843, -0.1707569695429975, -0.2511568989316397, -0.09095544339395575, -0.18826636132416005, -0.23725609271333786, -0.14127270384159937, -0.03667153847305001, 0.033248290518917076, 0.10226597729959999, 0.2332452706883415, 0.19981940093773812, 0.16893419855233482, 0.23422587592125677, 0.32748482288241526, 0.29514899313683973, 0.3596811642830469, 0.49198558928192543, 0.5604652103379968, 0.6211875071774913, 0.4642326702768304, 0.5761983085241437, 0.6721360968115112, 0.6841911303052887, 0.4640115329845541, 0.6877513817345567, 0.567140796746673, 0.7792447189845781, 0.7521324999999999, 0.8060254937490804, 0.9143088175410056, 0.2700963584799674, 0.39012208559250416, 0.673447839067328, 0.49668547261481644, 0.5681188501900846, 0.6008051362058643, 0.8185894489951135, 0.6903075698250786, 0.6747680317174316, 0.7055580041571906, 0.858633922023995, 0.7932332897028126, 0.8111164171555786, 0.9968001264317192, 1.1025273850369977, 1.0246294156431035, 1.039210644869423, 1.0520354205503246, 1.0399563089072053, 1.090165768664908, 1.0946310278339042, 1.1122478721122735, 0.49592793271006025, 0.7574362572524534, 0.7681716679430264, 1.1109032505844199, 1.0610546506958753, 1.084004722303817, 1.6727655246439825, 1.1764495026162196, 1.3409247299820506, 1.225195758907795, 1.2502831967643182, 1.232100738861092, 1.2295748115005625, 1.3689224579649648, 1.4775155763352414, 1.4694052441452468, 1.5287202413167904, 1.52343676902994, 1.5434832664498168, 1.5411210490080245, 1.5451884172752388 ], "y": [ 0, -0.14468352631889764, -0.23070981425875983, -0.44794301943353315, -0.31991045022126985, -0.2584596056149396, -0.1378847686322067, -0.03670525576906236, -4.979720047032925e-16, -0.09846787782672123, -0.2968385227933938, -0.21519117940216909, -0.17906681922820594, -0.2757788604717193, -0.38075789433161966, -0.35457620467417544, -0.4366717264322707, -0.4875368441853432, -0.4540318835474406, -0.5305279794044703, -0.561115596036529, -0.6206453573912224, -0.720123409339005, -0.8666549711604663, -0.8442952421534938, -1.0208589273818363, -0.9574264750813437, -0.9298345386859426, -1.0325873925006368, -1.1106276939689832, -1.0355126805214656, -1.1320988221050623, -1.0977434475297985, -1.1659690324887493, -1.0908589924263026, -1.0772597010755756, -1.2307553438470704, -1.267051160300234, -1.3099938374670246, -0.6278946674209438, -0.9643999801765685, -0.9452294933372076, -0.9831620254859561, -1.2741283861087205, -1.315853968624621, -1.4735592154733435, -1.4487844926926756, -1.4977032569121267, -1.6561060422189908, -1.4720653687522098, -1.5748297101438913, -1.6060256985747752, -1.7116872945894945, -1.6904754931142438, -1.683880245638487, -1.68435445845545, -1.9211165500753231, -1.716705745967467, -2.7233450758439584, -1.9244039487750144, 0.21858056800026554, 0.2643351959033585, 0.03008534298304405, -0.1482919370734484, -0.24004547266245715, -0.37138204619610216, -0.5645449927147971, -0.8869212658253206, -1.1187756055543936, -1.0943968845303855, -1.9523240613681097, -1.1852525417410276, -1.3476426160247814, -1.2427192132922926, -1.2974012528461059, -1.289773581309572, -1.2818575400236485, -1.2758800201097908, -1.2975965467763442, -1.3068435909291019, -1.3033060260516915, -1.2848646003121988, -1.1941233249169416, -1.3849912530347848, -1.4080849999999998, -1.4077861814975126, -1.4077861814975126, -1.3919628485398365, -1.4583519895396053, -0.8494242835395293, -1.153212105540596, -1.2826657751114865, -1.3631206753749172, -1.3736550486002665, -1.3608784077712737, -1.3716704483634812, -1.348762653475442, -1.3570045561740545, -1.3399482810908234, -0.7618169766668595, -1.0603492174514042, -1.1022165257458303, -1.1429919541356242, -1.15036841435458, -1.170475815624645, -1.1393989416825725, -1.160812676026849, -1.2447629682685066, -1.2594326476423365, -1.2568150371151479, -1.3113247859114339, -1.6550304913709126, -1.4668428911645686, -1.717002467568346, -1.4881534493307333, -1.5852418949029843, -1.4203042494521927, -1.4855838718401801, -1.5361761046883051, -1.5304361693122732, -1.4996409124728345, -1.5387205141277887, -1.4746411073849917, -0.6304613265411263, -0.8795008658676613, -0.6352876569089203, -0.7193854074682263, -0.6009012768712277, -0.7576422360759517, -0.8581282623056116, -0.8089339318951896, -0.5522557095629927, -0.5936356415261848, -0.5155311819317414, -0.547062610931314, -0.4879366814441998, -0.5095496921700305, -0.4661181592816517, -0.43494836211076404, -0.43807503845429874, -0.46233381723339106, -0.12128513939622301, -0.251956428832765, -0.20859883895591178, 0.3317110792850304, 0.1618367702604478, -0.013208957735151293, -0.17516514024771937, -0.26396107638513494, -0.35179450197895, -0.30542267687434854, -0.11955220732601968, -0.17982326693192932, -0.08149106904836473, 0.13620391005102053, 0.03681729771543888, 2.513973318991674e-16, 0.0989105034866386, 0.25849453073007184, 0.15017871737459038, 0.37039486746437056, 0.3118223212628433, 0.25723395291983636, 0.22208610321277292, 0.2954983761499951, 0.3754687620062464, 0.43239835026296897, 0.5199153457251076, 0.4631748997625006, 0.8035118932484347, 0.7061609843005637, 0.6584913310978993, 0.8170488807972186, 0.831091115218299, 0.8580964916852214, 0.8723179099885924, 0.892002641545947, 0.9655475000000007, 0.9303169288261928, 1.0003645479354986, 0.5960452019825822, 0.7917385028413602, 0.9072890406584869, 1.0434446687180412, 1.0492054921208491, 0.9893272885972124, 1.4356818529390674, 1.6487094474538184, 1.543547137095582, 1.9303188127924704, 1.7091395639919245, 1.115879660954737, 1.4996745821858561, 1.5624805741868584, 1.582799861008668, 0.4544658929783455, 0.45035729515521294, 0.5658126877199311, 0.8516986275678444, 0.8331054753824616, 0.8202545616325472, 0.9191574729898575, 0.8694677894838377, 0.6561420342782315, 1.3116997096165266, 1.4874298141062532, 1.590485964939254, 1.574088090484172, 1.5849176857757912, 1.2371449587475256, 0.6068920777347095, 0.7390831129934062, 1.1973074454266797, 1.0799674717963803, 0.9229071873183501, 0.7761111778833967, 0.9030445505117963, 1.0379029615810054, 1.2456479375242588, 1.3977794217796484, 1.4452978861728167, 1.5367921492029006, 2.076395537208218, 1.5756722445851288, 1.5432778970243046, 1.5863710217905906, 1.7107642144893878, 1.7008311902549418, 1.7355332478929952, 2.2420043015611637, 2.257340935059523, 2.2454653264244104, 1.7506809625088804, 1.5872568119880823, 1.6254711621901994, 1.3790288473873644, 1.5817334288791787, 1.6073015338089118, 1.5861745268645313, 1.5406949581298284, 1.547225205804026, 1.5335084693880867, 1.629534888906622, 2.007360816152837, 1.911818564339099, 1.1725178819415265, 1.549350560679834, 1.5989485898514644, 1.4539801630134337, 0.7940605709152948, 1.3155470582792572, 0.8733202424600892, 1.286685965167743, 1.302731704023799, 1.2700929468552888, 1.3155179847466048, 0.19035557874898465, 0.4256503219286399, 0.8872347624392014, 0.45016947199737606, 0.5862531750734455, 0.6814796573146206, 0.9895046640713101, 0.7351028984211625, 0.7494058206320411, 0.7204921119587095, 0.806310922395754, 0.6304013394118492, 0.7001369100723779, 0.7282124306620342, 0.8738524374678365, 0.6885223934077028, 0.7550307290535119, 0.6522895966765848, 0.6909453196810159, 0.6294074999999999, 0.6629321145700289, 0.6114634420852315, 0.2090420526662658, 0.3759946233982542, 0.26919804827418164, 0.49460599376268055, 0.27687847598116694, 0.38386620487876333, 0.6622947233577674, 0.36867692634480026, 0.46695939603734804, 0.3420808024127518, 0.37748275260440356, 0.31634970131636103, 0.21127959425452383, 0.29097345085790827, 0.1945186158488152, 0.24853129401233928, 0.14450660889154487, 0.19245482013349957, 0.09710773612026664, 0.12941155021637582, 0.06476258289662502 ] } ], "_js2py_relayout": {}, "_js2py_restyle": {}, "_js2py_update": {}, "_last_layout_edit_id": 2, "_last_trace_edit_id": 2, "_layout": { "autosize": false, "font": { "family": "Balto", "size": 14 }, "height": 750, "hovermode": "closest", "margin": { "t": 75 }, "plot_bgcolor": "rgb(245,245,245)", "showlegend": false, "title": "Path marking from root to a tree node by clicking that node", "width": 700, "xaxis": { "visible": false }, "yaxis": { "visible": false } }, "_py2js_addTraces": {}, "_py2js_animate": {}, "_py2js_deleteTraces": {}, "_py2js_moveTraces": {}, "_py2js_relayout": {}, "_py2js_removeLayoutProps": {}, "_py2js_removeTraceProps": {}, "_view_count": 1 } }, "cc1cd20fb2c64f18968206d8488f4d7a": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.2.0", "model_name": "DescriptionStyleModel", "state": { "description_width": "" } } }, "version_major": 2, "version_minor": 0 } } }, "nbformat": 4, "nbformat_minor": 2 }