changeset 0:42e6c251bfd0 draft

planemo upload for repository https://github.com/goeckslab/tools-mti/tree/main/tools/scimap commit b19cb55dfb751cccc857b95a432890299bfeebb5
author goeckslab
date Tue, 19 Jul 2022 20:30:34 +0000
parents
children fd38e533a54b
files main_macros.xml mcmicro_to_anndata.py scimap_phenotyping.py scimap_spatial.py scimap_spatial.xml test-data/imc.h5ad test-data/manual_gates.csv test-data/mcmicro_output.csv test-data/phenotype_workflow.csv test-data/tutorial_data.h5ad test-data/tutorial_data_pheno.h5ad
diffstat 11 files changed, 5288 insertions(+), 0 deletions(-) [+]
line wrap: on
line diff
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/main_macros.xml	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,29 @@
+<macros>
+    <token name="@TOOL_VERSION@">0.0.1</token>
+    <token name="@VERSION_SUFFIX@">0</token>
+    <token name="@PROFILE@">20.01</token>
+
+    <xml name="scimap_requirements">
+        <requirements>
+            <container type="docker">quay.io/goeckslab/scimap:0.17.7</container>
+            <yield />
+        </requirements>
+    </xml>
+
+    <xml name="macro_stdio">
+        <stdio>
+            <exit_code range="1:" level="fatal" description="Error occurred. Please check Tool Standard Error" />
+        </stdio>
+    </xml>
+
+    <xml name="scimap_spatial_options" token_label="spatial_aggregate">
+        <section name="options" title="Advanced Options" expanded="false">
+            <param argument="x_coordinate" type="text" value="X_centroid" optional="false" label="Column name containing the x-coordinates values" />
+            <param argument="y_coordinate" type="text" value="Y_centroid" optional="false" label="Column name containing the y-coordinates values" />
+            <yield/>
+            <param argument="imageid" type="text" value="imageid" optional="true" label="Column name of the column containing the image id" />
+            <param argument="subset" type="text" value="" optional="true" label="Imageid of a single image to be subsetted for analyis" />
+            <param argument="label" type="text" value="@LABEL@" optional="true" label="Key for the returned data" help="Stored in adata.obs" />
+        </section>
+    </xml>
+</macros>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/mcmicro_to_anndata.py	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,45 @@
+import argparse
+import json
+import warnings
+
+import scimap as sm
+
+
+def main(inputs, outfile):
+    """
+    Parameter
+    ---------
+    inputs : str
+        File path to galaxy tool parameter.
+
+    outfile : str
+        File path to estimator.
+    """
+    warnings.simplefilter('ignore')
+
+    with open(inputs, 'r') as param_handler:
+        params = json.load(param_handler)
+
+    image_path = params['image_path']
+    drop_markers = params['drop_markers']
+    if not drop_markers:
+        drop_markers = None
+    else:
+        drop_markers = [x.strip() for x in drop_markers.split(',')]
+    options = params['options']
+    for k, v in options.items():
+        if v == '':
+            options[k] = None
+
+    adata = sm.pp.mcmicro_to_scimap(image_path, drop_markers=drop_markers, **options)
+
+    adata.write(outfile)
+
+
+if __name__ == '__main__':
+    aparser = argparse.ArgumentParser()
+    aparser.add_argument("-i", "--inputs", dest="inputs", required=True)
+    aparser.add_argument("-e", "--outfile", dest="outfile", required=True)
+    args = aparser.parse_args()
+
+    main(args.inputs, args.outfile)
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scimap_phenotyping.py	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,73 @@
+import argparse
+import warnings
+
+import pandas as pd
+import scimap as sm
+from anndata import read_h5ad
+
+
+def main(
+    adata,
+    output,
+    gating_workflow,
+    gating_workflow_ext,
+    manual_gates=None,
+    manual_gates_ext=None,
+    rescale_plots=False
+):
+    """
+    Parameter
+    ---------
+    adata : str
+        File path to the input AnnData.
+    output : str
+        File path to the output AnnData.
+    gating_workflow : str
+        File path to the gating workflow.
+    gating_workflow_ext : str
+        Datatype for gating workflow, either 'csv' or 'tabular'.
+    manual_gates : str
+        File path to the munual gating.
+    manual_gates_ext : str
+        Datatype for munual gate, either 'csv' or 'tabular'.
+    rescale_plots : boolean
+        Save plots from rescaling.
+    """
+    warnings.simplefilter('ignore')
+
+    adata = read_h5ad(adata)
+    # Rescale data
+    if manual_gates:
+        sep = ',' if manual_gates_ext == 'csv' else '\t'
+        manual_gates = pd.read_csv(manual_gates, sep=sep)
+
+    adata = sm.pp.rescale(adata, gate=manual_gates, save_fig=rescale_plots)
+
+    # Phenotype cells
+    # Load the gating workflow
+    sep = ',' if gating_workflow_ext == 'csv' else '\t'
+    phenotype = pd.read_csv(gating_workflow, sep=sep)
+    adata = sm.tl.phenotype_cells(adata, phenotype=phenotype, label="phenotype")
+
+    # Summary of the phenotyping
+    print(adata.obs['phenotype'].value_counts())
+
+    adata.write(output)
+
+
+if __name__ == '__main__':
+    aparser = argparse.ArgumentParser()
+    aparser.add_argument("-a", "--adata", dest="adata", required=True)
+    aparser.add_argument("-o", "--output", dest="output", required=True)
+    aparser.add_argument("-g", "--gating_workflow", dest="gating_workflow", required=True)
+    aparser.add_argument("-s", "--gating_workflow_ext", dest="gating_workflow_ext", required=True)
+    aparser.add_argument("-m", "--manual_gates", dest="manual_gates", required=False)
+    aparser.add_argument("-S", "--manual_gates_ext", dest="manual_gates_ext", required=False)
+    aparser.add_argument("-p", "--rescale_plots", dest="rescale_plots", action="store_true",
+                         default=False, required=False)
+
+    args = aparser.parse_args()
+
+    main(args.adata, args.output, args.gating_workflow,
+         args.gating_workflow_ext, args.manual_gates,
+         args.manual_gates_ext, args.rescale_plots)
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scimap_spatial.py	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,59 @@
+import argparse
+import json
+import warnings
+
+import scimap as sm
+from anndata import read_h5ad
+
+
+def main(inputs, anndata, output):
+    """
+    Parameter
+    ---------
+    inputs : str
+        File path to galaxy tool parameter.
+    anndata : str
+        File path to anndata containing phenotyping info.
+    output : str
+        File path to output.
+    """
+    warnings.simplefilter('ignore')
+
+    with open(inputs, 'r') as param_handler:
+        params = json.load(param_handler)
+
+    adata = read_h5ad(anndata)
+
+    tool = params['analyses']['selected_tool']
+    tool_func = getattr(sm.tl, tool)
+
+    options = params['analyses']['options']
+    if tool == 'cluster':
+        options['method'] = params['analyses']['method']
+        subset_genes = options.pop('subset_genes')
+        if subset_genes:
+            options['subset_genes'] = \
+                [x.strip() for x in subset_genes.split(',')]
+        sub_cluster_group = options.pop('sub_cluster_group')
+        if sub_cluster_group:
+            options['sub_cluster_group'] = \
+                [x.strip() for x in sub_cluster_group.split(',')]
+
+    for k, v in options.items():
+        if v == '':
+            options[k] = None
+
+    tool_func(adata, **options)
+
+    adata.write(output)
+
+
+if __name__ == '__main__':
+    aparser = argparse.ArgumentParser()
+    aparser.add_argument("-i", "--inputs", dest="inputs", required=True)
+    aparser.add_argument("-e", "--output", dest="output", required=True)
+    aparser.add_argument("-a", "--anndata", dest="anndata", required=True)
+
+    args = aparser.parse_args()
+
+    main(args.inputs, args.anndata, args.output)
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/scimap_spatial.xml	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,214 @@
+<tool id="scimap_spatial" name="Spatial Analysis Tools" version="@TOOL_VERSION@+galaxy@VERSION_SUFFIX@" profile="@PROFILE@">
+    <description>from Scimap</description>
+    <macros>
+        <import>main_macros.xml</import>
+    </macros>
+
+    <expand macro="scimap_requirements"/>
+    <expand macro="macro_stdio" />
+    <version_command>echo "@VERSION@"</version_command>
+    <command>
+        <![CDATA[
+        python '$__tool_directory__/scimap_spatial.py'
+            --inputs '$inputs'
+            --anndata '$anndata'
+            --output '$output'
+
+        ]]>
+    </command>
+    <configfiles>
+        <inputs name="inputs" />
+    </configfiles>
+    <inputs>
+        <param name="anndata" type="data" format="h5ad" label="Select the input anndata" />
+        <conditional name="analyses">
+            <param name="selected_tool" type="select" label="Select an analysis">
+                <option value="cluster">Cluster</option>
+                <option value="spatial_aggregate">Spatial Aggregate -- find regions of aggregration of similar cells</option>
+                <option value="spatial_count" selected="true">Spatial Count -- compute a neighbourhood matrix using any categorical variables (e.g. cell-types)</option>
+                <option value="spatial_distance">Spatial Distance -- calculate the average shortest between phenotypes or clusters of interest</option>
+                <option value="spatial_expression">Spatial Expression -- o compute a neighbourhood weighted matrix based on the expression values</option>
+                <option value="spatial_interaction">Spatial Interaction -- computes how likely celltypes are found next to each another compared to random background</option>
+                <option value="spatial_lda">Spatial LDA -- compute a neighbourhood matrix using any categorical variable and then perform Latent Dirichlet Allocation (LDA) modelling</option>
+                <option value="spatial_pscore">Spatial pscore -- a scoring system to evaluate user defined proximity between cell types</option>
+            </param>
+            <when value="cluster">
+                <param name="method" type="select" label="Select the clustering method">
+                    <option value="kmeans" selected="true">kmeans</option>
+                    <option value="phenograph">phenograph</option>
+                    <option value="leiden">leiden</option>
+                    <option value="parc">parc</option>
+                </param>
+                <section name="options" title="Advanced Options" expanded="false">
+                    <param argument="subset_genes" type="text" value="" optional="true" label="Type in a list of genes  that should be included for the purpose of clustering" help="Optional. Comma delimited. By default the algorithm uses all genes in the dataset." />
+                    <param argument="sub_cluster" type="boolean" checked="false" optional="true" label="Whether to do sub-clustering on existing clustering or phenotyping " />
+                    <param argument="sub_cluster_column" type="text" value="phenotype" optional="true" label="Type in the name of a column to be sub-clustered" help="This is only required when sub_cluster is set to True." />
+                    <param argument="sub_cluster_group" type="text" value="" optional="true" label="Type in a list of group names within the sub-cluster column" help="Optional. Comma delimited. By default the program will sub-cluster all groups within column passed through the argument sub_cluster_column." />
+                    <param argument="parc_small_pop" type="integer" value="50" optional="true" label="Smallest cluster population to be considered a community in PARC clustering" />
+                    <param argument="parc_too_big_factor" type="float" value="0.4" optional="true" label="If a cluster exceeds this share of the entire cell population, then the PARC will be run on the large cluster" />
+                    <param argument="k" type="integer" value="10" optional="true" label="Number of clusters to return when using K-Means clustering" />
+                    <param argument="n_pcs" type="integer" value="" optional="true" label="Number of PC's to be used in leiden clustering" help="By default it uses all PC's" />
+                    <param argument="resolution" type="float" value="1" optional="true" label="A parameter value controlling the coarseness of the clustering" help="Higher values lead to more clusters." />
+                    <param argument="phenograph_clustering_metric" type="select" label="Distance metric to define nearest neighbors">
+                        <option value="euclidean" selected="true">euclidean</option>
+                        <option value="cityblock">cityblock</option>
+                        <option value="cosine">cosine</option>
+                        <option value="manhattan">manhattan</option>
+                        <option value="braycurtis">braycurtis</option>
+                        <option value="canberra">canberra</option>
+                        <option value="chebyshev">chebyshev</option>
+                        <option value="correlation">correlation</option>
+                        <option value="dice">dice</option>
+                        <option value="hamming">hamming</option>
+                        <option value="jaccard">jaccard</option>
+                        <option value="mahalanobis">mahalanobis</option>
+                        <option value="minkowski">minkowski</option>
+                        <option value="rogerstanimoto">rogerstanimoto</option>
+                        <option value="russellrao">russellrao</option>
+                        <option value="seuclidean">seuclidean</option>
+                        <option value="sokalmichener">sokalmichener</option>
+                        <option value="sokalsneath">sokalsneath</option>
+                        <option value="sqeuclidean">sqeuclidean</option>
+                        <option value="yule">yule</option>    
+                    </param>
+                    <param argument="nearest_neighbors" type="integer" value="30" optional="true" label="Number of nearest neighbors to use in first step of graph construction" help="This parameter is used both in leiden and phenograph clustering." />
+                    <param argument="use_raw" type="boolean" checked="true" optional="true" label="Whether to use raw data for clustering" help=" If False, normalized/scaled data within adata.X will be used." />
+                    <!-- <param argument="log" type="boolean" checked="true" optional="true" label="Whether to log the raw data" help="Set use_raw = True for this to take effect." /> -->
+                    <param argument="random_state" type="integer" value="0" optional="true" help="Used to change the initialization of the optimization." />
+                    <param argument="collapse_labels" type="boolean" checked="false" optional="true" help="While sub clustering only a few phenotypes/clusters, this argument helps to group all the other phenotypes/clusters into a single category- Helps in visualisation." />
+                    <param argument="label" type="text" value="" optional="true" label="Column name for the returned data" help="Stored in adata.obs. The default is adata.obs [method used]." />
+                    <!-- <param argument="output_dir"> -->
+                </section>
+            </when>
+            <when value="spatial_aggregate">
+                <expand macro="scimap_spatial_options" label="spatial_aggregate">
+                    <param argument="phenotype" type="text" value="phenotype" optional="flase" label="Column name of the column containing the phenotype information" />
+                    <param argument="purity" type="integer" value="60" min="1" max="100" label="Percent purity of neighbouring cells" help="e.g. if 60 is chosen, every neighbourhood is tested such that if a particular phenotype makes up greater than 60% of the total population it is annotated to be an aggregate of that particular phenotype." />
+                    <param argument="method" type="select" label="Select the method">
+                        <option value="radius" selected="true">radius</option>
+                        <option value="knn">knn</option>
+                    </param>
+                    <param argument="radius" type="integer" value="30" optional="true" label="The radius used to define a local neighbhourhood" />
+                    <param argument="knn" type="integer" value="10" optional="true" label="Number of cells considered for defining the local neighbhourhood" />
+                </expand>
+            </when>
+            <when value="spatial_count">
+                <expand macro="scimap_spatial_options" label="spatial_count">
+                    <param argument="phenotype" type="text" value="phenotype" optional="flase" label="Column name of the column containing the phenotype information" />
+                    <param argument="method" type="select" label="Select the method">
+                        <option value="radius" selected="true">radius</option>
+                        <option value="knn">knn</option>
+                    </param>
+                    <param argument="radius" type="integer" value="30" optional="true" label="The radius used to define a local neighbhourhood" />
+                    <param argument="knn" type="integer" value="10" optional="true" label="Number of cells considered for defining the local neighbhourhood" />
+                </expand>
+            </when>
+            <when value="spatial_distance">
+                <expand macro="scimap_spatial_options">
+                    <param argument="phenotype" type="text" value="phenotype" optional="flase" label="Column name of the column containing the phenotype information" />
+                </expand>
+            </when>
+            <when value="spatial_expression">
+                <expand macro="scimap_spatial_options" label="spatial_expression">
+                    <param argument="method" type="select" label="Select the method">
+                        <option value="radius" selected="true">radius</option>
+                        <option value="knn">knn</option>
+                    </param>
+                    <param argument="radius" type="integer" value="30" optional="true" label="The radius used to define a local neighbhourhood" />
+                    <param argument="knn" type="integer" value="10" optional="true" label="Number of cells considered for defining the local neighbhourhood" />
+                    <param argument="use_raw" type="boolean" checked="true" optional="true" label="Whether to use raw data for clustering" help=" If False, normalized/scaled data within adata.X will be used." />
+                    <!-- <param argument="log" type="boolean" checked="true" optional="true" label="Whether to log the raw data" help="Set use_raw = True for this to take effect." /> -->
+                </expand>
+            </when>
+            <when value="spatial_interaction">
+                <expand macro="scimap_spatial_options" label="spatial_interaction">
+                    <param argument="phenotype" type="text" value="phenotype" optional="flase" label="Column name of the column containing the phenotype information" />
+                    <param argument="method" type="select" label="Select the method">
+                        <option value="radius" selected="true">radius</option>
+                        <option value="knn">knn</option>
+                    </param>
+                    <param argument="radius" type="integer" value="30" optional="true" label="The radius used to define a local neighbhourhood" />
+                    <param argument="knn" type="integer" value="10" optional="true" label="Number of cells considered for defining the local neighbhourhood" />
+                    <param argument="permutation" type="integer" value="1000" optional="true" label="The number of permutations to be performed for calculating the P-Value" />
+                    <param argument="pval_method" type="select" label="Select a method to calculate the P-values">
+                        <option value="zscore" selected="true">zscore</option>
+                        <option value="histocat">histocat</option>
+                    </param>
+                </expand>
+            </when>
+            <when value="spatial_lda">
+                <expand macro="scimap_spatial_options" label="spatial_lda">
+                    <param argument="phenotype" type="text" value="phenotype" optional="flase" label="Column name of the column containing the phenotype information" />
+                    <param argument="method" type="select" label="Select the method">
+                        <option value="radius" selected="true">radius</option>
+                        <option value="knn">knn</option>
+                    </param>
+                    <param argument="radius" type="integer" value="30" optional="true" label="The radius used to define a local neighbhourhood" />
+                    <param argument="knn" type="integer" value="10" optional="true" label="Number of cells considered for defining the local neighbhourhood" />
+                    <param argument="num_motifs" type="integer" value="10" optional="true" label="The number of requested latent motifs to be extracted from the training corpus" />
+                    <param argument="random_state" type="integer" value="0" optional="true" label="The seed number for random state" />
+                </expand>
+            </when>
+            <when value="spatial_pscore">
+                <expand macro="scimap_spatial_options" label="spatial_pscore">
+                    <param argument="proximity" type="text" value="" optional="false" label="Type in the list of cell-types for which the proximity score needs to calculated" help="Comma delimited. e.g.: CellType-A,CellType-B." />
+                    <param argument="score_by" type="text" value="imageid" optional="true" label="Column name containing region's of interest for score comparison" help="Optional. By default the score is calculated across the entire image." />
+                    <param argument="phenotype" type="text" value="phenotype" optional="flase" label="Column name of the column containing the phenotype information" />
+                    <param argument="method" type="select" label="Select the method">
+                        <option value="radius" selected="true">radius</option>
+                        <option value="knn">knn</option>
+                    </param>
+                    <param argument="radius" type="integer" value="20" optional="true" label="The radius used to define a local neighbhourhood" />
+                    <param argument="knn" type="integer" value="3" optional="true" label="Number of cells considered for defining the local neighbhourhood" />
+                </expand>
+            </when>
+        </conditional>
+    </inputs>
+    <outputs>
+        <data format="h5ad" name="output" label="Scimap.tools.${analyses.selected_tool} on ${on_string}" />
+    </outputs>
+    <tests>
+        <test>
+            <param name="anndata" value="imc.h5ad" />
+            <conditional name="analyses">
+                <param name="selected_tool" value="cluster" />
+                <param name="method" value="kmeans" />
+            </conditional>
+            <output name="output">
+                <assert_contents>
+                    <has_h5_keys keys="obs/kmeans" />
+                </assert_contents>
+            </output>
+        </test>
+        <test>
+            <param name="anndata" value="tutorial_data_pheno.h5ad" />
+            <conditional name="analyses">
+                <param name="selected_tool" value="spatial_aggregate" />
+            </conditional>
+            <output name="output">
+                <assert_contents>
+                    <has_h5_keys keys="obs/spatial_aggregate" />
+                </assert_contents>
+            </output>
+        </test>
+    </tests>
+    <help>
+        <![CDATA[
+**What it does**
+
+This tool does various single cell spatial analyses with Scimap.
+
+**Input**
+
+AnnData.
+
+**Output**
+
+Anndata with a corresponding key added.
+
+
+        ]]>
+    </help>
+    <citations>
+    </citations>
+</tool>
Binary file test-data/imc.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/manual_gates.csv	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,19 @@
+markers,gate
+ASMA,6.6
+CD163,6.6
+CD206,7.5
+CD68,6.2
+CD20,7.8
+CD21,8
+CD3D,6.5
+CD45,7.3
+CD56,8.7
+CD8A,6.5
+FOXP3,5.2
+CD11B,6.7
+CD11C,6.3
+CD15,7.9
+CD4,7.4
+PD1,7.9
+HLADR,6.7
+CD25,7
\ No newline at end of file
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/mcmicro_output.csv	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,4826 @@
+CellID,DNA1,BG1,BG2,BG3,DNA2,CD25,CD2,CD10,DNA3,CD163,CD3D,CD5,DNA4,CD30,ACTIN,CD45,DNA5,CD206,CD68,PD1,DNA6,KI67,CD11C,CD7,DNA7,CD8A,FOXP3,CD20,DNA8,CD4,HLADR,PSTAT3,DNA9,PS6,PERK,CD21,DNA10,CD43,NOS2,PDL1,DNA11,CD11B,CD57,MHCI,DNA12,CD15,ASMA,CD56,X_centroid,Y_centroid,Area,MajorAxisLength,MinorAxisLength,Eccentricity,Solidity,Extent,Orientation
+1,16640.5641,719.6324786,527.7094017,1100.273504,14726.17094,581.5811966,618.3846154,1606.777778,7182.247863,509.3247863,477.5897436,1795.410256,10677.03419,1084.051282,5382.076923,2983.239316,3771.91453,1103.111111,399.3418803,2705.57265,7494.65812,1599.940171,757.7692308,451.6324786,8504.008547,389.8547009,109.042735,7809.042735,7239.435897,1408.564103,807.2393162,2814.196581,5718.74359,617.4273504,260.0598291,20362.76923,3721.222222,756.3589744,370.4615385,1334.666667,3247.74359,969.8034188,148.5726496,4133.598291,2508.555556,1085.735043,218.5470085,3170.470085,511.5555556,9.846153846,117,14.53227038,10.27362788,0.707260822,0.959016393,0.75,-0.695369483
+2,16938.30097,686.5533981,469.3009709,1048.048544,14650.61165,565.8932039,442.2912621,1539.398058,7244.252427,496.8252427,484.9029126,1793.932039,10165.42718,1056.427184,3202.825243,2895.475728,3729.495146,1076.504854,352.3980583,2904.805825,6971.31068,5288.281553,725.8446602,433.0485437,8211.699029,380.2524272,101.9320388,4205.223301,7051.174757,1366.407767,998.4951456,2812.883495,5586.271845,594.7281553,244.7669903,5087.757282,3746,790.631068,349.2038835,1326.640777,3062.407767,867.8932039,143.3300971,2705.466019,2386.116505,1075.640777,164.4854369,3116.76699,579.3300971,9.398058252,103,16.0562861,8.776322775,0.837395595,0.903508772,0.613095238,1.115706828
+3,16243.54167,819.4166667,604.3916667,1098.15,14324.90833,666.475,574.3333333,1759.683333,7296.325,548.05,494.1666667,1901.141667,10336.58333,1179.216667,3045.058333,2509.725,3901.975,1155.625,775.5916667,2448.65,7403.65,1932.808333,2533.725,477.5416667,8438.216667,389.1083333,109.1333333,4923.483333,7260.166667,1615.125,968.4166667,2785.666667,5864.183333,906.15,264.625,10590.6,4249.358333,781.4583333,368.4,1401.816667,3333.691667,1236.808333,150.7,4460.333333,2634.016667,1164.391667,227.7416667,3156.108333,630.9583333,12.88333333,120,15.2220045,10.31075603,0.735652971,0.975609756,0.681818182,0.151615546
+4,20215.44295,695.3087248,444.5436242,1063.375839,17440.28188,558.5033557,408.5771812,1557.738255,8583.442953,472.3691275,347.0939597,1772.805369,12923.10067,1081.255034,4449.959732,3137.201342,4895.798658,1106,332.885906,2400.060403,8861.348993,2666.100671,125.0872483,419.2013423,10357.71812,384.3691275,103.8926174,6379.765101,8868.865772,1235.09396,794.7181208,2789.630872,6966.872483,547.4362416,244.6979866,5095.61745,5177.644295,710.738255,359.2483221,1279.228188,3952.899329,674.3087248,144.6845638,2517.95302,3096.026846,1097.530201,155.3624161,3090.751678,745.1946309,16.27516779,149,14.38020046,13.4047589,0.362026674,0.967532468,0.662222222,-0.270451448
+5,17922.32934,685.9580838,521.6646707,1075.023952,15913.23952,562,524.4550898,1596.982036,8090.39521,482.0658683,372.8982036,1808.51497,11358.23952,1041.275449,3203.676647,2656.94012,4390.658683,1079.97006,315.6467066,2396.39521,7671.389222,2875.526946,122.8742515,427.508982,9384.772455,372.9041916,101.2754491,4407.814371,7981.209581,1239.616766,825.754491,2779.275449,6312.275449,514.5928144,251.3353293,18157.99401,4689.820359,725.508982,350.5628743,1326.952096,3575.724551,838.2155689,144.2275449,2677.179641,2866.928144,1107.874251,157.6047904,3074.137725,657.1736527,18.03592814,167,17.67583101,12.11010632,0.728428039,0.943502825,0.695833333,-0.810889758
+6,16637.04942,666.9593023,432.4767442,1054.688953,14887.5407,558.5494186,536.3953488,1500.401163,7671.296512,489.2005814,665.7616279,1770.860465,10399.71512,1047.305233,3711.02907,3216.81686,3880.555233,1071.488372,315.7151163,3681.30814,7289.337209,3397.715116,100.9796512,511.1773256,8499.674419,373.2383721,102.1569767,4943.063953,7466.773256,1425.049419,861.7877907,2810.572674,5848.133721,538.1133721,245.0465116,11203.57558,4117.572674,872.9127907,358.6860465,1312.43314,3298.465116,668.005814,161.747093,3301.197674,2583.406977,1076.712209,208.8430233,3081.438953,573.255814,21.36337209,344,25.24958833,17.93258704,0.703986811,0.919786096,0.688,-1.541931451
+7,17428.98758,731.7826087,498.1925466,1156.602484,15325.03727,599.7204969,806.1304348,1759.869565,7472.993789,499.621118,911.2919255,1789.795031,11319.62112,1120.285714,3551.763975,2527.745342,4296.248447,1125.198758,335.1428571,3000.826087,7738.186335,484.6521739,172.9689441,751.8322981,9078.795031,545.9875776,106.6086957,3170.695652,7749.863354,1292.099379,743.0372671,2804.602484,6275.639752,546.0062112,263.5652174,15315.98137,4576.863354,1825.89441,364.0559006,1341.36646,3604.236025,737.6583851,174.9068323,4941.049689,2795.322981,1157.801242,282.1490683,3144.385093,693.8136646,18.92546584,161,15.59784113,13.54223486,0.496193207,0.904494382,0.670833333,0.289214038
+8,21476.56693,675.9055118,403.2440945,1026.944882,18771.98425,563.4015748,713.9606299,1450.149606,8658.787402,476,1631.606299,1743.488189,13842.14173,1077.866142,3975.566929,2535.527559,5052.96063,1083.409449,372.8188976,5595.031496,9231.818898,1442.84252,474.9055118,741.3700787,10880.04724,371.7244094,101.9685039,3255.976378,9126.629921,1602.92126,693.4015748,2779.614173,7278.937008,565.4251969,242.1968504,7154.661417,5256.102362,1052.480315,351.8582677,1383.251969,3720.488189,700.1811024,143.023622,3909.897638,3111.173228,1059.700787,239.5590551,3106.015748,786.7559055,18.66929134,127,15.498643,10.82948919,0.71537777,0.940740741,0.566964286,-0.95753058
+9,22720.96113,709.9434629,432.3074205,1064.724382,20137.56537,584.614841,658.6713781,1525.837456,10173.25088,523.844523,819.5229682,1771.459364,14537.68551,1089.526502,3853.65371,2819.34629,5210.759717,1127.498233,398.0106007,4931.837456,10059.63604,2319.787986,986.819788,624.254417,11531.18728,378.8657244,109.9929329,3350.077739,9882.017668,1510.628975,807.6501767,2813.321555,7968.922261,531.7385159,255.5229682,7738.565371,5372.155477,1024.381625,372.4169611,1373,4428.865724,820.4946996,147.6219081,2948.777385,3424.897527,1112.731449,223.8268551,3127.992933,515.9081272,23.56537102,283,21.17393298,17.77633935,0.543299658,0.901273885,0.585921325,1.225395231
+10,15906.02174,734.0289855,659.8985507,1090.753623,14285.63768,585.3985507,611.3768116,1588.652174,7279.710145,519.5942029,448.5724638,1822.485507,10008.05797,1105.637681,4756.971014,3229.07971,3780.594203,1127.456522,327.3115942,2578.253623,7121.195652,1112.173913,155.8550725,432.7173913,8342.137681,397.5797101,109.0797101,6809.57971,7161.5,1314.355072,1038.753623,2815.76087,5652.275362,536.7898551,254.3405797,13143.52899,4017.942029,781.1086957,368.173913,1334.934783,3283.492754,667.1014493,147.8478261,3441.818841,2589.282609,1115.442029,205.3695652,3099.224638,549.7246377,20.69565217,138,14.160818,12.52565142,0.466485576,0.926174497,0.704081633,0.90930707
+11,18001.72464,701.2028986,480.6775362,1055.322464,15580.51812,567.1304348,671.2391304,1524.438406,7094.952899,469.8478261,763.1268116,1750.753623,11119.2029,1076.054348,4415.826087,3322.601449,4128.561594,1075.75,329.3333333,4875.855072,7303.985507,1378.753623,402.1992754,664.0108696,8593.311594,363.9057971,104.0507246,5804.452899,7232.543478,1499.369565,745.1195652,2785.445652,5658.460145,516.6195652,246.0543478,15184.72826,3981.978261,955.0289855,351.7789855,1317.050725,2782.695652,681.826087,143.3188406,4181.836957,2336.67029,1062.576087,245.8985507,3134.086957,822.0905797,24.48188406,276,20.56850935,17.54794381,0.521672033,0.958333333,0.73015873,-1.207261085
+12,18065.39394,814.4181818,1050.181818,1140.690909,16025.51515,623.2848485,716.0060606,1706.066667,7891.539394,524.569697,656.3575758,1815.854545,10894.6303,1118.048485,2851.248485,2470.109091,4076.872727,1162.284848,350.3636364,2953.939394,7775.084848,375.0484848,1181.012121,528.7515152,8953.830303,393.2545455,112.1030303,2989.284848,7400.6,1500.763636,856.8545455,2836.660606,5910.060606,617.6,246.6666667,4772.509091,3693.30303,906.8727273,378.4121212,1337.363636,3235.054545,1101.872727,152.5393939,4033.993939,2436.860606,1236.527273,364.5030303,3173.515152,466.8060606,22.34545455,165,21.21484471,10.15640075,0.877956572,0.916666667,0.634615385,1.15203287
+13,17345.54639,725.5773196,518.8814433,1079.216495,15271.71649,597.7525773,1065.546392,1614.865979,7820.876289,523.5618557,1201.360825,1832.963918,11011.56186,1104.458763,5483.494845,3866.804124,4197.309278,1129.551546,321.0876289,7072.463918,7907.618557,640.4896907,113.5463918,729.0463918,9010.350515,411.1597938,102.4690722,3933.319588,7792.994845,1931.175258,769.2938144,2791.701031,6156.175258,566.8556701,256.4175258,14769.87113,4548.273196,1233.448454,357.3556701,1359.917526,3601.520619,636.8298969,146.9226804,4150.226804,2817.948454,1128.365979,308.185567,3158.051546,595.9845361,23.69072165,194,17.16673236,14.45989668,0.538976417,0.946341463,0.713235294,0.977732195
+14,25852.2875,748.5375,558.8083333,1104.991667,22493,595.3083333,466.1666667,1611.108333,10963.60833,496.8541667,383.9083333,1789.679167,16392.01667,1138.995833,2915.958333,2493.091667,6016.875,1162.183333,358.0791667,2758.116667,10652.59583,1763.1375,202.1791667,426.8333333,12867,387.125,106.5541667,3984.679167,10791.84583,1334.8875,788.35,2782.883333,8434.279167,529.1333333,252.0666667,7494.566667,6385.0625,761.6125,370.9166667,1308.4875,4657.508333,709.7625,151.6916667,2539.033333,3745.095833,1141.158333,144.9375,3145.420833,755.2708333,26.48333333,240,19.28685511,16.3576434,0.529797882,0.93385214,0.705882353,-0.227701741
+15,10222.59551,609.4494382,461.8202247,998.7752809,9242.640449,515.2359551,1013.47191,1372.179775,4653.044944,464.4382022,933.8651685,1773.05618,6687.337079,975.8876404,5476.685393,3216.955056,2444.58427,1020.101124,361.4269663,5059.910112,4800.797753,355.1910112,1406.741573,554.2921348,5648.202247,322.5168539,97.61797753,5169.921348,4805.910112,1666.370787,827.3595506,2794.404494,3747.842697,536.1011236,223.3820225,11483.64045,2568.573034,886.5280899,337.3370787,1359.146067,2250.595506,908.2921348,215.3595506,4128.932584,1765.303371,991.9213483,296.2247191,3050.438202,496.3146067,21.71910112,89,11.1479573,10.36743383,0.367597297,0.956989247,0.674242424,-1.359742306
+16,20699.90667,741.9466667,574.8,1104.28,18583.32,617.7733333,767.36,1639.813333,9342.24,557.2533333,1449.12,1830.8,13216.22667,1123.933333,5175.88,3771.666667,4823.253333,1180.386667,390.7333333,6576.933333,9266.173333,500.32,814.5066667,668.1333333,11066.96,379,111.6533333,4729.613333,9216.426667,1637.786667,958.1333333,2810.173333,7359.786667,537.5866667,269.6666667,20234.85333,5102.88,1181.573333,377.5333333,1420.586667,4207.173333,863.28,168.3733333,4970.56,3350.92,1147.16,299.52,3104.733333,539.3866667,22.24,75,12.57922347,7.969694216,0.77369347,0.925925926,0.625,0.461545519
+17,21590.01198,689.4011976,443.4730539,1060.838323,18553.41317,573.3532934,639.3113772,1575.682635,9451.035928,498.5748503,460.7964072,1786.550898,12868.31138,1074.179641,3653.946108,2533.772455,5036.203593,1084.694611,322.1497006,2739.622754,8854.826347,5187.892216,276.4071856,451.4251497,10552.93413,407.0359281,99.46107784,5092.257485,9003.634731,1345.209581,865.0359281,2778.556886,7135.335329,574.7065868,246.4550898,11129.2515,5275.461078,750.994012,352.0179641,1293.167665,3984.065868,681.1497006,144.5868263,3190.526946,3189.179641,1099.868263,161.5988024,3100.634731,614.3772455,24.50299401,167,14.80328499,14.53712827,0.188774673,0.965317919,0.695833333,-0.670820353
+18,16131.30612,670.8163265,441.0748299,1041.823129,13902.06122,536.6938776,465.8979592,1504.816327,6270.346939,455.3129252,453.9047619,1774.326531,9843.272109,1050.918367,3407.47619,2774.823129,3677.62585,1051.979592,322.6530612,3122.238095,6594.244898,1715.312925,129.755102,469.5238095,7830.020408,365.244898,100.2108844,4969.646259,6568.068027,1376.054422,787.3945578,2807.639456,5195.687075,571.8911565,229.9591837,8031.741497,3511.823129,791.8571429,347.2176871,1276.578231,2473.210884,586.3129252,137.9863946,3505.816327,2029.07483,1025.272109,171,3093.156463,838.1564626,24.49659864,147,14.68161234,13.42466576,0.404842714,0.924528302,0.7,1.278434268
+19,17681.25581,647.3895349,406.7732558,1028.706395,15216.8343,536.6162791,490.6133721,1489.238372,7269.273256,447.4418605,344.6598837,1760.880814,11163.63953,1029.526163,3684.912791,2719.156977,4152.877907,1040.218023,317.2267442,2500.159884,7483.863372,1877.909884,120.3982558,423.3575581,8719.915698,354.8633721,100.9040698,5387.215116,7368.531977,1228.156977,784.9796512,2778.514535,5869.415698,513.3023256,231.2093023,8494.915698,4276.328488,673.872093,343.3953488,1298.709302,3047.142442,634.2645349,136.5232558,2508.159884,2511.078488,1035.061047,170.6860465,3060.252907,800.5697674,28.12209302,344,24.97850823,17.91814904,0.696720558,0.974504249,0.682539683,1.041157883
+20,23166.27551,659.5714286,390,1051.867347,20333.14286,557.3061224,369.3979592,1521.265306,9766.734694,465.1530612,424.9387755,1747.806122,14528.12245,1061.836735,2545.714286,2363.367347,5391.55102,1064.418367,325.9489796,2995.132653,9403.663265,2694.704082,93.29591837,484.2040816,11584.37755,345.255102,103.4591837,3176.571429,9781.204082,1224.397959,845.1938776,2794.22449,7786.94898,529.622449,239.255102,4683.204082,5792.663265,711.3163265,354.5102041,1283.102041,4198.010204,620.3571429,136.0102041,1997.673469,3357.326531,1072.489796,142.255102,3027,720.7653061,25.80612245,98,14.5562829,8.825940109,0.795211611,0.951456311,0.544444444,0.603697504
+21,21450.385,678.91,442.695,1061.15,18555.085,554.365,471.325,1585.13,9096.31,468.155,359.275,1800.165,13413.87,1063.365,3587.42,3046.015,5067.505,1066.36,323.02,2450.04,8851.35,3884.165,349.405,413.775,10431.18,355.215,106.2,6637.885,8979.435,1239.855,949.51,2806.4,7213.33,518.11,242.975,6277.835,5330.85,688.45,347.325,1281.075,3965.12,736.045,144.045,2833.865,3090.37,1088.045,150.84,3036.32,736.165,26.095,200,21.10549957,12.49231314,0.806012523,0.938967136,0.714285714,1.228089221
+22,18549.69091,712.5212121,451.0909091,1058.084848,15856.8,566.8666667,626.9212121,1542.478788,6929.757576,475.5878788,691.3636364,1761.612121,11506.64242,1090.860606,5144.290909,3118.206061,4134.90303,1110.551515,337.0969697,4359.218182,7435.763636,2158.381818,105.1636364,521.9636364,8921.593939,396.3636364,107.2121212,5958.830303,7331.381818,1554.660606,690.9393939,2788.363636,5779.024242,608.8545455,245.7636364,10578.46667,3949.890909,875.4060606,350.5575758,1310.169697,2671.448485,605.0787879,144.2121212,2690.642424,2282.351515,1067.139394,238.8,3105.248485,855.1030303,28.93939394,165,17.74668721,12.44341596,0.712995722,0.964912281,0.647058824,-0.569781106
+23,36404.87619,882.2380952,512.6285714,1098.790476,31779.59048,684.1809524,815.5333333,1592.714286,15560.22857,592.8571429,1312.6,1739.12381,22076.19048,1227.914286,4705.990476,2709.647619,8080.2,1250.2,376.952381,2796.628571,15771.80952,350.6190476,406.9428571,729.7619048,17988.19048,816.5904762,119.9142857,2040.495238,14999.6381,1493.92381,760.8190476,2823.466667,11731.61905,618.3428571,266.152381,2813.009524,7306.552381,1084.352381,402.0857143,1298.066667,6544.761905,673.6952381,153.4761905,2096.980952,4781.952381,1163.780952,431.0380952,3162.638095,448.6285714,26.55238095,105,12.95898131,10.56428097,0.579166588,0.913043478,0.673076923,-0.017470717
+24,14565.37805,612.9085366,425.445122,996.8536585,13171.72561,516.9512195,447.4756098,1413.243902,6614.603659,462.3109756,560.4634146,1757.219512,9069.304878,992.4695122,4797.52439,3096.963415,3285.414634,1026.542683,346.0853659,3656.158537,6378.634146,1093.432927,361.3353659,452.1585366,7257.829268,330.402439,103.8353659,6162.47561,6089.52439,1453,905.9390244,2843.341463,4779,534.652439,229.4634146,7868.371951,3187.378049,926.847561,342.0121951,1300.676829,2665.884146,666.902439,146.0731707,2652.384146,2051.219512,1003.926829,204.5243902,3061.134146,486.5304878,29.62804878,164,16.20350395,13.06637744,0.59138126,0.947976879,0.643137255,-0.382111502
+25,15652.2931,678.4482759,473.2931034,1059.672414,13746.10345,556.7298851,541.4482759,1558.649425,5841.091954,463.7816092,468.4195402,1771.781609,9636.201149,1042.028736,3529.574713,2244.109195,3531.063218,1069.482759,373.8965517,3513.413793,6433.609195,2353.074713,519.954023,464.4827586,7486.683908,367.7241379,99.8908046,5747.431034,6161.132184,1418.442529,711.9597701,2795.017241,4899.902299,596.5,247.1954023,14855.90805,3268.908046,753.5,340.3908046,1344.5,2238.890805,754.3793103,143.408046,3426.074713,1892.528736,1016.816092,237.5689655,3106.235632,867.3333333,29.93103448,174,18.50458015,12.20524539,0.751634633,0.935483871,0.743589744,-0.056207698
+26,19822.29358,687.8623853,422,1040.87156,17145.57798,560.1192661,672.2110092,1456.908257,8226.816514,485.146789,1144.238532,1761.12844,12704.66972,1066.779817,2522.495413,2584.045872,4707.302752,1103.550459,368.8715596,5704.669725,8281.93578,439.6238532,212.7522936,606.2844037,10318.97248,327.9082569,104.8073394,2473.788991,8544.220183,1524.825688,657.8623853,2777.366972,6714.954128,511.6880734,249.6880734,12654.15596,5043.522936,916.1743119,355.9541284,1384.651376,3648.87156,693.4770642,145.1743119,3817.899083,3027.614679,1092.522936,236.2385321,3084.394495,779.6146789,28.74311927,109,12.49933506,11.10605404,0.458815448,0.973214286,0.756944444,0.845818395
+27,29560.13725,788.5,529.5,1084.009804,26079.92157,662.5784314,1039.343137,1571.245098,13104.22549,571.7254902,2269.892157,1783.892157,17923.88235,1175.186275,5227.882353,3532.303922,6574.156863,1198.784314,375.4117647,4053.843137,12888.60784,616.7941176,906.6862745,1266.401961,14860.20588,398.3137255,411.1764706,3016.480392,12112.84314,1924.421569,806.5294118,2878.078431,9710.098039,631.7058824,274.0392157,5947.686275,6380.617647,1266.754902,397.7745098,1330.882353,5525.431373,875.7843137,161.8235294,3523.882353,4136.343137,1170.127451,567.3137255,3112.411765,459.2156863,30.43137255,102,12.65695658,10.48628426,0.55998956,0.944444444,0.653846154,0.380835727
+28,15897.90226,626.0526316,409.5037594,1021.18797,13733.18045,517.1654135,432.9548872,1434.887218,7072.06015,465.556391,545.7142857,1745.315789,9824.368421,995.4285714,3889.300752,2396.759398,3465.353383,1034.180451,335.7293233,3418.24812,6842.894737,602.3308271,988.3909774,460.9398496,7703.421053,324.1804511,104.1353383,4967.323308,6600.458647,1427.330827,850.3984962,2819.481203,5154.819549,518.7744361,228.0902256,7483.834586,3509.924812,865.112782,340.8646617,1331.315789,2932.203008,842.5789474,151.3609023,2890.398496,2225.203008,1029.488722,230.2105263,3078.255639,501.0150376,31.35338346,133,17.06374558,10.28904684,0.797758539,0.898648649,0.558823529,-0.630902615
+29,16887.15702,770.0413223,520.1404959,1088.917355,15142.04132,621.5454545,520.1652893,1598.892562,7750.661157,546.7190083,484.785124,1836.247934,10741.89256,1166.363636,4856.619835,2806.966942,3850.429752,1179.677686,600.2396694,3118.07438,7525.809917,867.231405,1499.46281,467.0330579,8737.677686,370.3719008,112.3884298,7302.661157,7356.206612,1510.520661,1057.603306,2810.181818,5955.057851,564.9504132,278.1900826,20674.6281,4233.22314,838.7107438,384.214876,1376.239669,3443.933884,990.2727273,156.4958678,4120.198347,2803.826446,1164.46281,252.3636364,3100.041322,534.2066116,31.09917355,121,12.70991667,12.33678041,0.240528338,0.9453125,0.617346939,-0.402621696
+30,18373.89147,731.6589147,502.5736434,1099.883721,16424.2093,577.6434109,521.9844961,1678.682171,8233.333333,499.6356589,416.4108527,1793.434109,12345.36434,1116.410853,6452.449612,3439.449612,4584.976744,1116.426357,332.2170543,2431.666667,8250.875969,2429.100775,104.1782946,440.6976744,10030.31008,381.0620155,108.2868217,7761.550388,8547.224806,1301.968992,852.1782946,2799.131783,6820.193798,548.6356589,275.372093,29554.51938,5193.457364,752.7131783,366.9147287,1326.465116,4022.604651,772.0310078,150.0465116,5128.860465,3220.612403,1148.341085,236.3488372,3223.418605,687.9612403,31.05426357,129,14.13556353,11.72514542,0.558538709,0.962686567,0.767857143,1.18206732
+31,23437.41667,721.3257576,456.9242424,1063.734848,20787.21212,598.7727273,1065.439394,1531.318182,10494.66667,522.7045455,1313.431818,1744.181818,15541.86364,1118.143939,3903.689394,2945.568182,5816.689394,1137.69697,342.5378788,4423.901515,10579.43939,1345.454545,109.6060606,915.9621212,12925.00758,367.1666667,108.1136364,4472.44697,10866.17424,1691.840909,829.1060606,2794.924242,8723.69697,585.3560606,260.5681818,14635.09848,6563.590909,1167.257576,376.0606061,1356.840909,5112.05303,715.969697,148.5757576,5284.954545,4064.19697,1176.69697,269.1666667,3127.409091,701.5075758,31.84848485,132,13.81738292,12.2443384,0.463389578,0.942857143,0.676923077,0.386767438
+32,40014.78351,1148.505155,564.4948454,1137.793814,34812.04124,763.2061856,624.556701,1654.123711,17047.94845,649.8350515,476.0515464,1770.927835,24757.85567,1642.927835,4466.402062,2875.154639,8759.608247,1276.938144,403.443299,2390.917526,17294.97938,368.5463918,139.0206186,452.7010309,19943.26804,409.2989691,126.6597938,5639.360825,16555.18557,1406.505155,820.7525773,2805.938144,12992.4433,587.9072165,296.3814433,2654.587629,7924.649485,797.185567,405.2680412,1303.360825,7182.340206,604.3402062,159.7113402,1223.010309,5210.082474,1177.845361,406.556701,3240.525773,437.628866,31.16494845,97,15.81025127,8.524970973,0.842174368,0.850877193,0.587878788,-1.256427802
+33,16620.70423,666.7887324,439.528169,1056.633803,15066.71831,542.6267606,378.8380282,1536.457746,7788.535211,482.5915493,439.2816901,1774.387324,10496.65493,1054.901408,3741.077465,2600.640845,3884.823944,1074.591549,322.9295775,2708.288732,7354.34507,3984.014085,141.4084507,423.6619718,8534.21831,354.6126761,103.3450704,4813.640845,7357.035211,1308.401408,877.1690141,2814.795775,5851.288732,532.4084507,258.8309859,16673.76056,4152.373239,733.7887324,361.6267606,1301.323944,3329.93662,650.5704225,145.028169,3348.070423,2655.105634,1072.760563,185.5,3084.683099,547.1197183,33.20422535,142,16.72674259,11.39784997,0.731897444,0.916129032,0.591666667,-0.996846612
+34,17464.97674,740.872093,694.0813953,1110.162791,14963.72093,581.5,702.8488372,1718.813953,7778.55814,488.5813953,422.1860465,1859.523256,11248.5,1087.337209,2537.593023,2204.046512,4150.406977,1143.883721,323.0348837,2911.127907,7220.197674,470.3604651,226.2209302,432.5813953,9149.011628,369.9186047,102.3953488,3505.186047,7671.906977,1267.546512,840.9534884,2813.604651,5963.290698,517.0697674,253.1395349,10731.90698,4634.232558,983.3837209,365.7674419,1343.151163,3565.965116,743.255814,142.7325581,3458.651163,2870.313953,1123.232558,190.627907,3130.162791,664.2209302,31.89534884,86,11.61332602,9.644256094,0.557097082,0.924731183,0.601398601,1.251857345
+35,23670.2037,719.1759259,402.4907407,1071.305556,20625.00926,593.9722222,682.1666667,1512.555556,10284.25926,501.8055556,1588.916667,1746.694444,15399.72222,1158.425926,3473.916667,2404.388889,5688.037037,1135.398148,348.7037037,6941.898148,10267.08333,941.25,115.6851852,1224.425926,12328.25,411.2222222,104.9444444,1835.916667,10532.39815,1554.712963,766.1203704,2808.481481,8358.5,551.1111111,239.3518519,3978.62963,6364.296296,1159.527778,369.2777778,1316.138889,4770.148148,621.9259259,149.287037,3108.87037,3749.824074,1137.444444,203.4907407,3070.703704,715.7592593,33.78703704,108,13.01003307,10.80007619,0.557563318,0.964285714,0.639053254,0.691427039
+36,20355.45775,684.0422535,411.3661972,1037.93662,17356.35211,560.9084507,1098.295775,1466.049296,9188.859155,510.2887324,1534.78169,1736.06338,12476.1831,1078.943662,4259.225352,2965.309859,4846.528169,1122.190141,314.3380282,6118.06338,8854.450704,592.1901408,91.8028169,777.1056338,10297.19014,428.084507,98.27464789,2464.007042,8923.528169,1494.788732,807.9084507,2781.359155,7175.126761,515.6971831,239.2253521,10051.29577,5348.84507,1262.140845,342.7112676,1325.302817,4097.133803,595.7183099,143.0774648,2837.753521,3289.190141,1102.908451,307.1056338,3065,607.6619718,35.00704225,142,15.91096602,11.55017422,0.687773457,0.953020134,0.676190476,1.072221865
+37,18552.675,742.6125,1203.275,1175.9375,16420.55,592.1,838.5625,1655.2875,8619.0875,522.4875,849.425,1850.7,11413.975,1076.1875,3279.5,3038.975,4348.7625,1124.125,358.2125,4623.8,8282.6125,440.5875,843.2375,622.7,9469.825,392.125,111.8,2796.85,7831.6125,1548.05,826.65,2836.9625,6220.85,543.35,250.9125,7723.325,4180.9875,1044.625,382.4875,1377.6,3461.8,762.3375,146.9,3994.1625,2667.2375,1096.7125,244.1125,3161.225,470.575,32.7375,80,11.755712,9.078035877,0.635351101,0.879120879,0.666666667,-1.406810394
+38,14795.21495,656.317757,475.5233645,1061.476636,13145.6729,549.9252336,399.9252336,1600.317757,7009.018692,491.2149533,434.317757,1818.738318,9488.962617,1038.448598,4703.766355,3912.700935,3425.53271,1046.336449,314.4579439,2658.196262,6693.88785,555.0373832,122.682243,432.1775701,7705.327103,342.7570093,103.7757009,8574.654206,6742.523364,1277.757009,1021.28972,2803.037383,5312.35514,504.1869159,246.5514019,13514.90654,3797.542056,720.1028037,349,1294.336449,3027.757009,665.7196262,148.7383178,4144.336449,2411.158879,1054.542056,175.1869159,3129.971963,569.3738318,34.42056075,107,12.31552579,11.17282298,0.420668442,0.955357143,0.743055556,-0.889130187
+39,31869.23457,747.9753086,442.9259259,1066.666667,27316.85185,622.2345679,752.8395062,1581.049383,13769.44444,554.9506173,1185.765432,1845.037037,19975.06173,1146.580247,5020.493827,2722.82716,6900.555556,1196.234568,379.9012346,5435.345679,13430.81481,539.7654321,1121.91358,690.7901235,15830.93827,371.5925926,115.7283951,2624.308642,13580.85185,1810.481481,792.6419753,2825.432099,10484.06173,568.8024691,279.9753086,5719.691358,7304.320988,936.5679012,382.1604938,1405.135802,6127.012346,866.5679012,171.9753086,3616.530864,4611.679012,1139.469136,367.1234568,3149.703704,506.4938272,37.60493827,81,14.70270269,7.156066437,0.873559287,0.952941176,0.519230769,-0.653898052
+40,21126.69231,724.3186813,439.5384615,1085.626374,18507.69231,587.3186813,628.8131868,1566.769231,9520.076923,499.8791209,384.0659341,1764.835165,12705.89011,1086.307692,3330.703297,2123.758242,4831.879121,1090.923077,328.1428571,2426.087912,8608.813187,1176.10989,265.3956044,478.3076923,10153.86813,388.1428571,102.043956,2369.054945,8812.846154,1263.505495,835.5384615,2804.241758,6970.659341,563.8901099,242.6813187,3691.076923,5196.912088,708.3516484,353.8571429,1294.967033,3911.043956,642.4505495,143.4505495,2114.549451,3067.703297,1108.263736,140.1978022,3138.010989,636.4835165,35.31868132,91,12.38143014,9.456350466,0.645508979,0.947916667,0.842592593,1.411269735
+41,21101.93452,742.8214286,463.6607143,1373.053571,18412.54762,565.8452381,472.6428571,1967.595238,9295.166667,472.3928571,409.1428571,1773.416667,13683.48214,1093,3871.964286,2275.095238,5058.255952,1085.208333,335.1547619,2813.660714,8984.613095,5282.065476,758.3333333,457.2916667,11044.69643,401.1071429,108.1190476,5372.089286,9402.10119,1321.767857,981.1130952,2805.529762,7370.982143,705.2857143,244.0178571,6111.529762,5707.077381,760.9880952,360.3571429,1305.428571,4266.196429,841.7321429,141.672619,3062.303571,3390.14881,1109.125,167.7321429,3138.14881,728.8988095,38.28571429,168,16.28345208,13.35051972,0.572531617,0.938547486,0.7,-0.4459838
+42,23997.91667,778.7037037,483.5092593,1104.12963,20598.03704,614.287037,523.6388889,1648.351852,10302.84259,513.1203704,622.9814815,1807.101852,15422.23148,1182.62963,3923.638889,3591.916667,5696.490741,1165.324074,351.2685185,3549.87963,10221.92593,1005.481481,97.02777778,736.787037,12201.16667,379.3981481,107.7222222,5230.574074,10397.24074,1462.833333,847.5648148,2794.824074,8030.481481,548.7777778,268.1111111,11880.68519,6177.87037,1044.740741,382.2777778,1337.648148,4580.185185,707.6018519,148.1574074,2981.611111,3636.527778,1173.888889,210.1666667,3190.555556,768.5833333,36.44444444,108,13.35798475,10.54426514,0.613930002,0.923076923,0.692307692,-1.393054592
+43,16320.11429,668.8928571,426.5,1050.992857,14231.60714,554.5714286,427.25,1511.692857,6728.378571,452.3285714,348.7571429,1760.228571,10398.83571,1065.571429,2363.057143,2240.25,3873.928571,1080.921429,335.6642857,2476.864286,6907.385714,664.5071429,102.4428571,430.2642857,8401.642857,356.8142857,103.2857143,5139.792857,7109.971429,1273.521429,730.0071429,2835.928571,5647.7,553.9857143,243.4857143,13515.25,4031.278571,671.15,359.8214286,1300.328571,2808.1,585.1,148.4071429,2553.407143,2364.764286,1053.028571,179.7642857,3077.214286,840.7857143,36.11428571,140,15.23283642,12.12034386,0.605727508,0.939597315,0.717948718,1.296202542
+44,28329.52941,737.3823529,480.6960784,1053.617647,25368.15686,610.0490196,565.0294118,1433.529412,12956.78431,540.7352941,787.7058824,1770.323529,17265.58824,1129.941176,4427.95098,3480.823529,6713.539216,1173.372549,372.5882353,3385.970588,12455.65686,381.754902,1043.823529,788.0980392,14367.16667,413.4313725,117.4509804,2644.313725,11788.20588,1678.784314,855.3039216,2826.568627,9486.686275,590.7254902,246.9313725,3192.715686,6341.235294,1171.529412,383.4509804,1330.166667,5422.598039,827.4901961,155.254902,3633.333333,4032.156863,1135.45098,390.745098,3063.843137,451.7745098,38.89215686,102,13.55713516,9.956206069,0.678729198,0.879310345,0.607142857,0.289150069
+45,25898.15464,694.2680412,402.4845361,1048.71134,22569.43299,582.6804124,819.0515464,1497.175258,11466.46392,532.556701,1134.536082,1734.793814,16093.8866,1075.927835,4079.14433,2440.742268,5741.762887,1133.824742,355.4123711,4536.237113,10733.10309,857.5257732,796.1752577,829.8969072,12596.78351,353.4329897,107.9587629,2669.061856,10781.37113,1516.247423,779.257732,2811.123711,8458.092784,533.0206186,260.7010309,7946.938144,5935.639175,947.9690722,373.5773196,1387.268041,4857.237113,797.0412371,170.185567,3305.587629,3753.340206,1118.783505,309.4226804,3127.484536,519.8556701,36.12371134,97,14.8174248,8.629234642,0.812923318,0.91509434,0.60625,-1.387958305
+46,18578.53676,675.2647059,450.2867647,1062.580882,16236.61029,559.5588235,443.7941176,1654.580882,8661.147059,489.9558824,492.3235294,1810.485294,11864.69853,1059.286765,3910.544118,2983.198529,4367.316176,1058.838235,310.8529412,3310.654412,8218.455882,1360.242647,97.04411765,470.3014706,9291.492647,355.7794118,100.4411765,5719.838235,8223.264706,1337.419118,977.1029412,2809.941176,6539.014706,533.7941176,247.8014706,12519.38971,4821.904412,769.75,346.0661765,1319.647059,3742.463235,647.5,140.5808824,3298.713235,2937.955882,1098.941176,177.1617647,3100.544118,593.8382353,38.59558824,136,15.12227383,11.75930981,0.628740502,0.931506849,0.697435897,-0.108735604
+47,18782.38068,690.8181818,462.4943182,1067.159091,16874.6875,579.3522727,659.6590909,1561.625,8947.125,515.5909091,1052.909091,1790.181818,12208.53977,1079.494318,4498.392045,3093.159091,4537.488636,1114.005682,329.7954545,5245.397727,8326.159091,1190.4375,125.5227273,573.7045455,9909.647727,348.8352273,106.9829545,5206.585227,8497.289773,1486.289773,803.1022727,2819.017045,6770.244318,549.2443182,260.8920455,21242.35227,4861.619318,967.5113636,370.4090909,1385.471591,3873.9375,677.7386364,159.0568182,4733.431818,3072.551136,1113.130682,231.3068182,3107.5625,554.2215909,42.03977273,176,16.59744143,14.26009646,0.511682894,0.936170213,0.575163399,-1.042082491
+48,21551.73958,702.7291667,474.0833333,1061.375,18779.92708,580.8541667,398.0729167,1554.520833,9350.3125,484.1145833,361.6458333,1779.885417,13843.46875,1109.75,3984.885417,2646.78125,5022.197917,1090.927083,359.34375,2388.3125,8991.71875,7285.083333,293.3333333,476.6145833,10855.05208,387.9166667,106.3854167,6133.333333,9190.791667,1266.197917,1013.833333,2796.458333,7210.4375,527.6875,255.375,11392.39583,5567.770833,687.6770833,354.0833333,1315.385417,4082.90625,716.5,145.6458333,4013.21875,3231.010417,1117.34375,143.2708333,3136.3125,743.5520833,37.84375,96,13.72539306,9.34592019,0.732356074,0.932038835,0.666666667,0.822615194
+49,26127.91176,715.7794118,429.1323529,1080.264706,23365.36765,594.2867647,440.6617647,1530.169118,12226.75,530.5367647,720.1985294,1772.095588,16470.47059,1119.955882,2925.367647,1553.080882,6095.382353,1155.110294,343.9852941,3191.558824,11732.00735,1927.654412,267.3382353,484.5661765,13663.95588,385.0588235,113.4705882,2187.823529,11135.34559,1463.786765,787.8235294,2945.786765,8836.639706,559.4264706,256.8823529,8500.772059,6003.522059,959.8529412,377.9926471,1321.838235,4896.867647,646.2647059,153.3529412,2403.720588,3766.117647,1120.367647,190.9191176,3117.867647,475.8897059,42.08823529,136,17.38425848,10.13718258,0.812382986,0.957746479,0.666666667,-0.403910908
+50,19268.31633,693.4897959,474.2295918,1080.229592,17179.11735,568.6071429,519.4489796,1615.117347,9168.923469,507.4336735,756.7704082,1839.030612,12377.87755,1070.469388,4248.642857,3523.265306,4525.602041,1084.770408,323.4591837,3747.642857,8392.897959,602.7755102,218.5204082,463.2908163,9695.209184,365.8061224,102.377551,6582.204082,8530.030612,1423.795918,922.0102041,3145.290816,6767.239796,526.877551,250.7857143,13064.92347,4922.005102,858.6479592,358.2346939,1331.586735,3883.183673,688.4540816,158.6122449,4099.02551,3049.25,1114.989796,226.1581633,3141.836735,582.5510204,42.54081633,196,21.95693869,11.92271232,0.839729909,0.890909091,0.622222222,0.395161126
+51,20801.75658,701.0855263,441.2236842,1101.263158,18307.82237,569.7434211,439.4473684,1605.868421,9605.394737,479.5065789,543.8421053,1766.592105,13041.01974,1075.960526,3015.171053,2231.927632,4978.927632,1108.565789,319.8157895,3112.164474,9081.013158,5491.940789,107.3552632,468.3947368,10752.76316,382.9342105,102.8486842,3392,9269.684211,1389.625,844.9342105,2771.664474,7481.835526,592.4934211,246.0986842,13134.54605,5602.302632,793.3684211,353.5065789,1299.434211,4257.894737,622.1052632,138.1315789,3476.236842,3390.651316,1112.710526,161.2894737,3128.460526,624.9539474,41.125,152,15.79247729,12.46460424,0.614040146,0.95,0.678571429,0.670234034
+52,21597.24468,701.7606383,436.3670213,1061.648936,19274.29787,577.1648936,998.8191489,1796.202128,10064.32979,503.8297872,943.1223404,1958.111702,14379.54255,1107.367021,3912.223404,2854.074468,5339.808511,1102.37234,333.1117021,5481.617021,9713.585106,1233.446809,457.4202128,515.9521277,11473.82979,373.0478723,105.3191489,3715.542553,9961.632979,1636.909574,773.9521277,2802.010638,7869.207447,515.0691489,249.4893617,7975.531915,5979.196809,1008.287234,360.9893617,1351.074468,4706.457447,830.1117021,155.7021277,3215.643617,3633.18617,1139.920213,252.7180851,3163.218085,662.1276596,41.56382979,188,18.97703828,14.02631698,0.673573283,0.846846847,0.618421053,-1.52200024
+53,18698.48624,748.5779817,498.7889908,1078.311927,16567.99083,595.4495413,979.5688073,1628.06422,7338.944954,497.8165138,1230.027523,1809.697248,12021.9633,1105.733945,6780.183486,3665.458716,4537.477064,1126.623853,414.3211009,6484.834862,8102.807339,613.3577982,622.5229358,789.1559633,9750.376147,401.2477064,109.2293578,5836.431193,8123.495413,1811.990826,651.3119266,2782.385321,6485.018349,622.1100917,260.4862385,15610.01835,4529.06422,1038.422018,368.0458716,1369.183486,3043.963303,776.293578,224.5137615,4733.706422,2679.944954,1088.908257,365.2752294,3153.220183,876.7706422,39.65137615,109,15.438945,9.525890409,0.786960035,0.915966387,0.619318182,1.407532367
+54,32723.03929,863.0821429,532.3464286,1103.296429,29491.45357,677.3714286,530.4142857,1600.010714,14674.16071,587.6571429,491.7642857,1755.075,20668.59643,1227.785714,4528.567857,3409.482143,7476.985714,1244.853571,384.8678571,2512.925,14531.45714,1616.042857,316.8464286,456.7107143,16777.78571,385.6571429,122.1321429,4637.192857,14143.2,1406.682143,879.7571429,2838.382143,11290.03929,691.9928571,277.4964286,3234.453571,7283.8,811.2714286,398.6714286,1312.417857,6307.260714,686.3892857,158.8285714,2364.339286,4671.921429,1192.453571,475.3285714,3168.328571,438.075,43.82142857,280,20.39354026,18.48908242,0.421959562,0.866873065,0.579710145,-1.282488962
+55,21767.35472,737.1245283,513.6679245,1099.641509,18921.93962,594.4830189,504.690566,1626.709434,9553.245283,507.6754717,680.6264151,1820.766038,14061.13962,1111.369811,4334.475472,3754.792453,5244.241509,1125.354717,346.2716981,3419.509434,9052.4,6069.690566,96.0490566,508.4113208,11141.18491,405.0188679,108.6943396,5979.403774,9323.90566,1421.939623,973.5886792,2805.977358,7369.396226,637.7886792,258.0867925,12856.6566,5669.45283,786.7509434,367.6188679,1300.079245,4076.713208,608.045283,151.4716981,4262.324528,3316.826415,1150.158491,198.1358491,3156.049057,781.9962264,47.28679245,265,24.68423676,14.22085113,0.81737173,0.926573427,0.649509804,-0.32305699
+56,41657.61076,841.9746835,543.7183544,1111.563291,38057.15823,696.8987342,594.8607595,1642.60443,18734.18987,588.2310127,635.335443,1746.996835,26718.9019,1225.477848,4418.120253,4266.376582,9542.547468,1271.585443,393.4936709,2401.360759,18613.22152,402.2088608,187.693038,602.2056962,22102.82911,386.5474684,216.6740506,3899.164557,18126.96835,1470.829114,1137.841772,2806.14557,14535.84177,570.7025316,284.7911392,1922.825949,8905.607595,828.4082278,413.3132911,1300.414557,8130.120253,643.6044304,168.25,2928.386076,5822.03481,1213.120253,223.7373418,3135.357595,413.0949367,50.74683544,316,27.67636391,15.83901867,0.820048479,0.868131868,0.593984962,-0.305169462
+57,24936.75172,748.5862069,675.862069,1097.689655,22177.85517,603.937931,806.3724138,1556,11629.15172,539.1724138,1582.744828,1802.303448,15802.53793,1124.8,4833.372414,3702.668966,5824.731034,1155.544828,364.2896552,6124.227586,11369.45517,1047.2,1115.324138,1204.489655,13135.4069,400.8206897,114.1310345,2393.682759,10697.96552,1850.717241,831.1103448,2824.393103,8565.165517,553.5241379,257.5793103,3449.282759,5820.6,1254.551724,390.9586207,1338.731034,4807.765517,842.262069,152.5448276,3482.862069,3625.793103,1121.586207,305.7931034,3170.537931,463.9931034,43.06206897,145,15.50846475,12.66563155,0.577074495,0.873493976,0.647321429,0.228373503
+58,25359.0381,736.6571429,434.8857143,1080.552381,22136.97143,595.6857143,386.1428571,1565.990476,11200.4,505.1904762,368.5047619,1781.380952,16431.80952,1120.733333,3164.409524,2704.67619,6063.314286,1124.885714,359.4666667,2435.247619,10868.20952,4103.704762,199.7333333,431.1809524,12775.39048,380.1904762,104.6,4735.495238,10873.44762,1294.4,849.7809524,2778.266667,8579.314286,540.9047619,257.447619,8573.904762,6557.342857,725.5142857,365.0857143,1305.961905,4897.057143,657.647619,144.9142857,2587.047619,3860.590476,1155.895238,153.8380952,3138.27619,755.7714286,40.26666667,105,13.61179437,10.02200558,0.676683904,0.954545455,0.734265734,1.158521721
+59,14587.28313,675.3192771,489.0240964,1043.060241,12690.36747,548.9518072,495.1927711,1559.295181,6333.987952,458.9216867,493.6506024,1776.204819,9416.512048,1057.837349,3834.614458,4139,3539.512048,1067.951807,330.9518072,3176.96988,6208.126506,607.0421687,101.7710843,505.2650602,7538.674699,359.6024096,104.060241,5848.807229,6344.144578,1280.216867,917.8192771,2800.090361,5081.861446,513.6204819,249.0301205,16180.48795,3847.108434,716.1987952,354.6807229,1294.463855,2721.96988,606.4759036,145.7048193,3654.096386,2293.53012,1075.222892,213.6445783,3160.23494,795.9036145,43.15662651,166,16.02401638,13.34764496,0.553306876,0.965116279,0.741071429,-0.007962804
+60,21453.74194,816.3629032,602.766129,1121.016129,18770.05645,639.1532258,618.6935484,1738.072581,9572.879032,529.0806452,528.4354839,1823.685484,13972.73387,1180.104839,2550.895161,2311.774194,5154.112903,1198.435484,360.8629032,2553.741935,9363.975806,620.7903226,255.2419355,574.4516129,11178.29032,412.3145161,107.3951613,2368.596774,9433.830645,1421.387097,744.0322581,2821.306452,7640.008065,559.4919355,273.7741935,17127.49194,5809.604839,988.6048387,385.1612903,1326.403226,4445.822581,783.5,154.1532258,4883.669355,3519.653226,1211.935484,229.5806452,3156.16129,694.8548387,42.51612903,124,13.43751418,11.89720616,0.464882192,0.946564885,0.688888889,1.566529764
+61,21317.22308,681.1230769,402.1076923,1057.323077,19032.02308,566.2461538,1422.107692,1516.438462,10020.52308,528.6923077,1398.984615,1788.715385,13441.55385,1087.492308,5039.661538,3281.653846,5022.338462,1104.015385,341.5538462,6981.869231,9439.523077,1120.030769,148.3153846,664.2615385,10955.46154,408.1307692,109.8846154,2833.746154,9241.184615,1702.623077,788.3307692,2821.738462,7245.530769,516.0461538,244.4923077,4174.184615,5148.984615,1210.815385,363.4538462,1319.846154,4188.115385,595.9923077,154.3230769,3635.938462,3250.676923,1089.084615,400.4461538,3116.707692,494.7076923,44.63076923,130,13.50546897,12.75177445,0.329391642,0.921985816,0.619047619,1.281465554
+62,25304.95349,710.127907,428.4883721,1083.023256,21795.24419,593.744186,490.4534884,1581.197674,11352.02326,526.5348837,542.255814,1809.174419,15689.2907,1105.174419,4099.197674,2518.546512,5653.534884,1148.732558,344.7325581,2787.895349,10552.0814,4140.511628,234.3488372,474.9767442,12235.33721,387.1744186,112.4418605,5237.197674,10574.98837,1439.418605,917.3488372,2821.744186,8327.011628,584.255814,275.4883721,7363.406977,5917.55814,815.2674419,380.6395349,1308.372093,4765.546512,705.0465116,159.2790698,2311.94186,3583.069767,1104.488372,180.3953488,3116.895349,513.3372093,44.80232558,86,14.34332007,8.035470788,0.828341219,0.905263158,0.573333333,0.343715515
+63,13840.79762,674.8214286,457.2380952,1043.535714,12076.66667,555.0238095,462.3928571,1489.25,6188.059524,463.9642857,363.3928571,1742.869048,8839.321429,1051.797619,4719.928571,2212.428571,3364.678571,1055.785714,375.9761905,2449.988095,6085.452381,869.547619,1798.738095,467.0952381,6962.333333,348.0952381,111.1190476,5289.392857,6115.75,1296.940476,937.3095238,2778.952381,4943.821429,535.5833333,259.8333333,12672.83333,3753.77381,732.6785714,348.452381,1329.119048,2806.071429,1178.714286,142.6428571,4454.190476,2240.238095,1081.107143,200.2857143,3109.630952,737.7142857,44.97619048,84,11.13261996,10.18341598,0.404050468,0.913043478,0.583333333,-1.340877084
+64,22293.7377,698.7704918,417.852459,1061.368852,19524.27049,560.4180328,450.9016393,1558.057377,10270.91803,509.7295082,432.057377,1814.721311,14192.16393,1067.704918,3408.836066,2922.713115,5146.172131,1109.352459,355.7131148,2519.819672,9614.139344,1923.811475,582.557377,432.3852459,11243.2541,372.5901639,107.9672131,6162.02459,9655.729508,1362.967213,932.9098361,2806.54918,7534.114754,551.9508197,245.8770492,5816.827869,5452.95082,804.0819672,367.5245902,1312.401639,4393.07377,728.9016393,147.3442623,2275.172131,3367.721311,1106.5,197.3688525,3102.311475,523.1147541,46.16393443,122,16.47707057,9.683341192,0.809089207,0.953125,0.677777778,-0.591550775
+65,21488.71545,696.3658537,448.6829268,1063.723577,18900.88618,576.699187,522.8130081,1582.447154,10080.00813,487.7886179,1611.715447,1800.666667,13756.52846,1081.260163,5175.00813,3798.674797,5088.926829,1080.861789,315.4471545,9346.723577,9181.845528,531.0731707,91.04065041,753.4796748,10648.34146,340.8699187,101.398374,3684.178862,9394.130081,1732.162602,782.4146341,2804.731707,7565,523.902439,248.796748,12792.08943,5608.650407,1460.926829,357.2682927,1381.756098,4326.98374,727.4878049,146.5528455,3855.699187,3444.292683,1106.626016,199.7073171,3084.170732,603.0487805,46.19512195,123,14.10339908,11.45048327,0.583803083,0.931818182,0.591346154,-1.422472448
+66,21877.93836,785.2191781,830.5,1174.363014,19455.31507,628.6643836,903.7945205,1764.143836,10309.95205,533.2876712,592.1575342,1852.116438,13972.34247,1145.287671,2672.636986,2082.438356,5337.90411,1207.684932,348.7260274,3411,9649.719178,2933.828767,204.109589,524.3767123,11320.84932,434.4246575,104.890411,2203.267123,9813.479452,1427.842466,710.6780822,2800.452055,7755.753425,584.5136986,256.630137,8123.246575,5948.616438,891.3082192,382.739726,1323.69863,4557.315068,636.7945205,146.1438356,3035.458904,3673.835616,1191.089041,145.7739726,3193.205479,637.9452055,46.73972603,146,14.31524241,13.29010333,0.371611618,0.935897436,0.802197802,0.606267389
+67,29481.50649,787.2077922,440.012987,1116.467532,25784.36364,608.025974,402.4285714,1642.363636,12976.36364,512.2857143,367.5714286,1768.090909,19197.96104,1186.805195,3523.363636,2736.987013,6874.662338,1175.285714,358.1948052,2450.285714,12596.27273,4557.831169,105.5454545,425.1818182,14939.81818,401.3506494,117.6623377,4762.688312,12753.63636,1334.272727,776.1688312,2802.285714,10105.12987,644.7922078,276.7142857,12053.98701,7672.818182,755.2077922,392.1298701,1320.675325,5750.883117,622.9480519,147.7012987,3126.207792,4536.051948,1196.155844,165.2987013,3169.831169,770.2077922,45.33766234,77,12.14187353,8.725693894,0.695377377,0.905882353,0.636363636,-1.010771696
+68,16856.83756,709.3908629,494.5279188,1054.360406,14792.54315,585.3451777,643.1319797,1547.233503,7327.233503,480.2233503,894.4619289,1781.431472,11352.35025,1100.497462,5160.101523,3415.243655,4150.203046,1100.096447,443.9238579,4324.467005,7431.096447,458.0964467,1091.634518,701.8883249,8986.705584,367.6243655,106.7258883,5960.685279,7660.441624,1601.923858,821.2233503,2802.020305,6056.274112,604.8426396,256.2081218,12341.9797,4625.15736,1143.751269,363.9238579,1370.593909,3241.827411,878.5076142,150.8730964,3877.279188,2758.005076,1108.426396,230.0203046,3113.746193,815.0659898,47.16243655,197,16.67133904,15.37586581,0.386490494,0.975247525,0.724264706,-1.4460406
+69,25615.74074,789.1358025,504.617284,1124.407407,22891.14815,637.8148148,615.3333333,1643.91358,12064.77778,552,584.5308642,1790.888889,16586.09877,1175.049383,4115.814815,3749.444444,5796.925926,1178.037037,350.962963,4373.802469,11281.17284,1146.962963,156.6419753,587.1851852,12986.97531,375.6296296,112.5925926,4718.037037,11235.62963,1519.209877,852.6790123,2838.765432,8871.049383,568.2839506,288.6790123,10030.76543,6219.024691,1003.283951,390.7160494,1334.419753,4981.876543,676.2222222,155.6049383,3579.740741,3953.148148,1160.802469,227.308642,3146.358025,572.9506173,45.77777778,81,10.77567,9.977455652,0.377708919,0.931034483,0.669421488,-1.414576409
+70,18340.42982,755.3157895,535.2105263,1084.5,16341.30702,602.6403509,550.0964912,1635.903509,7915.236842,507.8333333,438.122807,1786.614035,12093.59649,1138.552632,5023.842105,3521.657895,4465.736842,1123.552632,426.5701754,2732.982456,7744.192982,690.245614,920.2368421,454.5526316,9462.175439,386.0964912,112.4385965,9413.254386,7880.789474,1391.894737,854.7719298,2799.631579,6217.5,583.7368421,264.7017544,18870.62281,4679.561404,755.2982456,377.4473684,1335.017544,3210.122807,839.1578947,148.2105263,4287.298246,2694.833333,1128.763158,235.2368421,3138.263158,828.6754386,47.71929825,114,13.09846115,11.13599991,0.526498272,0.966101695,0.74025974,0.214947325
+71,19924.97436,680.1666667,451.0128205,1074.384615,17959.98718,567.6794872,736.7179487,1543.089744,8547.615385,469.6666667,419.5512821,1708.025641,13002.5641,1068.948718,2363.961538,2314.884615,4758.423077,1074.089744,352.1666667,2477.807692,8596.051282,884.9487179,213.4487179,455.6410256,10119.57692,379.0384615,108.6666667,5009.730769,8714.961538,1283.730769,796.6282051,2787.564103,7043.589744,540.2948718,247.525641,14168.87179,5172.538462,692.9358974,360,1311.641026,3485.461538,636.8461538,143.6282051,3235.935897,2919.705128,1083.435897,186.9871795,3147.564103,838.974359,46.37179487,78,11.69812047,9.11513036,0.62678016,0.896551724,0.590909091,0.629759309
+72,32486.68966,798.137931,494.0862069,1060.810345,29564.17241,640.6896552,457.2068966,1517.775862,14394.75862,560.2931034,399.7758621,1717.931034,20663.68966,1180.206897,4470.086207,4523.87931,7692.086207,1223.948276,381.4827586,2380.224138,14529.18966,356.4310345,114.3793103,424.5,17279.27586,369.8448276,117.4310345,3834.189655,14317.06897,1338.689655,921.3965517,2823.017241,11276.24138,619.9482759,269.2241379,2735.017241,7032.224138,744.2068966,398.5344828,1298.793103,6515.913793,616.2413793,158.7241379,3564.034483,4626.172414,1217.37931,200.8793103,3185.931034,424.4655172,46.43103448,58,9.971971991,7.793619944,0.623839436,0.920634921,0.644444444,1.553955674
+73,21815.44697,721.0454545,483.905303,1099.378788,19600.05682,588.3409091,525.3977273,1665.375,10568.25379,535.0113636,774.2537879,1861.212121,14209.95833,1109.560606,4632.753788,3829.878788,5172.189394,1140.905303,353.1401515,3715.731061,9778.420455,1502.632576,166.9734848,534.9848485,11262.70833,408.0606061,110.9469697,5811.882576,9860.465909,1567.291667,1021.587121,2816.219697,7756.700758,555.0795455,263.5227273,8671.69697,5679.026515,913.7992424,379.5606061,1324.723485,4419.420455,663.8939394,153.5909091,3527.719697,3479.859848,1142.526515,209.625,3170.765152,540.5227273,52.41287879,264,21.93906686,15.91651714,0.688235421,0.891891892,0.604118993,0.051134694
+74,22797.51111,750.0088889,464.2,1092.28,19766.41778,594.9288889,513.0177778,1641.12,10372.57778,510.92,727.1377778,1838.888889,14817.59556,1139.04,4372.066667,3903.542222,5586.924444,1146.6,345.2,5211.955556,9769.702222,1382.582222,128,724.6711111,12048.83556,391.5333333,107.3866667,4901.053333,10144.31556,1426.271111,795,2799.924444,8075.022222,535.6177778,256.1466667,12836.08,6299.697778,1026.115556,370.8888889,1346.573333,4712.457778,775.2711111,149.4444444,3639.786667,3767.955556,1172.942222,229.9733333,3169.151111,681.9155556,50.65777778,225,18.41034328,16.16732571,0.478357192,0.922131148,0.625,0.400395747
+75,27568.46018,811.1681416,569.6017699,1123.061947,23727.0177,646.5575221,520.840708,1759.672566,11339,516.460177,445.3539823,1824.902655,17459.71681,1180.132743,3319.123894,3188.663717,6401.769912,1188.716814,382.1681416,2681.893805,11489.52212,6328.070796,267.4159292,461.0619469,13708.90265,421.1769912,115.2920354,7090.292035,11656.14159,1392.176991,842.8495575,2783.230088,9155.79646,574.4690265,286.2035398,23062.02655,6597.80531,785.2389381,392.3539823,1334.495575,4519.646018,711.6902655,155.3539823,3624.035398,3778.672566,1159.017699,184.699115,3196.725664,861.0707965,48.52212389,113,15.93616768,9.354574078,0.809584946,0.911290323,0.642045455,0.386950128
+76,22381.18692,755.0747664,501.8130841,1104.831776,19685.8785,606.7570093,453.953271,1654.598131,9561.785047,499.9158879,407.9906542,1800.971963,14471.85981,1153.102804,3892.35514,2958.093458,5367.448598,1155.747664,362.7196262,2461.35514,9643.074766,5664.635514,107.9158879,448.3738318,11379.02804,430.8504673,111.3457944,6552.046729,9736.794393,1324.953271,793.7476636,2797.635514,7745.850467,644.8224299,282.0093458,20374.49533,5769.214953,722.1869159,377.0186916,1321.429907,3914.102804,625.3457944,149.6635514,3020.476636,3242.962617,1150.654206,171.4953271,3151.682243,849.3925234,48.47663551,107,12.20784035,11.35038126,0.36816213,0.946902655,0.743055556,-0.847824511
+77,22845.65686,757.7647059,536.5490196,1094.568627,19218.93137,605.9509804,541.0196078,1690,9187.147059,490.6470588,622.8823529,1834.147059,13931.06863,1127.627451,3560.794118,3612.735294,5398.039216,1159.784314,358.8921569,3429.5,9247.058824,2718.617647,249.0490196,588.9901961,11189.34314,403.9019608,108.7352941,4725.754902,9372.186275,1522.382353,908.8431373,2790.45098,7482.931373,605.5098039,260.3137255,15057.02941,5412.029412,841.4705882,373.4313725,1311.392157,3630.803922,732.2352941,152.8529412,3479.892157,3095.039216,1138.735294,217.9215686,3132.088235,869.4019608,51.95098039,102,18.63167475,8.022140411,0.902559742,0.857142857,0.62962963,0.174368311
+78,13136.29907,689.635514,556.8878505,1061.252336,11305.59813,570.5981308,693.2803738,1551.429907,6239.401869,506.4299065,832.1308411,1845.551402,8251.065421,1088.915888,6285.345794,4103.317757,3178.542056,1080.018692,325.2336449,3850.046729,5768.850467,1114.719626,338.6261682,491.271028,6389.88785,382.4579439,109.9158879,6925.149533,5668.009346,1587.158879,1327.719626,2823.214953,4577.158879,546.5981308,255.4579439,21222.1028,3302.551402,983.9906542,357.6074766,1318.280374,2615.046729,787.5981308,150.6915888,6427.672897,2049.439252,1086.570093,291.8411215,3155.766355,506.5794393,50.28037383,107,14.96199344,10.11774758,0.736690641,0.829457364,0.514423077,0.970847381
+79,24630.18352,776.4307116,477.5168539,1121.363296,20913.58801,628.4719101,864.917603,1688.363296,9992.674157,508.071161,1007.565543,1810.985019,15530.49438,1228.389513,3941.217228,2950.883895,5873.284644,1254.213483,366.1947566,4723.037453,10283.52434,3847.850187,188.3670412,799.0299625,12500.00375,432.1348315,111.3033708,4326.003745,10416.92884,1674.116105,719.0561798,2805.917603,8209.498127,578.9026217,263.6029963,10501.22097,5977.086142,950.6966292,383.5842697,1344.913858,3939.910112,713.9625468,211.8426966,3224.168539,3381.786517,1151.179775,266.9925094,3196.59176,879.8277154,54.49438202,267,24.30633879,15.83789245,0.758566913,0.81402439,0.585526316,0.019701941
+80,31350.10853,772.8449612,488.2829457,1083.073643,28181.54264,642.7403101,923.4844961,1542.027132,14552,565.7364341,1425.724806,1757.945736,19697.23256,1179.465116,4817.465116,3091.786822,7404.124031,1209.806202,378.2093023,3649.585271,13870.54651,434.0891473,452.9379845,852.7790698,16429.22868,381.7868217,207.244186,2916.751938,13475.88372,1778.573643,828.8565891,2832.577519,10849.39922,617.2248062,273.7674419,4816.825581,7466.903101,1205.457364,405.9806202,1338.03876,6162.953488,715.744186,156.9844961,2979.883721,4589.666667,1185.5,540.3953488,3175.151163,451.3255814,53.84108527,258,27.0118582,14.42582281,0.845449623,0.834951456,0.597222222,-1.49299536
+81,25545.46809,809.964539,606.9858156,1092.248227,22798.78723,646.1489362,489.6524823,1555.524823,10999.06383,540.4609929,460.6737589,1752.35461,15806.82979,1163.319149,6486.496454,3592.120567,5509.907801,1167.815603,366.5319149,2363.687943,10905.73759,330.5957447,891.8085106,463.3191489,12305.02128,389.0212766,114.4893617,5087.702128,10007.53191,1409.177305,877.5248227,2809.595745,8039.276596,598.1205674,258.1489362,2942.432624,4926.06383,766.1134752,385.6028369,1308.588652,4397.340426,846.7943262,154.3687943,3318.879433,3126.191489,1127.907801,345.822695,3131.29078,397.6382979,56,141,17.99881776,10.08153003,0.828410273,0.94,0.618421053,0.23120215
+82,23284.08021,782.1497326,583.486631,1170.631016,20779.87166,623.368984,673.4117647,1920.096257,11038.60963,538.368984,764.4064171,1896.203209,15071.24599,1149.695187,5482.588235,3841.989305,5582.171123,1146.299465,336.6791444,4506.914439,10250.30481,1594.40107,196.3208556,646.4278075,12005.51337,414.9786096,109,6429.898396,10286.16578,1559.770053,986.9625668,2834.096257,8142.748663,590.9518717,265.8930481,15225.13369,6217.823529,957.5294118,367.7486631,1355.764706,4741.481283,728.9786096,159.1122995,4696.860963,3763.197861,1173.941176,255.657754,3204.229947,592.0213904,56.82352941,187,19.69478011,12.43659396,0.775403155,0.912195122,0.656140351,-0.340633338
+83,27704.09483,789.9051724,525.9568966,1128.784483,24445.55172,632.3448276,729.6637931,1683.327586,13203.64655,541.7844828,1451.655172,1828.87069,17922.16379,1187.594828,6036.586207,3669.594828,6730.043103,1177.612069,350.612069,8123.034483,12085.22414,945.7327586,236.6896552,1243.793103,14069.82759,390.1034483,104.387931,5119.982759,12257.80172,1825.681034,806.4741379,2799.818966,9743.189655,543.1982759,270.7844828,17163.7069,7320.862069,1371.025862,374.9224138,1349.732759,5667.887931,850.0775862,152.362069,4369.586207,4444.810345,1182.922414,241.6982759,3165.939655,612.5948276,53.77586207,116,13.37523955,11.70396821,0.48403729,0.943089431,0.591836735,0.715711404
+84,23082.53913,729.4478261,441.5782609,1094.882609,20071.70435,583.7173913,441.5217391,1632.552174,10640.35217,491.5130435,377.8521739,1815.717391,15046.26087,1127.830435,3557.317391,2649.373913,5578.53913,1120.5,348.0347826,2432.06087,10219.96957,5467.991304,133.8608696,455.6913043,12272.4,399.826087,108.8782609,4714.252174,10377.33478,1281.426087,885.6826087,2799.908696,8320.834783,555.8173913,246.2565217,7393.395652,6364.108696,772.0130435,364.4695652,1291.452174,4802.047826,665.5608696,146.8347826,2731.826087,3807.791304,1143.343478,144.5608696,3133.769565,698.1956522,56.80869565,230,18.49152068,16.88929357,0.407167703,0.905511811,0.637119114,0.433453996
+85,21135.06923,697.0384615,415.2128205,1059.179487,18652.37436,573.4589744,471.0820513,1510.402564,9907.75641,485.7846154,432.1410256,1745.353846,14090.12051,1089.997436,3060.864103,2091.923077,5227.053846,1109.541026,405.8820513,2736.612821,9114.746154,1022.076923,662.1358974,459.0820513,11028.50513,352.7153846,107.5410256,3459.697436,9626.776923,1296.123077,693.6128205,2811.25641,7428.935897,536.9205128,261.7897436,9699.812821,5865.030769,717.1923077,362.7051282,1333.307692,4312.176923,774.0717949,149.1717949,2520.215385,3516.671795,1116.564103,159.3692308,3156.502564,749.6179487,62.45384615,390,27.63399238,18.99752068,0.726213466,0.890410959,0.656565657,0.342142112
+86,36307.97895,859.3684211,567.1473684,1144.263158,32723.16842,701.7578947,469.9684211,1634.042105,16436.53684,588.5263158,518.7473684,1731.126316,22967.63158,1256.926316,5095.368421,5269.747368,8561.105263,1279.021053,396.8421053,2384.778947,15784.42105,428.5263158,589.4,481.0210526,19102.74737,399.7368421,135.1263158,4328.221053,15786.44211,1454.4,1048.336842,2815.694737,12419.93684,585.4947368,285.7368421,3480.326316,8054.589474,831.9263158,421.5157895,1314.757895,7149.010526,727.9052632,169.1789474,3689.736842,5119.557895,1248.631579,290.9473684,3136.263158,426.5473684,55.06315789,95,12.40442151,10.52361123,0.52939444,0.904761905,0.71969697,1.25920918
+87,26192.9375,750.2291667,487.40625,1092.395833,23276.40625,613.1145833,820.4270833,1518.520833,12088.70833,535.3125,1358.354167,1783.416667,16321.71875,1125.322917,5205.052083,2612.458333,5994.208333,1199.541667,362.7083333,4780.041667,11805.33333,924.7291667,394.125,1041.78125,13431.72917,391.2708333,129.1770833,4067.270833,11145.02083,1760.197917,848.7395833,2843.197917,8800.864583,565.6458333,269.4583333,5117.208333,6103.177083,1063.40625,386.3854167,1327.40625,4941.322917,693.03125,151.5104167,2584.458333,3741.78125,1148.302083,281.6770833,3183.166667,468.4791667,55.59375,96,13.4156622,9.4801075,0.707568493,0.914285714,0.727272727,-0.539605182
+88,21809.61538,785.7863248,626.034188,1108.880342,19283.78632,621.8888889,612.042735,1673.709402,10325.64103,546.008547,695.9230769,1842,13990.5812,1256.452991,4588.897436,3360.222222,5215.752137,1183.316239,359.6923077,4046.34188,9752.247863,1099.863248,222.0683761,651.5641026,11360.13675,416.7606838,115.1452991,4427.384615,9441.42735,1551.923077,1119.196581,2857.487179,7458.564103,578.3076923,277.3675214,9559.598291,5285.837607,1168.700855,391.5641026,1332.017094,4262,631.5128205,163.0854701,5911.897436,3320.316239,1169.717949,218.6837607,3233.162393,491.0683761,55.75213675,117,13.02311049,11.92027459,0.402734115,0.9140625,0.642857143,0.967468944
+89,20918.79167,728.2013889,516.6319444,1120.270833,18860.15278,584.2916667,427.4097222,1645.263889,10204.39583,521.9513889,456.7916667,1822.111111,13463.16667,1089.430556,4208.298611,2743.277778,4920.861111,1118.701389,352.6666667,2693.4375,8934.055556,911.9722222,999.9652778,458.6944444,10482.41667,368.4861111,112.875,5081.534722,8953.555556,1431.791667,903.1527778,2825.361111,6982.5625,548.4097222,269.4861111,20205.55556,5127.291667,793.8333333,372.5208333,1353.173611,3904.611111,928.3541667,151.8888889,4517.097222,3070.236111,1110.4375,226.6527778,3094.243056,553.0833333,56.52083333,144,16.42712337,11.2461552,0.728910574,0.953642384,0.738461538,-0.627425422
+90,18519.42135,728.3876404,471.741573,1082.078652,16314.51685,583.6516854,415.8539326,1604.460674,8707.280899,502.4606742,491.3202247,1804.275281,11520.37079,1082.859551,3722.707865,2656.634831,4427.134831,1093.342697,372.6516854,3088.140449,7887.94382,2073.52809,820.7640449,478.6853933,9554.314607,376.7752809,107.3258427,5123.078652,7818.241573,1395.904494,890.1853933,2806.814607,6285.286517,535.0730337,254.5337079,14242.37079,4645.573034,880.741573,363.3820225,1354.11236,3615.08427,815.6292135,146.7752809,3950.438202,2847.337079,1127.994382,209.8932584,3130.988764,577.0617978,57.20224719,178,16.72179258,13.62840792,0.579448595,0.962162162,0.698039216,1.095826476
+91,28730.40146,836.5109489,486.2627737,1097.19708,25007.08759,662.5036496,943.2116788,1701.350365,11267.35036,534.7226277,1046.635036,1820.087591,18295.86131,1308.832117,3619.051095,2644.014599,6625.007299,1238.941606,399.8759124,3919.452555,12097.56204,1800.277372,677.2408759,532.5766423,14551.12409,482.5328467,118.9489051,6313.875912,12080.64234,1586.671533,693.7737226,2814.313869,9609.854015,590.8248175,267.0072993,6136.627737,6748.656934,938.350365,547.1021898,1347.751825,4373.613139,826.7591241,201.9270073,2497.635036,3790.065693,1200.678832,298.6131387,3214.948905,903.459854,58.0729927,137,17.67279844,10.46086871,0.805997308,0.88961039,0.619909502,0.286811292
+92,27555.70526,786.7052632,600.1789474,1123.957895,24523.63158,644.2947368,692.9894737,1631.105263,13038.85263,549.9684211,621.6210526,1776.673684,17063.93684,1158.178947,2516.747368,2166.505263,6439.063158,1222.726316,376.5157895,2795.694737,12002.95789,4368.336842,125.1052632,523.5684211,14200.37895,451.7052632,115.9473684,3012.063158,11227.74737,1492.136842,848.6421053,2832.873684,8880.157895,575.0631579,269.0526316,4587.968421,6205,856.7789474,397.6736842,1320.389474,4928.336842,614.4842105,160.7894737,2766.694737,3732.926316,1177.747368,170.7368421,3209.926316,477.6947368,57.04210526,95,12.43506084,10.21749946,0.569965485,0.913461538,0.664335664,-0.46630866
+93,23218.0219,751.0182482,449.7189781,1088.868613,20160.00365,594.9452555,565.5,1619.824818,10766.68978,525.6970803,733.6459854,1816.507299,15226.10584,1128.357664,4832.408759,3050.489051,5641.281022,1132.109489,364.2919708,3824.689781,10287.5438,1732.963504,472.7956204,483.0218978,12035.65693,396.4562044,107.9854015,5564.642336,10528.14964,1439.186131,764.8175182,2790.208029,8389.565693,534.2591241,257.149635,10087.62774,6420.065693,919.1532847,368.1569343,1320.375912,4925.846715,821.7335766,154.7189781,2665.20438,3851.277372,1158.29927,201.0474453,3138.653285,671.6970803,61.79927007,274,22.27266743,16.0229569,0.694596029,0.931972789,0.685,0.57848825
+94,22325.0125,761.1,548.49375,1101.9125,19418.975,612.2375,727.89375,1723.46875,9594.73125,499.74375,766.625,1829.1125,14496.89375,1158.61875,4974.0125,3768.7875,5371.3375,1157.5375,360.89375,4910.35625,9509.98125,1901.60625,102.21875,657.54375,11470.31875,413.8125,112.70625,5922.3125,9704.8625,1505.65625,872.91875,2792.85,7917.39375,639.15625,279.43125,25860.65625,6007.075,946.9125,390.15625,1346.55625,4068.45625,631.44375,153.31875,5366.03125,3385.60625,1150.46875,198.96875,3183.63125,854.61875,59.51875,160,15.75933905,13.14579715,0.551523782,0.952380952,0.588235294,-1.015708705
+95,20872.86911,784.3769634,496.1465969,1089.026178,17754.95812,635.2251309,672.9842932,1626.204188,8564.539267,500.8167539,750.3560209,1776.82199,13647.68063,1247.026178,2463.581152,2894.062827,5005.884817,1201.256545,382.4397906,4158.696335,9022.858639,2797.418848,620.0052356,665.3664921,10784.72775,446.7015707,114.4188482,4647.094241,9174.340314,1518.811518,690.7853403,2799.125654,7321.115183,622.2722513,274.4973822,19577.4712,5343.465969,937.4240838,389.921466,1344.586387,3505.235602,880.6073298,155.7225131,4091.010471,3042.717277,1161.507853,275.0157068,3145.513089,892.2879581,61.83769634,191,17.24671152,15.5063446,0.437763981,0.896713615,0.624183007,-0.41938694
+96,22307.74436,734.6090226,531.1954887,1088.360902,20041.57143,599.4135338,673.1954887,1594.052632,10451.06767,544.075188,1687.548872,1819.218045,14577.41353,1154.045113,5683.43609,4563.360902,5261.112782,1146.894737,358.4135338,6136.030075,9759.744361,1512.150376,721.6917293,1072.443609,11812.55639,397.6842105,113.3007519,5262.052632,9906.984962,1716.781955,1096.969925,2812.774436,7670.300752,582.0300752,273.7368421,13997.53383,5639.857143,1212.43609,382.8571429,1364.541353,4497.308271,810.6766917,155.1353383,4993.045113,3542.586466,1174.428571,283.5338346,3203.323308,503.7368421,59.66917293,133,16.05243394,10.76481487,0.741816176,0.95,0.692708333,1.155144131
+97,23485.07772,770.4196891,538.1917098,1097.082902,20748.22798,614.4404145,733.4715026,1735.440415,11193.35751,517.4248705,946.1554404,1885.906736,15124.65803,1151.098446,4920.336788,3724.42487,5875.067358,1115.88601,342.5492228,4210.528497,10440.98964,494.0880829,402.6891192,672.238342,12459.82383,384.8238342,105.8186528,5021.839378,10482.48705,1678.735751,913.4818653,2821.61658,8337.088083,549.4870466,249.7046632,12347.97927,6471.316062,1045.093264,363.1761658,1345.803109,4945.963731,878.2227979,151.7512953,4646.626943,3918.88601,1158.901554,366.134715,3135.34715,603.5388601,62.38341969,193,17.15136826,15.41728175,0.438163792,0.923444976,0.670138889,-1.125365175
+98,22877.17424,706.0151515,483.2651515,1085.924242,19874.29545,576.0378788,446.8939394,1616.393939,10734.26515,494.2575758,472.5454545,1799.280303,14910.42424,1095.643939,2906.075758,2592.636364,5662.174242,1099.719697,337.0757576,3046.075758,9934.628788,2195.977273,331.3030303,494.8181818,11970.09848,376.8333333,107.6590909,4962.416667,10219.99242,1313.045455,872.5909091,2799.810606,7940.628788,522.2272727,264.4924242,13253.65909,6168.643939,812.0757576,356.6212121,1317.55303,4689.568182,688.5454545,141.3636364,3358.143939,3723.613636,1118.128788,158.1363636,3141.818182,639.219697,58.37121212,132,16.85466876,10.47814786,0.783274279,0.942857143,0.647058824,1.428224035
+99,21029.71698,702.3915094,473.2735849,1047.424528,18205.36792,572.7122642,501.6226415,1612.051887,9716.570755,477.9716981,396.4245283,1817.122642,13864.31132,1115.792453,4572.080189,3912.985849,5166.207547,1092.745283,340.3066038,2475.660377,9091.34434,1970.037736,109.259434,448.6084906,10954.96226,368.7358491,108.3867925,7423.165094,9463.787736,1258.660377,1051.448113,2786.674528,7399.216981,541.3679245,245.8018868,10795.10849,5840.443396,740.1037736,364.8443396,1310.04717,4316.037736,683.6981132,146.9198113,3531.141509,3511.915094,1128.981132,160.0330189,3124.165094,714.3584906,62.38207547,212,19.88334594,14.03621447,0.708283408,0.959276018,0.654320988,0.863477337
+100,30960.86957,866.9652174,630.5304348,1234.121739,27273.3913,694.8869565,653.6,1919.582609,14846.14783,601.8956522,547.4434783,1831.730435,20387.34783,1266.6,5968.913043,3922.93913,7329.66087,1303.591304,388.173913,2813.165217,13794.86087,1704.782609,135.0956522,504.1043478,16165.67826,442.8434783,126.5391304,7213.513043,13767.88696,1494.573913,1377.330435,2822.043478,10860.94783,628.2782609,301.7565217,13517.69565,7976.93913,861.0173913,416.8086957,1342.269565,6177.817391,687.5478261,169.3826087,4154.886957,4923.434783,1271.773913,183.773913,3256.66087,530.973913,61.83478261,115,13.85012537,10.72037267,0.633152442,0.966386555,0.68452381,0.441435321
+101,20400.53846,712.5076923,444.6769231,1069.646154,18080.9641,568.9128205,574.1128205,1556.241026,9460.558974,488.9282051,596.3538462,1791.261538,13638.62051,1107.738462,3765.810256,2540.876923,4999.051282,1112.282051,346.7897436,2841.835897,8881.605128,1778.164103,257.1589744,500.6153846,10630.35897,365.3333333,106.4512821,4543.430769,9358.4,1351.882051,791.0410256,2807.825641,7282.292308,532.8307692,257.9897436,15621.03077,5739.384615,744.8769231,367.4871795,1320.189744,4250.097436,742.9589744,146.8923077,2938.748718,3432.333333,1123.092308,187.9641026,3104.215385,732.7794872,61.67692308,195,19.88946592,14.00630059,0.709994746,0.805785124,0.637254902,1.332204484
+102,19552.47143,734.7571429,521.3714286,1081.9,17386.09286,581.7857143,500.6428571,1657.735714,9026.385714,488.2071429,534.9071429,1791.4,13026.80714,1109.628571,5188.45,3915.321429,4845.885714,1123.071429,340.3928571,4196.921429,8317.907143,1838.642857,101.9857143,458.6214286,10291.24286,373.0642857,109.6071429,7215.45,8701.942857,1438.721429,874.3714286,2797.385714,6990.578571,542.3428571,267.1,21890.15,5474.857143,854.8357143,380.2357143,1367.721429,3861.478571,609.2214286,154.9071429,5420.678571,3202.807143,1154.65,224.7428571,3172.242857,791.8857143,61.4,140,14.41746485,12.39800729,0.510412366,0.972222222,0.769230769,0.306746132
+103,17847.0266,690.4308511,457.2446809,1053.771277,15824.21277,569.3882979,586.8297872,1586.281915,8219.56383,477.2446809,423.9521277,1797.898936,11619.32979,1077.819149,4293.744681,2836.43617,4364.984043,1077.68617,451.4734043,2867.117021,7447.75,821.7074468,797.6755319,466.5585106,9121.585106,363.1968085,109.1117021,6268.659574,7764.771277,1346.361702,845.8031915,2782.265957,6129.276596,691.8085106,243.3351064,9218.271277,4738.87234,743.6914894,363.106383,1320.803191,3267.978723,787.25,144.9202128,3478.81383,2720.62234,1072.840426,178.7340426,3083.031915,804.7925532,65.14893617,188,18.36523647,13.2462019,0.692659245,0.944723618,0.746031746,-0.095345307
+104,40168.69355,833.2580645,491.7903226,1121.145161,36071.75806,688.6612903,682.6935484,1693.532258,18342.32258,603.483871,642.9193548,1785.354839,26083.35484,1256.483871,3935.16129,2401.354839,9261.870968,1285.725806,392.1935484,2541.112903,18181.67742,479.0967742,130.4193548,786.7741935,22079.14516,401.0645161,157.1290323,3013.193548,18036.08065,1473.064516,815.7903226,2843.709677,14559.5,672.2580645,294.8548387,5237.129032,10212.35484,894.9032258,428.4193548,1342.774194,8287.870968,661.483871,164.2741935,2178.629032,6348.790323,1273.693548,530.0967742,3275.451613,446.8548387,61.56451613,62,10.7254991,7.451688728,0.719237954,0.96875,0.704545455,1.553096557
+105,40836.06944,895.0555556,600.5416667,1142.986111,37214.40278,730.3194444,613.8333333,1665.347222,18675.73611,617,488.3194444,1744.125,26459.52778,1309.722222,6310.013889,5452.569444,9260.138889,1303.291667,424.7361111,2410.986111,17779.54167,383.4444444,612.375,477.4444444,21730.20833,390.2916667,139.125,6028.972222,18049.15278,1511.194444,1196.125,2856.194444,14042.44444,582.0416667,305.8055556,2880.722222,9503.055556,876.9027778,436.1666667,1330.152778,8188.791667,771.6527778,172.9305556,2584.416667,5962.638889,1308.972222,228.0416667,3119.861111,423.2916667,63.16666667,72,11.86033729,8.244470157,0.718884552,0.9,0.553846154,-1.550921524
+106,28570.51685,774.8876404,481.3370787,1092.550562,25322.88764,619.6516854,726.1685393,1646.865169,13741.58427,547.4719101,1304.303371,1821,18755.35955,1182.876404,6225.11236,4170.640449,7128.337079,1174.337079,355.0449438,5304.157303,12672.01124,1990.539326,118.0898876,1011.494382,15052.46067,404.2247191,125.4269663,5511.449438,12990.14607,1578.797753,835.2921348,2811.370787,10154.70787,542.8539326,257.258427,9902.94382,7698.910112,1204.898876,381.2808989,1358.898876,5870.910112,633.6179775,149.988764,3508.539326,4689.292135,1178.247191,272.8876404,3183.94382,636.247191,67.41573034,89,18.3224741,7.23009807,0.918851835,0.855769231,0.402714932,0.63701375
+107,25154.89954,800.9589041,535.6027397,1111.479452,22051.66667,616.8675799,644.4246575,1711.063927,11516.73516,518.2557078,519.3744292,1816.680365,16501.89498,1153.808219,3690.041096,3511.068493,6043.936073,1169.39726,357.7716895,3302.278539,10282.74886,1916.319635,100.9452055,499.7442922,12864.9726,409.8447489,112.0410959,5008.031963,11028.89041,1344.442922,878.0730594,2793.200913,8452.452055,557.8538813,264.0821918,11746.99087,6628.794521,849.1369863,386.283105,1322.849315,4758.922374,622.5114155,153.1050228,3207.09589,3907.876712,1181.178082,175.5753425,3194.593607,780.7762557,67.7716895,219,20.75540218,13.82533649,0.745855429,0.920168067,0.678018576,0.531925845
+108,17115.86726,733.4690265,526.4424779,1100.230088,15219.93805,606.7079646,824.5309735,1662.79646,8351.80531,501.9115044,2221.451327,1816.345133,11509.84956,1108.646018,7386.628319,4929.035398,4454.353982,1105.318584,333.6902655,6175.318584,7909.389381,1097.60177,563.5132743,1157.539823,9105.672566,378.6283186,107.9823009,7191.884956,8009.451327,1988.973451,838.5044248,2791.973451,6369.504425,549.619469,258.4955752,20285.45133,4843.743363,1319.053097,367.2389381,1379.778761,3821.920354,882.4070796,156.0176991,6351.150442,2992.150442,1161.79646,477.8672566,3239.823009,646.5309735,68.2300885,113,16.80008128,8.702110445,0.855392572,0.941666667,0.664705882,-0.274702978
+109,17336.05166,684.2435424,440.5830258,1039.132841,14966.06273,565.3653137,494.7195572,1538.02583,8192.789668,476.2287823,464.6199262,1796.114391,11367.37638,1095.686347,5597.059041,3145.686347,4310.206642,1075.767528,360.8450185,2579.276753,7705.02583,1270.191882,527.5830258,1375.394834,9031.933579,379.6420664,105.9815498,6829.738007,7807.627306,1371.04428,898.904059,2791.409594,6242.826568,546.7785978,241.0332103,11113.67897,4846.900369,716.7380074,354.1734317,1318.154982,3660.498155,768.9372694,141.5571956,3331.653137,2927.96679,1100.793358,176.5940959,3076.944649,689.8228782,69.79704797,271,20.77530636,17.02420176,0.573159143,0.950877193,0.6775,0.817829018
+110,19412.12865,673.3567251,425.3274854,1048.508772,17308.21637,565.2339181,505.8362573,1523.152047,8931.812865,458.1637427,402.0760234,1779.596491,12866.49123,1081.473684,4238.754386,2280.725146,4799.888889,1076.181287,511.9766082,2700.736842,8382.859649,999.6959064,1566.467836,455.7368421,10295.15789,356.2631579,104.6959064,5366.48538,8793.239766,1332.087719,759.3391813,2804.491228,6963.883041,607.8479532,241.0409357,12190.90058,5366.011696,798.6315789,363.754386,1329.988304,3675.637427,1015.877193,144.9356725,3325.619883,3079.871345,1072.380117,190.3859649,3058.602339,825.1578947,67.94152047,171,17.01321403,13.08777755,0.63892225,0.929347826,0.628676471,0.859039646
+111,45476.49351,940.7532468,581.3246753,1158.75974,40955.07143,758.0064935,734.5194805,1703.305195,21043.33117,629.8701299,849.2922078,1914.714286,30006.97403,1390.337662,5891.62987,4808.74026,10525.74675,1391.188312,423.1298701,2677.987013,20736.97403,395.0714286,162.2532468,936.8376623,24276.36364,416.5454545,131.9545455,3509.876623,20051.02597,1898.045455,978.474026,2842.967532,16083.74026,637.8831169,314.4935065,2418.097403,10788.5,1006.5,457.8896104,1318.318182,9267.948052,694.9935065,183.9545455,4247.350649,6703.12987,1355.915584,238.1428571,3263.272727,408.9220779,67.53246753,154,16.88615646,11.90834327,0.708995138,0.911242604,0.647058824,1.100376294
+112,22275.93478,711.1478261,462.8130435,1090.43913,19983,585.5130435,443.1391304,1555.304348,10889.79565,517.7913043,552.8130435,1788.382609,14492.21304,1096.269565,3648.143478,2411.495652,5377.76087,1143.53913,345.9521739,3103.421739,9688.2,1018.478261,425.1478261,490.0826087,11389.10435,361.4521739,108.2826087,4340.856522,9768.595652,1402.356522,869.8130435,2822.117391,7703.66087,565.3608696,267.1086957,18972.73478,5780.552174,888.5913043,375.9347826,1341.286957,4381.465217,782.9913043,152.7652174,4010.347826,3448.678261,1119.908696,196.7565217,3097.473913,553.6608696,70.73478261,230,23.01839323,14.13925078,0.78910463,0.818505338,0.605263158,-0.633443084
+113,20985.34911,692.2899408,455.5207101,1059.757396,18737.6213,571.4674556,581.8639053,1596.213018,10109.6568,492.5088757,436.3786982,1775.372781,14059.50296,1109.295858,4258.923077,3141.621302,5336.686391,1105.213018,325.443787,2616.798817,9791.686391,3756.64497,128.8757396,480.7573964,11034.76331,385.3195266,105.5857988,7627.224852,9576.739645,1316.934911,980,2800.698225,7741.816568,517.1775148,246.5325444,11599.35503,5785.130178,779.7810651,354.7988166,1300.47929,4469.431953,699.0591716,144.260355,3218.816568,3494.153846,1121.08284,179.5325444,3144.840237,627.9289941,70.10650888,169,18.45024323,12.6627051,0.72730307,0.913513514,0.584775087,0.61186481
+114,19091.0553,728.6359447,478.6497696,1076.35023,16582.39631,592.59447,654.516129,1622.511521,8818.843318,501.8294931,728.3087558,1816.576037,12608.04147,1127.585253,4326.207373,3577.0553,4652.640553,1118.686636,364.3824885,3338.373272,8232.059908,995.718894,342.9539171,648.9124424,9688.341014,391.1474654,109.1474654,4981.202765,8509.75576,1426.313364,788.3824885,2793.290323,6688.847926,537.6543779,255.8709677,18871.02304,5244.663594,971.156682,369.7465438,1334.829493,3860.202765,669.6497696,151.0414747,4594.258065,3119.018433,1141.009217,228.2073733,3144.317972,765.59447,69.99539171,217,20.49097925,13.94309205,0.732794276,0.927350427,0.601108033,-0.563918166
+115,27721.02247,800.8089888,495.5730337,1116.213483,25064.88764,648.1348315,778.8988764,1621.337079,13583.96629,576.2134831,1815.94382,1780.404494,18111.44944,1195.561798,6484.258427,3516.685393,6694.977528,1230.617978,373.6404494,6838.247191,12879.37079,929.2921348,138.3370787,1388.988764,15221.97753,462.6741573,117.5617978,3749.05618,12303.1236,1779.775281,843.7977528,2830.662921,9721.730337,591.8539326,284.988764,6897.47191,7198.168539,1437.865169,416.6179775,1336.05618,5694.651685,635.7752809,162.1348315,3554.606742,4471.202247,1215.146067,362.9325843,3251.280899,480.5393258,66.56179775,89,12.10499597,10.02418817,0.5605754,0.927083333,0.570512821,-0.876086097
+116,36078.50602,858.4518072,504.9939759,1130.337349,32416.04819,720.5662651,834.1445783,1676.704819,16773.92771,613.5903614,1509.108434,1843,23343.90964,1301.963855,5060.921687,3574.13253,8595.843373,1312.86747,404.873494,4052.825301,16146.8494,414.3554217,532.9277108,1363.054217,19624.37952,412.5722892,357.7168675,1940.108434,16203.73494,1921.114458,790.6204819,2825.554217,12804.77711,642.626506,294.6385542,5099.433735,9332.433735,1259.60241,434.2349398,1337.307229,7446.325301,752.4518072,172.7891566,3606.518072,5695.650602,1302.548193,525.8614458,3315.024096,449.3313253,70.1686747,166,18.92929112,11.75863413,0.783662179,0.873684211,0.62406015,-1.525058001
+117,28262.90123,762.5802469,517.0740741,1125.765432,25423.48148,618.0123457,464.654321,1646.024691,13424.16049,535.9382716,487.6790123,1867.765432,18193.98765,1151.888889,4707.691358,3248.802469,6899.098765,1180.888889,368.1728395,2603.08642,12209.39506,1807.296296,149.0617284,452.0123457,14698.09877,401.962963,114.0123457,5907.950617,12386.24691,1356.320988,1034.160494,2822.444444,9748.765432,572.1234568,272.2592593,16969.79012,7266.407407,813.8148148,389.2962963,1339.82716,5664.148148,683.2222222,150.5185185,3534.098765,4453.358025,1175.555556,197.1481481,3156.530864,510.654321,68.90123457,81,11.1112781,9.681465837,0.490717328,0.9,0.613636364,-0.84236635
+118,23602.7185,729.1099196,441.8954424,1085.33244,20604.82306,589.5924933,570.9168901,1597.49866,11374.14209,513.9651475,969.2064343,1811.230563,15920.82306,1119.131367,5003.479893,3094.238606,5822.825737,1144.675603,347.3270777,4457.678284,10299.54424,1865.919571,227.4209115,743.2359249,12448.32172,372.4235925,107.4289544,4084.152815,10674.42091,1571.739946,749.233244,2791.683646,8427.552279,527.9651475,256.7426273,12500.72118,6508.010724,1009.168901,365.463807,1327.581769,4997.581769,739.386059,149.3163539,3012.30563,3928.560322,1137.214477,210.769437,3163.19571,661.2252011,74.64879357,373,27.07033768,18.50451827,0.729883315,0.88179669,0.579192547,1.018577723
+119,27505.87889,774.9965398,481.8512111,1102.802768,24195.51903,622.3010381,1017.955017,1676.076125,12492.81315,523.4256055,1611.321799,1814.16955,18519.56401,1179.854671,5655.792388,4057.096886,6850.986159,1192.961938,379.3044983,6992.844291,12458.90657,1826.740484,114.9619377,1208.072664,15088.76471,417.1280277,114.2802768,4524.577855,12679.3045,1835.17301,676.3910035,2792.923875,10186.05536,558.7612457,273.7854671,13777.59862,7605.103806,1332.702422,397.8027682,1334.197232,5335.84083,620.8200692,157.1522491,4174.186851,4355.892734,1183.342561,243.0968858,3185.152249,860.8615917,74.1384083,289,20.63814144,18.2220288,0.469505143,0.914556962,0.63377193,-0.309113387
+120,30427.69198,807.8649789,606.0886076,1124.278481,28147.77215,652.1729958,797.0042194,1676.814346,14940.09705,576.2869198,1106.966245,1786.78903,20347.78481,1218.620253,4754.721519,3171.974684,7526.337553,1232.966245,375.978903,3933.21519,13988.94515,2062.037975,279.5864979,886.8818565,16578.66245,752.1350211,117.3586498,4587.637131,14006.16034,1541.075949,869.5316456,2848.232068,11058.5443,576.5527426,291.5611814,13217.82278,8224.654008,1345.805907,415.3628692,1339.037975,6468.160338,667.07173,162.1265823,3720.350211,5125.054852,1227.637131,238.1940928,3272.772152,497.4472574,72.72995781,237,18.97595185,16.64830662,0.479874576,0.911538462,0.692982456,0.805706182
+121,19744.4375,782.6875,623.2410714,1188.803571,17013.86607,622.0714286,744.2767857,1924.955357,9208.017857,540.2142857,863.4910714,1871.044643,12456.09821,1156.875,4360.258929,3182.553571,4668.303571,1136.419643,345.5178571,3593.714286,8338.741071,2358.053571,509.5714286,653.5714286,9987.428571,393.7053571,106.25,5542.946429,8323.866071,1593.544643,844.6785714,2809.205357,6583.875,599.125,267.6785714,22620.95536,5098.169643,975.5714286,371.4732143,1379.107143,3826.892857,762.4642857,152.0267857,5315.517857,3106.258929,1209.75,3514.946429,3223.830357,590.3482143,71.91071429,112,15.88943672,10.59115123,0.745457671,0.82962963,0.538461538,0.421253684
+122,44007.83529,887.2,579.9882353,1135.282353,39781.24706,746.9058824,556.0588235,1629.4,20514.07059,627.8117647,656.1529412,1817,28301.94118,1300.835294,5388.529412,5148.823529,9878.035294,1369.741176,434.8470588,2475.964706,18729.56471,378.8588235,897.3647059,824.7294118,22642.25882,401.5176471,135.1647059,5339.070588,18975.71765,1637.611765,1266.447059,2824.152941,14885.4,574.3529412,300.9529412,2725.917647,10352.62353,899.7411765,434.9882353,1332.976471,8472.764706,848.2588235,169.6588235,3219.235294,6278.964706,1310.176471,334.1882353,3248.870588,428.9058824,70.22352941,85,12.06247975,9.335705964,0.633251802,0.904255319,0.653846154,1.434294899
+123,22325.48113,734.1226415,453.8490566,1114.283019,19905.17925,600.0849057,699.9811321,1583.462264,11051.0283,543.9245283,1288.103774,1792.603774,14559.59434,1136.886792,4470.141509,2941.216981,5531.235849,1171.188679,357.9433962,4555.556604,10504.36792,6255.849057,127.4528302,1133.622642,12152.11321,696.1037736,113.9622642,3038.726415,10034.83962,1539.792453,930.4622642,2869.509434,8083.311321,598.754717,257.8679245,9916.877358,6051.698113,1571.358491,391.9716981,1324.971698,4767.820755,631.3396226,161.3773585,3184.179245,3750.764151,1167.95283,244.7075472,3192.584906,485.2641509,74.88679245,106,15.91995733,9.814674293,0.787353894,0.890756303,0.56684492,-0.251438282
+124,23894.19658,760.9002849,754.5811966,1170.076923,20928.68091,610.5698006,706.5982906,1770.039886,11397.45869,545.7749288,489.4472934,1898.678063,15930.84046,1151.353276,4946.917379,3137.225071,5795.581197,1194.57265,362.985755,2561.843305,10840.59259,1132.34188,120.5042735,452.2592593,12594.88034,398.4188034,114.8603989,5781.492877,10799.27066,1375.165242,993.7863248,2835.666667,8538.749288,550.8461538,266.3960114,11157.23647,6439.219373,849.7920228,401.7549858,1331.387464,4927.099715,666.3960114,154.4957265,3170.048433,3955.17094,1181.786325,166.6837607,3191.150997,525.3162393,80.96296296,351,32.52655826,14.76894515,0.89097211,0.89769821,0.664772727,-0.028395617
+125,22274.53488,721.4593023,438.0465116,1082.186047,19908.72093,593.6162791,661.7267442,1567.947674,11056.05814,522.6046512,830.2325581,1799.186047,14984.40698,1111.162791,4637.633721,3331.19186,5372.284884,1145.767442,354.0174419,4770.761628,10201.25,1764.284884,126.2034884,632.7790698,11905.2907,385.9534884,109.9767442,4601.156977,10197.85465,1464.151163,896.2848837,2813.52907,8115.331395,540.5348837,257.8139535,7776.343023,6077.918605,1073.174419,383.1511628,1319.372093,4654.081395,642.5116279,150.4418605,3102.697674,3725.55814,1151.302326,251.5290698,3154.947674,539.9302326,72.48837209,172,16.43531575,13.7903026,0.544030769,0.960893855,0.674509804,-0.163639193
+126,22801.51724,814.5034483,766.5241379,1152.151724,20446.37241,661.0965517,873.062069,1693.303448,10811.04138,574.5172414,604.7310345,1847.944828,14403.86897,1198.241379,2865.786207,2158.772414,5370.613793,1228.365517,419.6,2932.62069,10289.66207,513.5931034,1279.386207,586.9310345,11948.66207,601.3103448,118.2275862,4319.372414,9767.137931,1577.910345,870.8344828,2884.489655,7782.993103,604.0896552,270.9793103,8741.124138,5773.006897,1194.4,418.9448276,1349.393103,4506.765517,967.7310345,161.1172414,3866.441379,3522.986207,1200.537931,216.6689655,3271.351724,470.7310345,72.23448276,145,16.13538625,11.52201998,0.700060101,0.960264901,0.697115385,1.039405061
+127,15266.41525,719.0423729,569.0423729,1139.516949,13153.31356,573.1864407,454.3983051,1637.889831,7268.686441,507.1525424,482.8813559,1818.483051,9777.542373,1077.508475,4527.661017,3365.381356,3538.127119,1087.932203,344.3389831,2773.90678,6565.983051,755.6101695,728.8389831,487.7542373,7658.313559,347.9745763,102.5762712,7162.211864,6473.389831,1387.474576,1031.313559,2802.067797,5051.974576,523.6864407,261.2033898,24821.22881,3871.423729,838.9152542,362.9830508,1354.754237,2908.618644,870.4152542,152.8220339,5428.847458,2336.59322,1110.305085,229.1779661,3177.70339,581.4067797,73.8559322,118,15.34768104,9.906919262,0.763760757,0.929133858,0.670454545,0.180448803
+128,19187.90265,764.7168142,668.300885,1115.495575,16458.76106,603.0619469,627.3539823,1739.840708,9139.557522,513.5132743,547.7079646,1893.336283,12418.02655,1157.911504,6222.318584,3967.964602,4779.115044,1179.628319,343.4778761,2993.858407,8459.433628,975.8849558,189.539823,581.3362832,9916.327434,414.2654867,108.5044248,9376.80531,8468.371681,1399.787611,979.5929204,2802.672566,6845.336283,559.8495575,260.159292,16168.02655,5249.265487,918.7876106,367.5309735,1313.309735,3987.371681,963.2300885,146.2477876,4520.292035,3231.743363,1158.283186,198.380531,3182.690265,614.5044248,72.83185841,113,13.37869562,11.26315807,0.539676221,0.941666667,0.627777778,-0.4092905
+129,15655.96774,709.5483871,474.1397849,1065.913978,14016.92473,558.7311828,464.7526882,1529.096774,7359,490.3010753,458.1290323,1787.043011,10795.27957,1121.150538,4305.763441,2468.569892,3836.064516,1084.247312,350.1827957,2653.913978,7293.591398,3678.311828,195.6129032,464.6989247,8219.204301,373.0107527,106.4731183,5429.602151,7445.172043,1384.043011,891.7849462,2780.580645,5966.537634,563.7741935,262,20811.06452,4721.322581,730.8387097,369.5698925,1338,3494.505376,648.5698925,148.3978495,3365.473118,2820.516129,1123.763441,187.2258065,3127.419355,733.172043,71.72043011,93,12.13026258,10.06395237,0.558274065,0.939393939,0.603896104,1.56151796
+130,18098.11558,706.9396985,467.3417085,1035.487437,15788.52261,574.6733668,688.2613065,1501.698492,7996.557789,470.8743719,1054.728643,1754.407035,12497.50251,1172.467337,4032.653266,3156.713568,4727.79397,1124.447236,402.2060302,4580.839196,8169.175879,594.4874372,1241.653266,777.8291457,10212.93467,392.4824121,110.1457286,5588.542714,8726.984925,1537.522613,766.7286432,2797.758794,7085.834171,633.2512563,246.6030151,12570.35176,5416.517588,907.2261307,367.6683417,1387.542714,3559.577889,890.5276382,145.3768844,4047.281407,3134.693467,1107.100503,240.839196,3111.944724,887.9145729,74.40201005,199,21.97169625,12.41531295,0.825050242,0.846808511,0.526455026,1.06289958
+131,46897.42857,915.9365079,556.1984127,1143.551587,42242.77381,743.6746032,679.5595238,1707.686508,22305.35714,631.797619,532.0753968,1752.59127,31010.26587,1343.833333,5798.305556,4243.833333,10977.79365,1387.626984,422.3055556,2448.988095,20912.45635,396.6666667,269.4722222,492.9047619,24824.15873,415.6468254,130.6507937,4734.333333,20893.6627,1588.190476,1132.912698,2849.706349,16742.75,602.984127,309.6071429,2789.861111,11890.61508,916.0198413,458.781746,1329.43254,9488.876984,689.6428571,173.8690476,2709.261905,7097.035714,1338.789683,246.3055556,3262.150794,422.5992063,79.14285714,252,21.04862843,16.72071623,0.607414484,0.834437086,0.571428571,0.98057773
+132,25410.52145,797.6567657,533.3036304,1112.336634,21927.57096,632.1287129,775.8448845,1763.986799,11944.12871,525.7029703,856.4455446,1857.828383,16898.55116,1209.89769,4716.821782,4362.531353,6185.214521,1167.785479,369.8283828,3313.778878,10717.62376,1678.960396,120.019802,714.2145215,13188.89769,403.660066,116.3267327,5306.818482,11282.47855,1529.409241,974.9636964,2790.155116,8785.006601,564.0792079,287.7392739,24520.41254,6974.785479,908.9867987,390.6567657,1344.40264,5173.933993,728.7260726,154.2211221,4323.336634,4258.570957,1197,202.679868,3183.683168,717.3432343,78.17161716,303,22.30499993,18.35437978,0.568212503,0.885964912,0.658695652,-1.298929089
+133,21040.16568,689.4201183,412.6508876,1041.881657,18570.3787,561.591716,512.8994083,1534.16568,9939.218935,466.8579882,695.9112426,1779.071006,14047.46154,1095.881657,3960.538462,3568.295858,5256.349112,1092.650888,370.0591716,3388.360947,9231.721893,3206.047337,248.1242604,594.1360947,11297.32544,373.9763314,123.8994083,5826.952663,9717.751479,1395.307692,782.3786982,2785.810651,7669.147929,572.3254438,235.2011834,4373.828402,5958.360947,903.2721893,372.1538462,1305.372781,4160.485207,640.4733728,148.556213,3057.059172,3478.615385,1108.349112,195.7810651,3078.207101,819.3431953,77,169,22.24500044,10.13680016,0.890139096,0.894179894,0.555921053,1.056363109
+134,20232.03731,784.3171642,563.7462687,1107.160448,17317.85821,627.7798507,714.4514925,1672.843284,8174.048507,501.1902985,509.869403,1792.156716,13191.8097,1219.488806,3878.152985,2818.007463,4834.753731,1174.675373,470.4067164,3417.652985,8774.11194,1400.94403,801.641791,471.7723881,10789.50746,417.6119403,116.0261194,7017.932836,8695.5,1492.884328,804.108209,2805.962687,7001.08209,595.0186567,270.7873134,18845.54478,4999.955224,815.7313433,387.2276119,1354.152985,3187.600746,858.9291045,151.0223881,4160.238806,2830.932836,1149.141791,221.6529851,3251.69403,925.0858209,79.39179104,268,20.59468334,17.922764,0.492589672,0.924137931,0.641148325,1.052319261
+135,14932.45604,685.7142857,510.510989,1068.714286,12881.28571,562.4835165,430.6043956,1553.978022,7218.648352,478.5054945,445.9010989,1819.164835,9641.153846,1059.274725,3975.582418,3159.247253,3725.82967,1064.076923,333.8076923,2634.769231,6713.56044,473.0604396,669.7527473,490.4450549,7746.423077,380.2857143,100.7142857,6542.857143,6605.115385,1333.884615,1008.576923,2798.247253,5255.785714,528.1153846,246.3131868,15971.24725,3921.032967,797.0769231,347.967033,1333.291209,3024.236264,876.0989011,144.1758242,4409.236264,2412.346154,1101.28022,259.5384615,3118.10989,602.5714286,77.7032967,182,16.05446655,15.30550395,0.301871429,0.928571429,0.669117647,-1.002909144
+136,13373.3875,715.8875,649.5375,1068.9375,11386.8125,570.8625,871.3875,1678.8,6084.075,472.7375,1166.075,1845.625,8923.7875,1181.7875,6416.75,4885.225,3670.425,1110.525,345.7625,6689.3125,6214.4,859.7875,520.7375,784.3875,7319.85,430.25,110.2125,9717.95,6393.5375,1773.5625,954.625,2800.9,5304.5125,554.3125,273.3125,30128.075,4067.4875,1252,379.875,1354.475,2778.8625,731.45,152,7007.125,2368.125,1116.5875,238.725,3169.7125,875.325,77.5625,80,11.63868665,9.098817122,0.623562468,0.898876404,0.615384615,0.19218346
+137,40246.71528,902.1666667,537.1041667,1146.694444,36028.61806,728.6944444,653.3611111,1672.506944,19381.08333,626.2986111,458.0833333,1745.513889,26855.88194,1326.875,4014.152778,2695.256944,9673.631944,1403.673611,419.2361111,2435.694444,18127.26389,406.3472222,517.8055556,465.5208333,21735.86111,405.1180556,129.6875,2509.652778,18585.90278,1489.277778,881.4583333,2919.416667,14690.5625,599.8888889,305.0069444,3539.305556,10684.91667,889.9722222,453,1339.215278,8290.354167,784.3819444,178.6527778,2296.631944,6351.666667,1336.659722,528.8541667,3297.361111,437.4513889,81.41666667,144,19.34744929,9.909286194,0.858880919,0.9,0.533333333,-0.516423625
+138,14210.66667,706.1891892,507.5045045,1061.324324,12753.05405,724.7207207,1524.288288,1574.882883,7040.468468,510.5135135,5144.927928,1825.81982,9888.486486,1101.342342,5952.585586,3749.981982,3718.684685,1087.630631,339.9369369,4083.981982,6829.162162,1038.243243,202.1621622,13758.47748,7802.297297,616.6216216,677.0990991,3624.774775,6870.810811,2631.81982,841.4234234,2795.648649,5499.315315,577.4954955,250.4684685,16439.87387,4238.612613,1083.099099,368.2972973,1349.504505,3328.810811,689.1441441,149.990991,6335.522523,2599.45045,1125.765766,287.9459459,3123.513514,702.5045045,79.89189189,111,14.33590066,10.78316335,0.658958845,0.948717949,0.660714286,0.470190146
+139,22302.28182,774.1636364,517.0272727,1100.181818,19510.01818,626.5090909,704.3545455,1692.290909,10541.83636,512.1727273,863.8181818,1840.772727,15050.01818,1168.045455,4606.636364,3759.790909,5459.936364,1154.754545,369.5454545,3855.845455,9688.918182,931.8545455,105.4272727,1060.127273,11651.71818,376.0454545,171.9363636,5957.745455,10265.52727,1440.181818,819.4818182,2790.454545,8038.581818,548.7454545,281.1272727,19072.3,6263.854545,888.7727273,384.9,1342.581818,4616.736364,661.6818182,152.3363636,4949.909091,3753.845455,1191.636364,241.5181818,3187.972727,774.1818182,80.09090909,110,13.16593497,10.74483805,0.577897999,0.973451327,0.714285714,0.299449642
+140,43636.875,894.625,564.5520833,1125.9375,39575.67708,730.5520833,741.4166667,1679.458333,20306.89583,612.3958333,950.2708333,1812.46875,28517.0625,1320.625,6384.635417,4744.677083,10236.79167,1362.166667,416.2708333,2575.229167,20045.57292,381.1354167,141.375,666.6875,23459.36458,416.3958333,131.3229167,3509.75,19448,1776.03125,1212.114583,2857.645833,15484.23958,622.7291667,302.6875,2587.65625,10969.64583,970.375,450.0208333,1315.020833,9048.260417,658.3854167,175.25,3293.822917,6772.645833,1320.375,245.53125,3281.697917,406.4375,78.84375,96,13.01060054,9.474763775,0.685328393,0.923076923,0.685714286,-1.425284407
+141,21767.45455,712.3522727,485.6306818,1076.147727,19770.50568,578.0284091,539.3693182,1569.306818,10591.48864,518.5170455,449.6306818,1804.215909,14653.92614,1089.920455,4800.482955,2799.960227,5421.653409,1130.971591,347.3181818,2560.090909,9963.818182,4664.113636,133.8579545,457.1590909,11671.28977,403.6875,109.0965909,6158.125,9977.392045,1327.244318,1139.4375,2812.346591,7946.022727,591.6818182,248.0681818,6608.903409,6000.102273,779.3806818,388.0795455,1312.346591,4606.380682,634.9375,152.375,2429.210227,3684.732955,1131.920455,158.9772727,3151.096591,511.7443182,81.44886364,176,16.08849709,14.03824958,0.488499123,0.967032967,0.690196078,-1.239839813
+142,14725.76339,631.1517857,373.9910714,1007.763393,12926.75,530.6741071,398.9285714,1390.21875,7025.910714,445.8794643,341.6741071,1732.71875,9771.71875,1025.290179,2682.982143,1419.089286,3617.633929,1044.642857,502.7991071,2484.71875,6422.276786,991.9910714,859.2232143,447.9910714,7652.857143,320.5178571,102.5,2502.794643,6730.066964,1292.450893,745.53125,2786.022321,5315.008929,743.7098214,231.21875,8448.53125,4176.477679,695.0580357,352.1071429,1320.834821,3059.816964,782.2232143,137.7633929,2413.232143,2508.861607,1045.834821,155.1026786,3060.714286,743.3482143,80.71428571,224,21.97083646,13.20310138,0.799295953,0.945147679,0.649275362,-1.38254539
+143,30780.94017,807.7606838,505.7606838,1106.25641,27418.03419,676.9230769,470.2905983,1570.504274,13822.64103,557.982906,467.6068376,1726.162393,19356.33333,1206.376068,3240.401709,2943.641026,6963.495726,1240.57265,386.2905983,2384.880342,13815.18803,346.9487179,1354.863248,453.6495726,15702.77778,393.2649573,120.9059829,2934.051282,13044.62393,1467.290598,1069.247863,2833.025641,10264.92308,661.1880342,272.3589744,3699,6962.897436,814.3418803,410.008547,1340.376068,6045.931624,983.2136752,167.0598291,4667.606838,4470.247863,1233.145299,388.8034188,3116.435897,388.4273504,81.05128205,117,13.28546356,11.63338923,0.482949922,0.928571429,0.642857143,-1.406536232
+144,26122.95489,769.0902256,465.8571429,1080.270677,23197.72932,638.0827068,1071.924812,1603.180451,12544.73684,527.3759398,1537.300752,1786.030075,17668.84211,1186.308271,5485.496241,3926.789474,6561.631579,1173.804511,372.1654135,8220.646617,11206.40602,799.3609023,101.9323308,990.0225564,14079.43609,392.7819549,161.3609023,3714.210526,12026.97744,1759.759398,729.9548872,2814.917293,9372.015038,553.0601504,265.3458647,9408.135338,7411.421053,1084.571429,401.9473684,1401.969925,5370.097744,639.8120301,151.518797,4309.857143,4465.488722,1200.150376,255.4661654,3176.593985,786.593985,81.94736842,133,14.93551585,11.53714074,0.635059172,0.936619718,0.633333333,-0.747548148
+145,25577.9916,755.2857143,484.697479,1114.184874,22162.33613,650.8235294,908.1596639,1670.058824,12138.94118,523.7142857,1327.798319,1855.563025,16681.7395,1171.747899,5604.336134,2825.789916,6366.319328,1156.184874,344.6638655,3939.218487,11046.18487,661.3109244,133.5462185,1410.310924,13618.07563,394.9579832,107.1176471,5654,11225.48739,1720.201681,860.1008403,2821.159664,9081.689076,546.4789916,256.3109244,13088.77311,7036.470588,1028.134454,377.8571429,1345.571429,5221.016807,751.4537815,146.6890756,4248.159664,4274.87395,1172.478992,228.3697479,3162.705882,617.5714286,82.66386555,119,15.65442256,10.04900058,0.76676554,0.894736842,0.61025641,-1.207247873
+146,21291.39103,730.2371795,514.9615385,1110.775641,18689.51923,586.5641026,520.75,1692.544872,10224.73718,492.275641,460.3205128,1819.461538,13706.51923,1102.282051,4168.99359,3311.910256,5089.846154,1102.641026,338.7179487,2756.730769,9516.724359,1341.217949,1254.615385,528.5448718,10541.10897,363.9358974,105.6987179,6611.179487,9010.621795,1383.160256,934.5769231,2786.153846,7133.679487,510.1410256,260.2179487,24483.04487,5398.102564,945.8269231,355.6538462,1331.378205,4055.833333,1076.608974,147.5192308,4769.634615,3141.576923,1116.666667,184.4551282,3151.698718,635.2948718,83.28846154,156,15.65815294,13.1264932,0.545183351,0.934131737,0.65,1.440211525
+147,40796.34419,868.5116279,531.3023256,1127.804651,36337.20465,704.8976744,642.5348837,1641.753488,19585.77209,617.6604651,687.8372093,1762.827907,26733.36744,1310,4342.325581,3662.316279,9800.15814,1364.748837,415.5116279,2821.776744,18228.54884,439.1627907,305.0046512,582.5813953,22380,551.7674419,129.1581395,3546.134884,18706.96279,1582.674419,848.4093023,2830.116279,14751.64651,609.1906977,309.6093023,5477.409302,11006.42791,981.5209302,451.5534884,1327.293023,8488.4,701.7162791,172.6,3574.790698,6686.237209,1323.790698,274.8883721,3302.311628,449.627907,84.26976744,215,20.45917776,14.01114448,0.728698929,0.922746781,0.716666667,-1.135791483
+148,18529.96269,745.0597015,561.4402985,1114.910448,16447.82836,582.7835821,619.8283582,1648.716418,8555.074627,478.9850746,616.9626866,1779.223881,12238.11194,1118.134328,3658.410448,3530.164179,4618.470149,1125.059701,358.619403,3704.597015,8210.320896,1306.320896,100.380597,606.0223881,9877.589552,408.5447761,106.8283582,4003.559701,8450.492537,1452.537313,730.4104478,2793.126866,6815.537313,595.738806,254.7238806,16558.35821,5293.761194,954.3731343,381.7462687,1314.708955,3604.873134,660.1641791,152.6791045,3935.992537,2989.626866,1132.574627,220.8432836,3139.686567,849.7313433,84.00746269,134,15.38337628,11.35264671,0.674820971,0.930555556,0.638095238,0.785030212
+149,31474.86792,1006.981132,749.8207547,1195.981132,26711.18868,770.8396226,649.3490566,1778.858491,14521.16038,643.0754717,781.7075472,1811.726415,20531.32075,1445.481132,3111.40566,3193.386792,7206.792453,1442.95283,476.990566,3611.018868,14289.63208,558.5471698,777.8867925,740.0943396,16679.78302,656.6132075,137.509434,4484.198113,13923.45283,1793.254717,883.3962264,2858.481132,11142.25472,723.8207547,324.9433962,5035.349057,8452.962264,1367.773585,489.7924528,1345.235849,6686.811321,881.490566,189.3018868,4200.377358,5297.273585,1409.811321,257.5660377,3341.509434,468.6226415,83.28301887,106,13.86978123,10.01100026,0.692117325,0.938053097,0.688311688,-1.320170877
+150,19321.43689,747.3592233,641.0776699,1095.174757,16970.48544,599.6019417,807.7572816,1682.912621,9076.92233,499.5048544,1207.291262,1805.213592,13849.16505,1213.699029,5293.514563,3730.135922,5103.38835,1159.097087,365.7864078,4020.485437,9309.796117,532.0291262,356.1067961,953.592233,11421.27184,415.7378641,111.8737864,7680.524272,10032.01942,1688.31068,742.0679612,2806.097087,8130.223301,560.184466,264.3883495,21897.24272,6281.029126,1065.165049,394.2330097,1358.194175,4188.359223,658.3300971,156.7961165,5143.76699,3668.718447,1153.718447,274.6116505,3162.524272,884.1553398,84.42718447,103,12.19646954,11.36245162,0.36343877,0.927927928,0.609467456,0.810354363
+151,28056.7549,905.8039216,575.4313725,1104.77451,25229.30392,697.9019608,480.8235294,1610.411765,12332.0098,580.6470588,626.3529412,1801.137255,17381.19608,1268.666667,5833.215686,3210.588235,6472.519608,1267.333333,402.9509804,2485.970588,12100.41176,564.0196078,2525.72549,621.6568627,13977.98039,456.6764706,121,4518.931373,11459.42157,1761.147059,820.4607843,2813.04902,8975.186275,756.3039216,281.2058824,1713.107843,6033.107843,951.6862745,414.9901961,1349.137255,5215.176471,1261.205882,168.0588235,4630.823529,3845.147059,1319.313725,1254.598039,3125.137255,372.0196078,85.2745098,102,14.0236767,10.1791378,0.687849102,0.879310345,0.523076923,-0.246845313
+152,25893.75829,762.7914692,566.492891,1072.2891,22787.5782,633.8056872,876.9620853,1582.421801,12805.91943,549.3222749,1031.047393,1797.104265,17246.30806,1174.246445,5556.957346,3819.417062,6460.620853,1219.293839,366.2464455,4053.876777,12085.91469,2538.132701,119.2748815,983.2180095,14283.77725,405.8293839,117.0900474,5531.208531,11593.47393,1810.815166,946.2985782,2845.800948,9468.369668,588.9241706,266.014218,8638.28436,7197.199052,1091.739336,411.5687204,1320.748815,5625.848341,638.2369668,158.1042654,3411.042654,4453.872038,1196.322275,303.6161137,3187.834123,480.5545024,89.76303318,211,20.79831487,13.41643417,0.764120835,0.894067797,0.639393939,-0.177950109
+153,19014.67398,714.3416928,450.4075235,1074.9279,16971.64263,577.0564263,544.5517241,1590.047022,9133.338558,488.0658307,841.2570533,1793.92163,12567.54859,1099.539185,4574.410658,3522.231975,4538.510972,1096.673981,343.2758621,4921.489028,8085.169279,1316.112853,1575.84953,645.2664577,9496.952978,360.3040752,104.846395,4833.554859,7934.677116,1647.068966,813.8432602,2788.103448,6230.166144,507.0595611,244.9655172,16856.2163,4732.642633,1315.053292,357.8369906,1401.420063,3641.583072,1154.366771,146.1943574,4793.746082,2799.510972,1108.203762,197.3573668,3137.736677,653.6865204,88.2507837,319,27.62181808,15.71689659,0.822335465,0.90368272,0.656378601,1.318107086
+154,26451.14917,816.2983425,503.6629834,1114.917127,22772.44751,656.0441989,860.8618785,1723.287293,12323.72928,534.8950276,1425.232044,1853.248619,17157.77348,1217.165746,6245.900552,3907.027624,6367.839779,1224.950276,385.5248619,6664.232044,11363.06077,1141.839779,117.9834254,715.1270718,13722.95028,404.7403315,117.8121547,4318.911602,11653.59116,1748.281768,747.1436464,2803.331492,9136.093923,584.480663,277.6519337,13235.48619,7029.950276,1235.40884,406.1657459,1345.464088,5123.78453,681.2099448,167.3038674,4550.060773,4250.464088,1209.138122,260.5801105,3212.375691,810.4585635,88.10497238,181,18.92616759,13.2425208,0.714442919,0.887254902,0.532352941,-0.553281685
+155,19021.59633,752.6055046,578.6330275,1089.761468,15794.89908,627.6238532,500.5504587,1613.119266,7679.807339,492.2293578,599.8073394,1785.733945,11901.99083,1217.348624,2769.706422,2740.577982,4343.238532,1155.082569,466.266055,3411.40367,7277.422018,958.3669725,1991.880734,573.7706422,9686.688073,380.7247706,112.8440367,5015.293578,7604.752294,1705.018349,850.3761468,2813.678899,6000.761468,750.8440367,278.9449541,26297.93578,4526.963303,880.6788991,384.3119266,1412.46789,2970.651376,1111.880734,152.4678899,5467.752294,2589.761468,1132.889908,306.0183486,3134.293578,907.1834862,85.86238532,109,14.30603152,9.880032805,0.723217732,0.923728814,0.698717949,1.08342598
+156,22475.63478,693.3043478,437.0826087,1067.178261,20032.28261,574.7391304,454.3695652,1514.917391,11139.78696,516.7434783,712.9086957,1796.856522,14994.9,1091.973913,3887.491304,2416.204348,5449.521739,1128.873913,411.626087,3411.33913,10219.82609,627.5652174,1075.56087,501.0608696,12041.95217,350.6086957,109.4130435,4492.721739,10210.48696,1429.730435,862.7043478,2823.704348,8122.895652,596.173913,251.8086957,11708.66522,6198.747826,907.173913,383.8565217,1364.795652,4633.008696,920.2217391,153.4043478,2812.373913,3760.395652,1120.243478,232.1217391,3108.473913,548.3173913,89.99565217,230,20.02289374,15.04926323,0.659615959,0.954356846,0.71875,-0.316006308
+157,21859.23622,747.2992126,466.7519685,1078,19324.74803,609.4409449,534.1220472,1627.559055,10476.81496,503.7047244,622.1377953,1824.523622,14604.27953,1145.708661,4814.090551,3168.181102,5442.492126,1146.862205,428.6771654,3150.582677,9360.507874,1954.015748,965.8149606,774.0748031,11418.82677,384.3464567,113.5787402,4943.700787,9834.511811,1458.188976,778.4094488,2789.543307,7742.929134,563.8031496,252.8031496,10261.76772,6086.307087,885.5590551,378.5944882,1338.413386,4485.562992,852.6062992,148.7795276,3614.133858,3659.830709,1161.740157,203.5551181,3138.133858,767.7362205,89.53543307,254,27.67606056,12.04407696,0.900343316,0.878892734,0.557017544,1.086785069
+158,26994.99375,811.23125,718.025,1145.74375,23419.4125,647.09375,886.9125,1769.2625,12562.88125,526.25625,824.36875,1847.1375,18052.1,1223.89375,4634.9,2827.94375,6711.1375,1458.9625,390.35625,4556.4875,12054.4375,1312.63125,152.725,741.34375,14699.3625,449.7875,119.175,4653.7,12671.59375,1623.2,720.0875,2811.375,10155.65,567.5,284.24375,6047.425,7758.15,1408.1125,428.75625,1323.51875,5227.01875,620.6625,163.95625,3115.13125,4395.16875,1208.03125,175.16875,3259.725,870.3625,87.26875,160,20.4485577,10.68168353,0.852719821,0.879120879,0.586080586,1.286947943
+159,18868.76786,824.5714286,406.8035714,1045.098214,17738.94643,641.4375,547.9821429,1402.741071,9034.517857,540.9196429,498.6785714,1713.9375,12390.48214,1173.160714,1882.919643,1349.866071,4635.607143,1187.8125,369.8482143,2423.160714,8866.571429,321.9375,684.1160714,460.0892857,10585.07143,428.5535714,113.2053571,1655.678571,8742.5625,1382.607143,775.5446429,2805.3125,7132.625,941.9910714,242.2678571,1923.991071,4996.553571,786.6607143,391.4910714,1307.357143,4219.089286,769.8928571,153.875,2162.544643,3288.1875,1180.526786,1328.330357,3022.964286,379.7857143,90.49107143,112,15.25328574,9.578317281,0.778252812,0.933333333,0.636363636,-0.14518871
+160,47867.60417,894.2291667,529.625,1118.645833,43517.89583,722.75,737.3541667,1656.916667,22757.25,626.8541667,487.0625,1770.708333,32205.08333,1352.291667,6015.4375,3439.333333,11236.58333,1388.270833,422.2708333,2400.833333,22140.625,399.1041667,129.5,442.0416667,26806.29167,408.0625,131.8541667,3073.229167,22311.5625,1508.520833,1267,2822.666667,18095.58333,620.7916667,321.7708333,2511.75,12994.83333,888.875,455.5625,1325.541667,10410.6875,661.0416667,179.9166667,1904.145833,8109.125,1358.5,166.4583333,3271.729167,412.8333333,86.3125,48,8.762493761,7.271755312,0.557952615,0.96,0.666666667,0.020924096
+161,25970.10433,742.5954198,494.3765903,1081.284987,23041.69211,601.9720102,774.3435115,1568.987277,12995.36641,544.0025445,1319.318066,1803.59542,17585.92875,1156.536896,5262.333333,3375.267176,6516.806616,1185.910941,366.4452926,5455.272265,11935.68957,1569.124682,122.2264631,965.1526718,14463.6743,392.3104326,114.0229008,4257.829517,12003.28499,1761.982188,896.2340967,2838.221374,9527.178117,566.0229008,262.3282443,8375.458015,7360.091603,1151.491094,411.3486005,1315.62341,5645.776081,623.9796438,169.6386768,3581.216285,4495.246819,1185.491094,304.7582697,3155.21883,497.5750636,93.45547074,393,24.18144733,20.95410838,0.49911359,0.95157385,0.779761905,0.177270724
+162,17005.35,651.0944444,427.0611111,1040.644444,14817.78889,539.1666667,386.6444444,1518.511111,8218.144444,452.7277778,362.15,1746.65,11441.82778,1060.972222,3499.777778,2319.416667,4238.122222,1064.527778,399.7944444,2563.516667,7168.033333,1675.127778,378.3833333,433.5833333,8933.355556,342.9944444,101.85,5096.866667,7560.677778,1260.727778,861.9111111,2783.216667,6040.911111,623.7166667,243.9722222,15815.80556,4839.577778,706.6166667,362.2833333,1331.744444,3515.577778,786.9888889,138.8388889,3064.344444,2914.711111,1083.722222,157.5833333,3127.605556,727.9888889,90.65,180,18.57961688,12.65404086,0.73221725,0.923076923,0.666666667,-0.386998246
+163,14114.83432,669.6213018,512.1597633,1064.674556,12281.02367,547.0414201,584.0946746,1546.627219,7019.005917,478.4497041,597.0118343,1799.763314,9596.43787,1057.650888,6196.08284,3707.745562,3526.390533,1048.284024,312.5325444,3671.053254,6528.940828,765.3727811,204.7633136,539.591716,7689.360947,352.147929,103.8816568,7789.887574,6629.591716,1389.846154,975.4497041,2799.633136,5404.982249,520.0118343,247.6094675,18947.27219,4093.218935,838.6863905,366.8934911,1330.508876,3138.585799,801.035503,209.9112426,5634.153846,2621.846154,1088.076923,213.1597633,3136.023669,577.4615385,92.01775148,169,18.64011671,11.80899021,0.773721769,0.933701657,0.722222222,0.093217135
+164,37742.7381,869.3650794,553.6587302,1135.690476,33994.74603,690.452381,664.1428571,1637.079365,17841.94444,588.2063492,491.1825397,1751.738095,24632.94444,1299.928571,3644.587302,4094.873016,8902.293651,1310.365079,408.5952381,2427.865079,17695.14286,375.1111111,261.6746032,452.7777778,20517.76984,482.6269841,131.1587302,4388.928571,17020.03968,1466.992063,1084.626984,2822.444444,13796.90476,673.1428571,291.2063492,3115.944444,9755.18254,873.015873,441.7857143,1326.357143,8101.785714,692.7063492,173.8571429,3789,6049.714286,1323.261905,288.1825397,3214.357143,391.015873,91.68253968,126,16.82923945,9.777761291,0.813904695,0.933333333,0.605769231,-0.651367589
+165,42031.89655,853.9224138,531.112069,1116.491379,38708.40517,692.7844828,654.3706897,1616.681034,20314.13793,596.5258621,460.2931034,1749.456897,27593.31034,1282.801724,5671.215517,4643.439655,10017.73276,1332.017241,407.4310345,2405.094828,19304.43103,372.0517241,128.2241379,443.7068966,22897.66379,417.0517241,123.0344828,4013.956897,19158.0431,1437.474138,1181.422414,2833.655172,15540.62069,590.3017241,289.8362069,2870.310345,11046.69828,845.6982759,445.5603448,1306.508621,8896.474138,650.2241379,170.5172414,3802.215517,6822.051724,1299.775862,233.637931,3239.793103,403.8275862,89.76724138,116,13.04912298,11.84229745,0.420015929,0.872180451,0.686390533,0.83561454
+166,21310.72848,730.8145695,630.781457,1102.311258,19046.50331,598.8344371,658.3377483,1662.761589,10598.17219,532.1324503,584.2516556,1855.463576,14401.62914,1139.470199,4736.89404,2811.649007,5406.980132,1184.615894,364.0993377,3664.89404,9650.099338,967.5761589,454.1258278,556.8410596,11589.5894,389.5496689,111.6821192,4675.463576,9862.039735,1366.086093,867.9403974,2809.708609,7845.006623,574.6622517,270.602649,16312.98013,6049.92053,872.2847682,400.3377483,1371.596026,4529.317881,776.218543,151.4503311,3070.788079,3727.549669,1167.364238,221.1523179,3180.682119,535.5629139,92.61589404,151,17.8055021,11.10979673,0.781461857,0.967948718,0.722488038,0.120274098
+167,18265.70815,705.3948498,482.0515021,1075.017167,16071.52361,568.7982833,530.3347639,1604.618026,8819.44206,483.4592275,514.1201717,1807.866953,12146.41631,1107.32618,4227.978541,3290.214592,4481.23176,1093.549356,368.6223176,3174.819742,7808.618026,814.9356223,346.3862661,746.639485,9531.854077,364.8540773,106.6309013,5005.381974,7981.781116,1435.399142,1036.467811,2792.27897,6392.030043,542.2532189,246.8240343,12857.59227,5011,803.1587983,361.0858369,1326.7897,3762.828326,967.5922747,144.6223176,4247.467811,3020.103004,1114.72103,161.0944206,3116.300429,696.5064378,91.16738197,233,21.56618952,14.39524473,0.744617561,0.920948617,0.661931818,-1.454241119
+168,16136.10619,720.4070796,543.619469,1088.274336,14089.0708,581.5486726,627.8584071,1547.477876,7822.168142,523.0884956,953.9557522,1810.20354,10761.75221,1110.123894,4861.168142,3429.477876,3800.610619,1119.274336,352.0530973,3910.451327,7511.150442,446.4336283,893.0973451,739.0619469,8532.132743,361.699115,108.2123894,4615.964602,7490.380531,1505.982301,923.5044248,2821.20354,6005.840708,550.1858407,264.8495575,21992.46903,4617.566372,996.2920354,395.7787611,1386.79646,3526.40708,954.4690265,156.3274336,3655.681416,2916.274336,1151,302.2300885,3139.424779,566.6017699,90.81415929,113,13.52313852,10.80557286,0.601273522,0.957627119,0.79020979,0.031367822
+169,17548.53704,769.882716,595.8024691,1126.104938,15184.49383,605.5061728,582.8271605,1707.351852,8666.234568,507.4012346,442.1728395,1834.567901,11731.65432,1135.666667,4076.820988,2996.302469,4454.734568,1142.308642,341.8703704,2607.962963,7955.944444,463.5679012,1330.722222,505.5493827,9193.623457,385.2901235,105.9135802,5064.166667,7968.703704,1349.358025,821.3765432,2824.08642,6461.660494,533.037037,250.9814815,17336.31481,4963.512346,1140.555556,370.7345679,1319.141975,3763.45679,1050.524691,147.0555556,4695.481481,3043.728395,1148.574074,158.9567901,3197.345679,625.1481481,92.64197531,162,15.43009308,13.8814747,0.436639663,0.885245902,0.6328125,-0.086169048
+170,21212.87205,742.7070707,502.956229,1084.468013,18143.99327,597.7508418,886.3367003,1587.286195,10015.79798,501.2020202,1432.579125,1820.050505,13952.81145,1147.144781,5506.299663,4196.855219,5377.979798,1148.659933,360.2121212,7744.10101,9102.141414,1091.390572,151.3030303,800.5319865,11244.60269,392.2828283,111.7508418,4541.962963,9673.79798,1842.094276,800.5521886,2797.410774,7805.003367,548.2592593,258.5824916,13752.79798,6137.478114,1116.114478,387.3569024,1350.956229,4246.329966,746.986532,154.973064,4370.703704,3687.148148,1152.531987,265.1717172,3161.356902,822.006734,96.03703704,297,21.479793,17.96395177,0.548243645,0.954983923,0.645652174,-0.33094902
+171,36139.91597,833.9831933,500.8991597,1094.369748,32556.52941,679.697479,485.8067227,1630.369748,16492.40336,566.9747899,660.907563,1787.042017,23208.89916,1250.756303,4879.042017,2823.042017,8582.756303,1249.243697,392.6554622,2487.361345,16416.80672,1605.647059,669.8403361,634.907563,19608.64706,472.394958,122.4537815,4955.747899,15802.76471,1628.277311,867.7815126,2820.033613,12388.80672,665.4789916,280.0504202,1632.747899,8668.672269,958.1848739,422.2352941,1312.848739,7264.05042,794,171.5462185,3999.033613,5506.537815,1262.890756,371.8571429,3128.848739,365.3109244,93.31932773,119,16.04063044,10.22555061,0.770468476,0.908396947,0.528888889,0.850560379
+172,16458.65031,702.595092,458.6134969,1073.693252,14800.47853,568.2883436,658.6871166,1570.944785,7640.453988,477,1111.104294,1789.858896,10766.53374,1108.374233,3952.90184,3169.490798,4028.588957,1091.650307,348.7668712,3931.981595,7221.607362,4363.380368,103.8343558,614.190184,8510.147239,424.8957055,106.2208589,4121.306748,7371.09816,1545.325153,817.8343558,2793.98773,5992.386503,603,241.803681,12575.81595,4571.269939,928.8588957,369.1226994,1319.779141,3174.515337,833.1472393,155.4662577,4360.662577,2644.055215,1100.797546,213.9815951,3128.447853,839.4539877,92.74846626,163,16.04567799,13.20412556,0.568173849,0.942196532,0.737556561,1.497770801
+173,46143.15789,861.3684211,502.1052632,1121.54386,42110.78947,709.3333333,706.6491228,1641.614035,22444.33333,610.4035088,459.4210526,1762.122807,30996.35088,1306.22807,4642.087719,3001.210526,10958.66667,1358.210526,420.8596491,2424.789474,21133.89474,393.3859649,120.4736842,473.5964912,25947.73684,394.877193,130.6666667,2713.649123,21162.03509,1491.035088,1115.701754,2813.45614,17120.84211,603.0877193,302.3684211,2131.684211,12559.82456,921.3684211,456.3333333,1308.385965,9936.087719,647.7192982,174.6140351,1921.859649,7616.982456,1332.824561,142.4385965,3304.508772,415.1403509,93.35087719,57,10.35148007,7.86065645,0.650653074,0.863636364,0.57,-1.072925873
+174,20123.14024,737.6463415,492.5304878,1102.012195,16828.38415,590.9329268,471.0731707,1684.695122,9482.359756,511.8536585,437.804878,1820.006098,13015.79878,1124.646341,4788.371951,2757.585366,4996.27439,1133.365854,344.5487805,2505.390244,8703.97561,2361.006098,602.6829268,472.554878,10724,383.0182927,107.0365854,5517.109756,8825.573171,1324.5,776.1585366,2812.810976,7029.97561,540.5182927,259.5792683,22459.22561,5561.29878,811.1768293,373.2621951,1335.378049,4227.042683,1027.341463,145.402439,4513.292683,3371.54878,1156.219512,199.8109756,3219.664634,612.8658537,96.03658537,164,17.68668435,11.94473671,0.737495592,0.953488372,0.700854701,0.249840786
+175,13438.83929,715.3392857,542.875,1086.544643,11993.50893,581.0089286,474.9464286,1653.455357,6731.4375,481.9910714,405.1607143,1815.026786,9423.767857,1113.339286,5566.616071,4327.464286,3486.928571,1092.723214,340.3303571,2499.473214,6181.455357,1351.232143,109.6428571,469.2142857,7474.508929,372.5267857,108.6428571,7397.803571,6393.973214,1262.785714,1152.669643,2798.303571,5152.964286,524.2678571,257.8214286,25510.16964,4080.5,737.3303571,365.8660714,1333.160714,3082.330357,1327.821429,150.8214286,5300.544643,2528.625,1124.982143,212.0892857,3112.339286,715.25,93.125,112,12.2540207,11.86906445,0.248681514,0.949152542,0.717948718,-1.209391468
+176,18786.29573,710.2957317,481.9786585,1077.353659,16206.7622,576.9115854,650.0365854,1574.375,8968.32622,489.2743902,1046.27439,1814.902439,12373.02134,1113.658537,4895.935976,3215.679878,4630.179878,1114.131098,389.1981707,4734.786585,7953.768293,1329.176829,447.0030488,858.5091463,9674.942073,359.3993902,106.6219512,4705.780488,8256.442073,1801.52439,827.902439,2783.841463,6555.176829,592.9634146,248.9634146,16613.1189,5140.085366,904.9573171,372.4786585,1349.496951,3748.317073,686.4359756,148.2682927,4190.606707,3084.359756,1120.710366,209.1463415,3128.603659,752.1737805,99.48170732,328,27.65084328,16.58873775,0.800047957,0.865435356,0.663967611,0.141587015
+177,27181.27586,773.5287356,468.4942529,1100.862069,23319.56322,618.0114943,755.8505747,1660.781609,11126.93103,504.9885057,646.1494253,1796.206897,17721.01149,1159.034483,3818.287356,3010.091954,6485.804598,1176.988506,369.7241379,3581.781609,11972.41379,3231.666667,110.954023,543.0114943,14395.90805,423.2758621,114.8390805,3931.931034,11874.43678,1487.275862,718.3678161,2810.551724,9613.195402,576.183908,255.7011494,10029.32184,6993.298851,882.1264368,392.1954023,1321.218391,4405.83908,675.5747126,156.8850575,3026.08046,3876.712644,1158.609195,171.4942529,3212.988506,930.7701149,90.98850575,87,15.28175775,7.605925129,0.867341948,0.956043956,0.725,-1.549612874
+178,31459.17284,816.2839506,536.2592593,1085.17284,28880.7037,655,540.8024691,1553.45679,15272.17284,582.4814815,572.2839506,1753.876543,20720.2716,1238.530864,6398.493827,3950.728395,7746.62963,1278.950617,397.4444444,2482.592593,13703.16049,435.617284,461.4691358,553.345679,17357.67901,383.6049383,121.8888889,4998.419753,14085.09877,1478.765432,1002.08642,2817.395062,11226.01235,583.0493827,278.9876543,3734.567901,8391.283951,881.6419753,416.654321,1335.740741,6408.790123,699.617284,163.2098765,3330.938272,5085.777778,1238.641975,286.1234568,3199.901235,424.7160494,93.33333333,81,12.28884093,8.432185289,0.727444959,0.964285714,0.736363636,0.746389652
+179,24067.86747,827.4096386,948.253012,1174.361446,21627.45783,650.1807229,963.8313253,1700.445783,11735.53012,573.9156627,772.8674699,1805.481928,16875.38554,1241.240964,2653.313253,2454.554217,6091.144578,1281.951807,387.9879518,3393.072289,11958.45783,608.9879518,130.3975904,708.1686747,13977.73494,459.8433735,122.1445783,3789.120482,11607.84337,1704.759036,835.8554217,2869.590361,9444.710843,872.3855422,280.2289157,3731,7292.53012,1212.975904,441.313253,1325.506024,5667.795181,633.2168675,168.5060241,3588.686747,4529.73494,1252.73494,152.1204819,3272.86747,468.9036145,93.06024096,83,10.9128428,10.2041581,0.35449062,0.912087912,0.754545455,-1.486436008
+180,12758.88957,664.5766871,457.2147239,1059.96319,11427.83436,548.0245399,419.5030675,1513.484663,6511.282209,468.2883436,441.0920245,1789.858896,8922.711656,1064.96319,4072.441718,2597.312883,3288.337423,1063.852761,350.4785276,2890.392638,6002.680982,1896.625767,634.6993865,470.7300613,7130.644172,368.5030675,104.3190184,4891.895706,6112.006135,1338.220859,812.5092025,2783.907975,4897.570552,539.0245399,241.4355828,16543.03681,3811.97546,794.2392638,352.3251534,1330.736196,2930.392638,851.7607362,149.8711656,4284.98773,2407.95092,1092.883436,158.5582822,3078.018405,678.601227,96.71779141,163,17.44829504,12.6823779,0.686791107,0.895604396,0.599264706,-0.883802333
+181,20485.54545,752.4431818,504.0113636,1077.579545,18051.76136,603.4204545,627.6477273,1698.125,9532.352273,499.4318182,1075.613636,1884.875,13847.15909,1150.125,5735.352273,4165.613636,5287.193182,1151.011364,378.9772727,4380.284091,9367.443182,1203.431818,609.2954545,641.5454545,11400.73864,405.3409091,114.8636364,6877.227273,9818.977273,1644.363636,921.75,2791.227273,7860.034091,573.75,254.1818182,13179.125,6177.806818,1079.931818,384.6477273,1331.988636,4303.068182,758.6363636,159.8636364,4526.102273,3558.659091,1138.727273,231.6590909,3185.534091,862.0340909,93.60227273,88,13.24614636,9.114874048,0.725601498,0.956521739,0.571428571,1.308607279
+182,21153.09251,743.3700441,478.1629956,1087.348018,18767.76211,676.1982379,1048.638767,1617.017621,9666.854626,499.0881057,1226.687225,1812.259912,14453.46696,1182.735683,5166.9163,2544.436123,5381.911894,1155.506608,366.2687225,4115.801762,9658.471366,5593.343612,277.8325991,721.9867841,11949.59031,422.9295154,112.7885463,3933.400881,10090.08811,1806.400881,726.969163,2800.845815,8057.211454,572.4008811,268.3039648,16480.86784,6022.127753,1099.193833,392.277533,1351.343612,4021.929515,712.660793,160.8810573,4870.140969,3475.898678,1148.621145,296.8810573,3199.651982,904.3700441,97.98237885,227,17.82994858,16.58094934,0.367687613,0.945833333,0.700617284,1.247917299
+183,18376.85833,716.45,456.8166667,1068.408333,15770.825,578.575,691.45,1593.375,7599.725,477.9083333,566.325,1797.741667,11854.34167,1128.691667,4434.658333,3010.591667,4336.941667,1143.641667,354.9666667,3573.616667,7828.158333,2479.791667,213.1666667,492.525,9790.175,410.55,109.2833333,4783.533333,7859.083333,1510.725,764.4666667,2813.183333,6385.708333,620.4166667,252.15,17295.11667,4769.391667,871.6583333,379.0833333,1345.933333,3072.425,669.3583333,147.6666667,3720.633333,2724.7,1104.641667,230.6833333,3177.125,919.0833333,95.25,120,14.27834356,10.87280066,0.648177907,0.952380952,0.714285714,-0.028814214
+184,35373.62921,825.3370787,516,1104.157303,31263.39326,686.988764,1081.88764,1630.696629,17121.82022,599.0449438,1518.483146,1748.078652,23200.89888,1265.426966,4508.94382,4352.11236,8504.910112,1304.41573,399.752809,2992.808989,15384.96629,607.1348315,116.0786517,1246.775281,19085.52809,600.7640449,433.8764045,2960.022472,15867.49438,1718.797753,858.011236,2841.325843,12585.47191,658.6292135,294.7078652,8446.47191,9493.932584,1107.303371,434.0337079,1342.426966,7167.370787,646.505618,167.6404494,3986.52809,5758.752809,1255.033708,437.5505618,3194.157303,454.0674157,95.19101124,89,11.72030754,10.16937121,0.497138813,0.898989899,0.674242424,-0.426677211
+185,14862.41919,703.7070707,515.3181818,1073.287879,12852.11111,571.9343434,590.8080808,1591.590909,6676.641414,466.2424242,435.5353535,1774.626263,9943.666667,1119.550505,3889.656566,2292.065657,3731.141414,1158.974747,372.1464646,2622.212121,6385.545455,5412.505051,593.3838384,493.4343434,8053.151515,397.3131313,111.979798,5930.348485,6872.873737,1372.626263,803.540404,2798.530303,5523.419192,591.479798,265.0606061,23032.84848,4273.383838,879.2626263,383.9494949,1322.454545,2800.39899,730.1313131,151.4494949,4700.777778,2441.333333,1090.30303,191.479798,3154.651515,887.5757576,97.69191919,198,17.16917484,14.77278749,0.509577076,0.956521739,0.727941176,0.042406362
+186,23256.27083,741.6041667,460.46875,1085.645833,19713.69792,589.3229167,724.53125,1670,9344.364583,471.96875,481.5208333,1813.947917,15712.71875,1136.302083,4009.28125,3006.697917,5735.666667,1128.145833,355.75,2831.510417,10259.05208,4412.447917,278.8333333,466.0833333,12466.38542,436.9583333,111.03125,6078.333333,10430.1875,1446.197917,816.5520833,2794.583333,8361.239583,546.3125,235.8958333,6323.677083,6263.364583,745.5625,376.8541667,1302.302083,3679.020833,704,147.65625,2986.09375,3327.0625,1107.385417,178.0208333,3168.510417,950.1666667,95.78125,96,12.40075539,9.925280672,0.599496866,0.941176471,0.666666667,0.701971724
+187,31312.3,803.1,500.4928571,1116.3,27779.44286,651.1285714,467.65,1616.971429,14831.17143,557.2714286,454.1928571,1749.457143,20054.19286,1208.328571,2934.435714,3476.157143,7228.092857,1267.892857,393.6428571,2487.714286,13238.75714,374.3357143,530.4142857,505.9142857,15925.31429,374.7714286,120.4214286,2791.442857,13170.42857,1423.707143,856.9071429,2867.714286,10411.79286,577.8642857,282.0714286,3387.428571,7842.442857,846.4928571,424.3571429,1327.735714,5913.564286,760.7357143,162.2785714,2311.35,4528.635714,1212.321429,237.0357143,3180.071429,440.7571429,96.49285714,140,17.68444683,10.59522099,0.80065437,0.875,0.68627451,1.550407041
+188,22069.44366,730.5140845,523.5352113,1091.338028,19384.42254,613.1690141,792.3591549,1593.929577,10824.87324,531.3239437,1665.584507,1863.450704,14839.94366,1142.366197,5789.65493,3513.690141,5441.295775,1154.65493,360.1408451,3891.485915,9676.464789,585.0492958,106.9788732,1054.964789,11890.5,371.8028169,113.9225352,4509.140845,10131.74648,1746.394366,920.8661972,2811.197183,7991.147887,595.0352113,265.1690141,15843.59155,6184.295775,1143.669014,407.4366197,1314.880282,4617.126761,667.9859155,158.5140845,3478.43662,3804.464789,1165.640845,244.5774648,3154.957746,515.7183099,98.20422535,142,17.14798736,10.88782915,0.772566913,0.934210526,0.591666667,0.805836998
+189,20922.69304,729.3449367,461.7088608,1091.566456,18248.62025,598.1234177,735.3164557,1571.110759,10128.58544,497.7246835,1029.901899,1800.291139,14349.56646,1135.566456,4696.003165,3076.443038,5424.275316,1137.585443,385.4905063,5799.424051,9357.224684,3802.544304,1357.674051,659.9778481,11353.63924,416.943038,110.4556962,3956.955696,9695.452532,1599.325949,778.7879747,2788.268987,7717.401899,568.0791139,247.7658228,9372.253165,6157.658228,1016.427215,381.8544304,1377.075949,4404.224684,1012.227848,157.7056962,3640.060127,3690.21519,1151.515823,222.5727848,3123.325949,797.9462025,101.306962,316,26.22081319,16.13012277,0.788398503,0.885154062,0.615984405,1.562002403
+190,21838.5858,723.6804734,457.6804734,1065.674556,19400.64497,596.6745562,698.443787,1618.147929,10339.83432,487.2307692,564.3550296,1794.39645,14864.43195,1141.668639,4220.56213,2807.52071,5545.443787,1139.39645,380.5857988,3587.739645,9762.550296,5927.390533,450.3136095,540.6153846,12004.92308,431.8757396,112.7988166,6382.526627,10355.43787,1525.136095,761.2071006,2791.130178,8305.621302,645.260355,258.112426,11969.86391,6518.786982,882.8579882,386.4142012,1313.402367,4489.739645,819.8579882,161.3136095,3253.798817,3759.118343,1142.615385,154.0828402,3166.485207,854.2011834,99.56804734,169,20.0064214,11.11495072,0.83147033,0.938888889,0.552287582,0.863325893
+191,15011.14198,695.191358,548.7407407,1078.833333,13160.30864,567.2592593,489.7716049,1651.592593,7288.37037,490.6666667,434.6666667,1829.148148,9939.074074,1089.08642,5552.209877,2834.592593,3736.882716,1087.08642,342.9382716,2507.95679,6618.561728,1163.037037,886.9074074,448.0864198,7928.771605,365.9320988,106.9074074,6710.54321,6771.074074,1332.611111,962.9567901,2821.388889,5467.345679,525.3209877,274.7901235,34379.06173,4405.919753,790.2160494,382.1049383,1363.469136,3196.765432,1069.030864,149.5925926,5714.104938,2716.197531,1132.993827,215.3518519,3135.604938,588.2530864,100.9382716,162,16.69953635,12.54090281,0.660332782,0.941860465,0.680672269,-0.283333654
+192,26977.22892,734.4156627,445.6204819,1084.957831,23313.21084,596.9578313,765.3554217,1643.096386,11166.58434,482.6987952,763.6927711,1776.391566,17513.07229,1137.855422,4437.475904,3069.801205,6546.295181,1154.475904,362.0301205,3797.554217,11579.23494,3306.337349,109.5542169,752.1024096,14286.18072,433.439759,115.8313253,5913.138554,11747.3494,1605.89759,826.2289157,2796.650602,9508.186747,565.7289157,244.3313253,5573.789157,7020.126506,914.0180723,389.6084337,1316.554217,4408.855422,619.4096386,155.5783133,3418.210843,3937.566265,1137.301205,196.7168675,3191.837349,933.5240964,99.18674699,166,21.94994142,10.39898142,0.880654556,0.846938776,0.538961039,-1.226663857
+193,36133.0443,988.3101266,601.2025316,1135.867089,32309.72785,760.9303797,722.0443038,1699.822785,16905.39873,636.5126582,1232.85443,1883.860759,23957.79114,1355.101266,4602.626582,3711.468354,8633.765823,1340.955696,416,2623.765823,17105.6519,398.6582278,623.5632911,630.0506329,19588.77848,472.1329114,205.9240506,4500.240506,16359.96203,1902.177215,819.9873418,2832.373418,13110.77848,824.4177215,297.6772152,1720.094937,9191.626582,1047.822785,459.721519,1330.411392,7970.683544,806.1392405,181.4240506,4430.594937,5871.386076,1325.272152,396.835443,3262.924051,352.7405063,102.4493671,158,20.40944099,10.43883229,0.859300682,0.882681564,0.546712803,0.724547353
+194,45599.31707,875.1869919,503.0487805,1139.073171,40757.52033,719.6829268,553.4715447,1664.796748,21539.5935,619.3739837,558.3658537,1767.325203,29781.63415,1322.04878,4560.487805,4840.95935,10757.88618,1365.414634,416.9837398,2433.552846,20735,391.8130081,215.3414634,463.1300813,24948.4878,601.3252033,128.4065041,3263.430894,20644.4878,1492.707317,1022.211382,2820.341463,16853.78862,612.4308943,304.4552846,2645.780488,12218.77236,955.0406504,461.6260163,1324.03252,9729.300813,679.5772358,178.2113821,3120.373984,7592.674797,1364.691057,221.1788618,3261.617886,399.0487805,100.1544715,123,13.49424062,11.81934838,0.482527253,0.968503937,0.62755102,1.142809204
+195,21507.52703,779.0810811,551.8783784,1103.608108,18919.63514,610.1148649,889.9459459,1700.608108,10757.20946,522.9256757,965.5810811,1865.277027,15040.52703,1183.898649,6401.263514,3940.533784,5495.648649,1142.97973,360.8783784,4716.614865,9693.425676,821.9121622,117.0540541,928.3581081,12048.69595,380.7094595,111.1756757,5717.364865,10189.25676,1664.006757,1038.959459,2807.148649,8169.236486,555.472973,276.6081081,25349.52027,6484.831081,973.9459459,393.6081081,1400.939189,4879.594595,1215.777027,150.9256757,5638.466216,4014.405405,1179.952703,208.3581081,3191.608108,703.7432432,101.3716216,148,16.24383737,12.30283738,0.652968675,0.891566265,0.580392157,-1.491787722
+196,17026.51579,629.9894737,394.0842105,1042.926316,14813.37895,527.3157895,303.1578947,1494.031579,8302.115789,453.8210526,364.2947368,1779.4,11146.42105,1027.336842,2781.126316,1929.357895,4177,1038.189474,398.3684211,2888.915789,7185.389474,5872.105263,596.8842105,423.1894737,8536.178947,359.6631579,103.0105263,3453.157895,7365.6,1278.105263,766.1578947,2779.768421,5886.631579,589.4526316,226.4631579,7193.842105,4538.221053,733,346.1684211,1333.694737,3292.673684,705.2631579,133.4947368,2806.757895,2668.010526,1034.810526,132.1578947,3074.263158,735.5368421,99.67368421,95,12.11610544,11.37961389,0.343332736,0.896226415,0.608974359,0.700987951
+197,22479.70732,703.3780488,450.5121951,1063.963415,19657.43902,579.6097561,452.6097561,1560.04878,10709.7561,474.7439024,422.9390244,1793.02439,15325.07317,1094.341463,2673.231707,2211.536585,5676.219512,1125.707317,377.9512195,2603.134146,10106.7439,3276.341463,1029.926829,764.6463415,12417.5,381.4268293,113.2804878,3850.926829,10647.19512,1438.804878,743.6341463,2807.560976,8406.036585,666.1463415,249.2560976,6782.146341,6611.060976,864.7439024,379.0243902,1304.060976,4391.060976,881.1219512,147.3170732,2576.963415,3638.670732,1108.329268,158.8780488,3106.512195,870.7317073,98.26829268,82,13.81528282,7.702101961,0.830172963,0.964705882,0.630769231,-1.083021936
+198,20170.48276,738.8206897,500.9241379,1116.848276,17425.83448,582.2896552,552.8896552,1723.42069,9898.724138,496.7241379,545.0206897,1814.689655,12658.43448,1098.351724,4583.234483,3405,4699.903448,1116.613793,370.6137931,3122.124138,8078.351724,1098.324138,2281,516.0206897,9229.186207,384.0827586,107.2,6204.103448,8098.751724,1417.875862,822.8965517,2794.434483,6437.524138,507.3172414,252.6689655,25121.77931,4771.489655,1242.358621,355.9931034,1373.786207,3421.034483,1366.331034,142.5655172,5442.089655,2683.468966,1092.344828,169.2896552,3106.37931,638.5862069,102.4965517,145,16.58022378,11.25555098,0.734273292,0.947712418,0.609243697,-0.569935144
+199,14750.66102,621,385.4237288,1045.949153,13097.47458,526.6949153,351.8135593,1435.745763,7348.728814,444.4237288,375.3389831,1717.847458,10117.37288,1023.186441,2769.59322,1757.559322,3879.372881,1020.084746,359.1694915,2673.881356,6807.305085,4442.118644,566.440678,444.8474576,8087.79661,352.2881356,101.7457627,3559.423729,7049.067797,1310.40678,746.6610169,2779.067797,5746.118644,612,220.4745763,5898.322034,4497.813559,698.6949153,347.0338983,1295.966102,3289.40678,693.440678,137.3220339,2344.440678,2665.271186,1032.525424,119.3050847,3035.40678,743.5084746,101.6271186,59,13.0074187,6.087350645,0.883733404,0.893939394,0.602040816,0.11214534
+200,42230.25714,1009.642857,687.7142857,1172.3,38146.01429,782.7142857,788.6142857,1793.785714,19874.57143,655.4571429,950.0857143,1796.128571,27319.25714,1405.757143,4860.8,3878.728571,10161.28571,1440.1,448.3,2688.485714,19668.14286,439.4428571,693.9,858.8714286,23509.07143,443.6428571,142.5857143,7470.414286,19337.64286,1990.485714,823.7285714,2843.357143,15278.25714,770.9428571,307.8,1696.428571,10796.85714,1119.285714,483.9857143,1354.985714,9155.014286,812.7,182.5428571,3862.928571,7141.528571,1381.8,281.1857143,3345.585714,361.0857143,100.3571429,70,13.36643853,6.860442253,0.858233884,0.985915493,0.578512397,0.781415617
+201,40493.30872,825.1409396,468.2416107,1120.536913,36830.84564,678.9530201,606.885906,1621.281879,19799.45638,596.0805369,825.2348993,1770.255034,26917.5906,1256.389262,3839.959732,3191.288591,9814.013423,1308.959732,403.9731544,2477.449664,18231.12752,1013.604027,172.7852349,722.7315436,22459.71141,403.1073826,124.6510067,2518.248322,18497.25503,1564.879195,1019.691275,2844.872483,15148.47651,591.0067114,290.4832215,2122.087248,11134.83221,943.4295302,445.6241611,1310.496644,8517.436242,664.5973154,168.704698,2521.308725,6760.885906,1282.496644,146.1946309,3227.550336,416.6711409,101.4228188,149,21.55889743,9.737097966,0.892194686,0.809782609,0.591269841,-1.550391859
+202,26394.67857,864.8839286,1453.8125,1302.508929,23029.16964,689.2946429,1032.026786,2047.232143,13037.42857,595.3482143,541.8660714,2008.258929,18404.39286,1293.580357,2974.071429,2162.598214,6388.892857,1345.589286,404.1785714,2613.848214,12291.03571,951.9375,128.3035714,463.4375,14563.8125,439.7946429,126.3125,3745.223214,12411.88393,1483.785714,801,2880.848214,9941.294643,603.8303571,288.0267857,5931.080357,7842.392857,895.2589286,464.7857143,1351.428571,6052.892857,687.9196429,171.5535714,1867.526786,4906.044643,1314.339286,144.5714286,3312.089286,529.4821429,102.9821429,112,12.3890918,12.09191821,0.217710961,0.933333333,0.571428571,0.562042809
+203,29028.08602,795.1075269,455.8494624,1105.086022,25140.77419,634.827957,723.3763441,1667.612903,13812.03226,547.4731183,1660.688172,1817.44086,19415.27957,1213.870968,6079.634409,4052.430108,7038.225806,1221.096774,384.7526882,5178.311828,12617.22581,911.9892473,176.7419355,813.5806452,15241.70968,399.2580645,115.4086022,3944.580645,13078.47312,1599.526882,679.9354839,2800.913978,10300.86022,557.3763441,266.9784946,7788.795699,7997.88172,900.7849462,401.7741935,1323.043011,5918.774194,631.2150538,159.2043011,2297.354839,4809.784946,1222.741935,252.3548387,3170.043011,766.3333333,100.2580645,93,12.5714476,9.849256005,0.621439241,0.958762887,0.715384615,-1.386227974
+204,30702.94318,791.1363636,528.0340909,1091.170455,27158.21591,646.7272727,909.9318182,1589.5,15060.90909,565.8863636,1764.545455,1801.897727,20448.95455,1213.988636,5722.488636,3776.170455,7641.409091,1252.397727,387.8068182,2861.352273,13759.34091,828.3409091,131.6590909,1125.625,16901.78409,1787.568182,156.875,4353.068182,14320.64773,1568.715909,1015.647727,2910.056818,11317.64773,731.9886364,286.9886364,14142.76136,8581.568182,1115.284091,425.4090909,1339.647727,6477.318182,662.5681818,167.4886364,4832.693182,5346.318182,1235.511364,424.9886364,3216.556818,460.3636364,103.0340909,88,13.73716016,8.998572938,0.755582619,0.838095238,0.533333333,-0.159810952
+205,19787.79524,717.9761905,479.9285714,1089.309524,17181.04286,575.2666667,492.3238095,1564.871429,9691.67619,490.252381,781.1571429,1796.733333,13507.57619,1115.214286,4218.161905,3366.028571,4967.614286,1113.261905,352.9095238,3602.890476,8745.290476,2042.742857,164.0428571,556.7666667,10579.7381,375.352381,108.9285714,5036.738095,8959.295238,1398.238095,914.7285714,2779.209524,7173.204762,519.6714286,244.6619048,9850.766667,5677.557143,911.7190476,368.2904762,1346.519048,4257.1,692.2,148.3857143,3940.338095,3489.352381,1141.561905,178.1142857,3125.038095,686.4619048,108.0047619,210,22.67690113,12.21323642,0.842576887,0.905172414,0.608695652,-0.302196914
+206,20447.20161,737.4879032,523.0504032,1107.959677,18264.82258,603.2318548,546.953629,1671.572581,10348.13911,532.3991935,913.25,1843.08871,14330.1129,1149.266129,5807.052419,3907.389113,5124.201613,1147.546371,377.5504032,3864.625,9705.127016,1204.489919,574.046371,697.125,11152.62097,385.5060484,109.9939516,6088.669355,9874.788306,1456.114919,1040.048387,2829.929435,8029.266129,582.3709677,266.766129,20412.54435,6198.205645,941.5241935,406.9858871,1369.957661,4722.211694,842.1330645,158.3225806,4104.086694,3927.9375,1190.072581,269.0080645,3199.895161,569.358871,109.7883065,496,29.56618153,22.52307873,0.647829722,0.895306859,0.666666667,1.463342726
+207,17004.66583,673.1557789,483.4020101,1050.507538,14812.31156,558.3316583,556.0979899,1511.733668,8003.017588,456.5728643,466.1155779,1754.61809,11543.94975,1060.243719,4020.361809,2475.160804,4329.361809,1086.60804,371.0452261,2796.050251,7420.527638,3550.781407,1178.09799,498.2261307,9197.507538,372.3894472,107.2537688,5080.28392,7936.165829,1457.223618,868.6055276,2841.527638,6457.268844,635.2085427,234.821608,13703.22111,4960.633166,781.9798995,365.6030151,1328.592965,3313.577889,884.1683417,151.7839196,3603.477387,2813.346734,1064.894472,173.040201,3122.462312,870.3994975,111.6130653,398,28.84133646,18.22285557,0.775106034,0.917050691,0.614197531,-0.803705582
+208,18096.43,785.43,498.28,1074.43,16912.78,633.76,552.73,1529.71,8590.15,523.71,658.19,1750.04,11980.51,1195.12,3561.07,3870.06,4285.89,1193.62,377.65,2578.33,8910.79,344.39,708.84,581.16,10057.06,455.22,116.85,3111.98,8431.2,1568.12,1012.16,2816.75,6829.23,850.94,264,2956.39,5008.04,908.55,409.89,1323.82,4323.21,796.25,172.94,4791.97,3238.61,1270.3,2082.46,3154.79,382.61,105.76,100,15.00154424,9.028757972,0.798605205,0.892857143,0.714285714,-0.050652387
+209,19790.51915,729.4553191,478.2468085,1084.004255,17246.67234,588.0638298,534.6255319,1614.182979,9303.012766,486.0893617,1241.689362,1817.374468,13134.5234,1135.110638,4795.621277,3240.212766,4895.051064,1131.889362,357.5914894,5676.880851,8555.051064,1240.748936,133.1659574,625.3191489,10538.6,378.9957447,110.6170213,5369.357447,9070.689362,1459.4,806.0212766,2828.4,7330.982979,530.1404255,259.9191489,19938.80851,5701.770213,985.3319149,380.5829787,1358.310638,4013.059574,887.5914894,156.0680851,4377.502128,3397.093617,1135.459574,219.3191489,3126.706383,832.3744681,107.6042553,235,24.16139227,13.14813389,0.838968827,0.876865672,0.621693122,-1.042551815
+210,30498.07813,817.75,486.171875,1129.75,26152.53906,651.78125,682.4453125,1728.84375,12675.54688,503.359375,548.203125,1787.453125,20261.94531,1216.015625,3242.789063,2897.304688,7362.523438,1210.804688,383.6875,2977.054688,13496.53125,10336.80469,128.1015625,502.859375,16334.52344,491.359375,124.859375,5566.289063,13592.1875,1517.203125,819.828125,2802.820313,10766.44531,574.4296875,271.734375,5220.992188,7995.132813,838.40625,412.0703125,1314.28125,4922.679688,642.359375,157.34375,2593.148438,4362.695313,1198.109375,142.46875,3264.898438,942.1484375,106.203125,128,14.68753773,11.74259512,0.600674362,0.934306569,0.656410256,-0.290455373
+211,23941.18182,715.9090909,476.5454545,1053.909091,20369.73864,585.4090909,832.5681818,1529.136364,11585.25,527.0568182,1298,1813.670455,16148.71591,1124.693182,5306.954545,4165.806818,5817.954545,1142.795455,354.6363636,5353.670455,10677.375,875.9318182,106.7840909,1285.806818,12830.375,379.9545455,109.1931818,5171.5,11016.40909,1855.681818,944.7386364,2811.295455,8683.75,558.8181818,249.8409091,4208.272727,6802.795455,1141.5,407.3409091,1328.522727,5105.897727,606.6818182,160.875,2905.715909,4136.272727,1174.818182,380.0795455,3156.102273,510.75,106.0909091,88,12.89359124,9.179293943,0.702253618,0.936170213,0.520710059,0.753471927
+212,19765.86628,713.25,505.0406977,1082.877907,17778.58721,576.4825581,375.255814,1610.348837,9967.209302,490.9302326,420.4360465,1786.505814,13719.02326,1113.412791,5140.901163,3582.668605,5022.517442,1100.575581,349.5872093,2904.744186,8756.395349,1325.040698,110.7325581,432.1860465,10556.88372,365.0174419,108.1627907,8137.093023,8979.273256,1300.732558,1075.482558,2791.633721,7132.784884,534.3139535,248.8837209,15513.16279,5632.401163,761.0232558,366.7325581,1330.860465,4199.656977,702.255814,148.7325581,4290.156977,3392.965116,1116.354651,157.744186,3159.523256,724.7209302,107.6453488,172,20.38416774,11.48990362,0.826001426,0.914893617,0.562091503,0.760981995
+213,32483.45283,963.2358491,509.5188679,1086.264151,29304.93396,727.8018868,579.0849057,1565.245283,15224.5,611.9433962,479.4528302,1743.386792,20948.91509,1291.264151,3653.075472,2890.339623,7516.04717,1299.160377,406.6320755,2403.415094,14940.9434,376.3584906,984.2358491,447.1320755,17469.18868,426.5943396,121.254717,2591.613208,14543.36792,1493.283019,825.7358491,2830.349057,11833.09434,638.7830189,280.2735849,3129.641509,8617.95283,861.8018868,448.4150943,1359.528302,7143.886792,864.9245283,172.9056604,4144.075472,5433.59434,1309.849057,517.6886792,3360.40566,391.8207547,107.4622642,106,14.25362856,9.720386116,0.731390676,0.972477064,0.630952381,0.510058233
+214,44016.01887,884.7169811,515.3396226,1128.801887,38377.33019,721.6037736,693.2924528,1645.669811,21525.67925,624.2358491,821.7358491,1763.141509,29110.4434,1343.150943,6177.584906,4682.688679,10466.15094,1371.216981,420.3396226,2683.132075,19556.19811,438.745283,125.0188679,955.6509434,24054.43396,767.7264151,146.5283019,3131.40566,20011.78302,1666.641509,843.7264151,2841.773585,16065.19811,632.5471698,298.8773585,3827.613208,12195.91509,1052.735849,462.9811321,1309.358491,9240.09434,654.6320755,175.6886792,2744.113208,7416.537736,1360,213.1792453,3275.122642,450.9150943,106.9056604,106,12.36436349,11.37013047,0.392882167,0.905982906,0.679487179,0.795566969
+215,15802.17123,692.2191781,507.390411,1052.041096,14207.05479,564.7465753,563.9178082,1537.5,7838.773973,498.739726,738.4109589,1791.726027,10391.82192,1095.013699,5840.623288,4057.623288,3950.5,1108.472603,345.2671233,4262.732877,7380.130137,3449.589041,110.3082192,686.9863014,8720.376712,394.9726027,107.2260274,4883.869863,7116.520548,1478.445205,1304.376712,2809.157534,5767.739726,585.0273973,241.7054795,7661.808219,4450.068493,942.1369863,391.760274,1322.308219,3499.130137,608.7808219,154.6917808,4398.835616,2771.917808,1118.589041,245.2123288,3101.534247,485.5547945,107.4315068,146,15.98873575,12.94525762,0.586914929,0.85380117,0.608333333,-1.494648582
+216,24879.89286,748.1150794,469.7103175,1101.992063,21024.05159,598.9325397,538.4603175,1648.797619,12108.70635,518.9007937,563.0873016,1810.678571,16149.68254,1137.765873,4871.515873,3331.753968,6151.376984,1142.448413,360.1071429,3397.25,10802.32937,2162.924603,998.3650794,500.0912698,12846.01587,404.4563492,110.5357143,5502.757937,11149.42063,1433.837302,789.6547619,2791.25,8629.09127,572.1944444,250.6468254,13783.81349,6805.595238,875.0436508,370.8611111,1372.611111,5159.055556,929.0793651,151.6111111,4162.15873,4092.186508,1173.329365,179.3452381,3180.297619,619.2222222,110.031746,252,25.6954187,13.42419646,0.852678866,0.9,0.6,-0.692129528
+217,23271.81921,799.2033898,652.5649718,1152.717514,20583.03955,639.9378531,659.2429379,1747.39548,11850.50282,542.9548023,564.740113,1821.045198,16283.27119,1252.943503,4026.960452,2146.378531,5918.903955,1222.265537,370.3615819,2987.632768,10749.20904,2490.943503,157.3333333,566.0169492,12922.20904,428.8418079,110.8474576,4063.887006,11241.99435,1539.344633,793.4124294,2799.60452,8806.096045,550.9152542,258.7570621,11552.25424,6951.903955,1009.463277,394.3615819,1346.418079,5195.361582,660.0112994,172.7231638,4362.152542,4282.525424,1227.542373,170.819209,3169.00565,672.2711864,108.5819209,177,21.12586319,11.40454172,0.841768992,0.898477157,0.546296296,0.77938395
+218,24321.01948,714.9480519,423.1298701,1058.383117,20933.57143,578.8311688,513.4220779,1619.337662,11644.87662,496.7987013,428.0194805,1817.136364,16215.67532,1113.448052,4570.792208,2873.025974,6040.88961,1119.967532,357.7727273,2736.11039,10307.66883,2140.74026,302.3506494,444.4090909,12708.33766,377.4155844,109.2402597,5148.980519,11092.08442,1299.461039,785.8831169,2778.61039,8779.12987,522.1948052,246.6688312,11182.03896,6895.551948,722.0064935,379.6883117,1325.584416,5005.077922,650.2207792,149.6558442,2953.415584,4159.272727,1139.714286,167.525974,3148.701299,769.5649351,108.9350649,154,20.32459928,10.68664145,0.850609229,0.846153846,0.475308642,-0.965228919
+219,22285.38017,710.2479339,448.5950413,1064.487603,19429.1157,580.9173554,633.5867769,1599.049587,10394.41322,477.2066116,555.3305785,1759.297521,14964.43802,1113.181818,3397.214876,2482.818182,5594.355372,1125.371901,352.0082645,3807.85124,9619.917355,2333.380165,106.7520661,511.6446281,12114.79339,378.9338843,111.6033058,5096.900826,10451.08264,1433.173554,708.7603306,2787.719008,8342.297521,534.8264463,255.8842975,15241.85124,6551.099174,780.1157025,384.6446281,1319.322314,4507.454545,797.446281,147.446281,2949.743802,3801.85124,1127.247934,163.322314,3133.198347,849.231405,107.8512397,121,18.24295324,10.42566807,0.820608926,0.765822785,0.540178571,1.141740182
+220,42668.72222,858.3571429,485.1349206,1125.603175,37590.24603,691.1984127,571.7460317,1664.325397,20211.56349,598.3095238,632.3412698,1763.111111,27193.69841,1286.198413,4658.452381,3982.333333,9657.571429,1301.261905,423.1031746,2471.690476,18048.56349,396.6825397,1119.992063,513.1825397,22114.22222,505.3730159,126.6587302,3741.380952,18282.64286,1536.02381,903.0634921,2809.484127,14498.46825,581.031746,297.1904762,2734.365079,10729.07143,960.2301587,452.452381,1328.650794,8052.920635,891.5,168.5555556,2796.301587,6552.928571,1277.777778,244.6111111,3240.666667,431.7936508,110.7380952,126,21.06937455,8.197045776,0.921216527,0.868965517,0.7,0.076882156
+221,39135.2093,871.9709302,540.0232558,1152.156977,34503.05233,720.8895349,629.9767442,1694.30814,18810.81977,604.2325581,833.0290698,1770.040698,25531.25581,1301.47093,5924.110465,4971.773256,9102.52907,1326.116279,418.3197674,2689.563953,17275.71512,414.2906977,457.2906977,1060.156977,20801.30233,396.2965116,277.2732558,3695.238372,17049.43605,1521.895349,974.9709302,2845.424419,13804.11628,628.1860465,301.6337209,3774.895349,10439.09302,1005.662791,456.1453488,1354.005814,8073.244186,743.122093,173.5232558,2729.587209,6291.662791,1306.331395,306.1162791,3250.203488,441.0523256,111.5523256,172,20.17847189,11.79662078,0.811311446,0.843137255,0.661538462,0.013895404
+222,21592.37121,707.6590909,452.3181818,1080.871212,19115.87879,574.3787879,407.0151515,1563.886364,9808.94697,468.3257576,394.5606061,1791,14834.9697,1099.55303,3757.515152,2340.424242,5548.287879,1113.401515,356.1363636,2584.69697,10055.59091,6077.659091,99.88636364,441.7424242,12111.73485,421.0530303,114.25,5824.962121,10111.91667,1318.55303,855.6742424,2795.128788,8134.075758,539.1363636,248.3409091,8134.045455,6198.568182,744.8181818,381.780303,1306.916667,3844.121212,681.1287879,150.9242424,3040.848485,3394.401515,1105.204545,152.7575758,3134.522727,925.1287879,108.6363636,132,17.53707504,10.30490794,0.809146477,0.857142857,0.534412955,1.122198506
+223,33589.80769,886.9134615,519.6923077,1156.721154,27549.46154,747.9326923,1826.163462,1833.644231,12658.28846,551.5288462,2677.836538,1960.932692,20901.48077,1323.346154,7222.346154,3984.778846,7537.826923,1268.875,396.5,7936.653846,13639.55769,1860.230769,117.6634615,1160.865385,17134,476.8557692,124.9807692,5055.865385,13751.67308,2559.134615,747.9711538,2805.903846,11082.36538,584.625,272.8846154,6197.403846,8096.615385,1531.730769,431.9423077,1342.951923,4942.346154,666.4807692,175.6346154,3750.125,4508.278846,1238.855769,442.6442308,3337.375,952.1057692,108.1634615,104,13.63434242,9.874117569,0.689580228,0.95412844,0.666666667,-0.411909007
+224,21399.76423,696.7479675,468.3821138,1036.349593,19580.37398,587.7804878,795.7804878,1485.089431,10781,507.4146341,1015.95935,1768.292683,14701.38211,1123.138211,4556.268293,2018.560976,5440.528455,1149.747967,351.2926829,3263.845528,10194.2439,5237.569106,317.6341463,590.9268293,12179.08943,523.1138211,113.2926829,4626.691057,10229.92683,1744.813008,1040.715447,2812.01626,8186.113821,756.0569106,253.902439,6158.02439,6389.747967,961.8536585,398.1382114,1296.203252,4839.01626,677.2926829,155.2439024,3799.138211,3977.495935,1160.081301,263.0894309,3163.300813,465.8780488,110.8943089,123,16.20248796,10.05137703,0.784317122,0.92481203,0.549107143,-0.602329853
+225,16570.01923,685.3990385,545.5625,1074.0625,14811.52885,557.9134615,520.3942308,1518.985577,8529.355769,495.8125,627.6105769,1793.778846,11486.80288,1097.721154,5730.783654,3243.014423,4395.956731,1109.3125,345.6442308,3180.567308,7717.096154,606.2980769,322.0336538,498.9375,9222.504808,389.2692308,109.2307692,7436.298077,7909.826923,1398.956731,1087.3125,2798.591346,6365.009615,533.2980769,240.4326923,13382.88462,4960.331731,839.9663462,389.1298077,1320.701923,3671.360577,746.1682692,173.8990385,2954.591346,3081.754808,1127.625,168.3701923,3120.221154,537.8653846,111.3076923,208,22.03950354,12.83601348,0.812895639,0.912280702,0.590909091,-1.296392726
+226,20392.55745,729.5361702,543.8680851,1081.353191,17962.05957,577.9191489,524.3148936,1694.374468,9987.387234,495.4255319,413.3148936,1847.617021,13265.17447,1098.493617,4427.217021,3577.434043,4903.148936,1114.689362,341.6297872,2675.26383,8718.238298,1394.238298,735.4510638,450.4978723,10089.77447,365.9361702,106.7659574,7230.195745,8620.719149,1309.953191,947.7702128,2777.770213,6881.565957,513.9404255,253.2510638,17648.21702,5220.323404,869.7957447,367.9191489,1337.655319,3864.268085,800.9021277,147.5191489,4292.425532,3105.361702,1116.625532,147.0553191,3144.570213,648.6553191,111.2255319,235,20.16467658,16.6914056,0.561090166,0.854545455,0.562200957,-0.634746785
+227,19463.75,744.0611111,484.1055556,1076.477778,16689.77778,602.2888889,1010.527778,1598.511111,7971.105556,495.5388889,1346.294444,1787.05,13670.86111,1174.122222,4780.261111,3136.933333,5017.666667,1182.561111,462.2111111,8072.216667,9105.522222,1997.833333,489.2055556,804.7222222,11057.78889,440.3388889,117.1222222,4677.95,9166.911111,1969.016667,711.7555556,2799.194444,7352.477778,629.1666667,252.9833333,11419.25556,5388.922222,1251.555556,389.3111111,1338.755556,3198.094444,769.4166667,188.9111111,4945.4,2991.6,1127.616667,343.85,3168.75,964.45,111.0333333,180,21.10486085,11.52940028,0.837595307,0.869565217,0.535714286,-1.159321417
+228,35455.10236,1058.937008,590.8031496,1126.826772,30831.16535,777.3228346,593.1417323,1712.228346,15685.48819,637.2598425,639.7637795,1787.559055,21266.47244,1366.590551,4655.874016,3029.055118,8007.283465,1376.393701,417.5275591,2478.685039,13565.59055,376.7952756,523.5905512,539.6220472,15757.6063,410.2204724,120.8818898,4152.866142,12767.58268,1593.377953,792.4251969,2842.559055,10164.86614,651.3307087,271.2755906,1681.96063,7012.606299,879.3228346,433.5354331,1344.653543,5981.622047,734.8425197,170.3937008,4894.92126,4453.220472,1255.866142,398.8818898,3300.275591,344.992126,110.3385827,127,14.63231803,11.59949371,0.609571479,0.969465649,0.697802198,0.192089356
+229,36519.12346,815.2469136,468.1851852,1100.654321,32741.67901,668.5679012,640.5925926,1576.925926,17377.18519,577.6666667,779.1358025,1772.530864,24178.04938,1240.790123,4016.530864,3126.17284,8635.592593,1274.728395,396.4320988,2528.246914,16355.40741,418.7160494,125.8518519,646.2716049,19803.8642,730.308642,117.5925926,3127.901235,16585.82716,1489.234568,894.3950617,2815.987654,13434.16049,585.9382716,284.962963,2429.012346,10005.98765,966.9012346,448.4197531,1317.555556,7678.679012,645.5308642,169.5061728,3544.148148,6064.518519,1269.555556,167.382716,3179.444444,420.5679012,108.9506173,81,14.62031065,7.588841737,0.854736838,0.861702128,0.642857143,-1.331946667
+230,14734.03788,741.4621212,601.6060606,1132.181818,12840.98485,606.9772727,488.7121212,1683.818182,7103.977273,510.8409091,553.8257576,1838.712121,9746.333333,1142.007576,6166.378788,3024.659091,3604.371212,1138.44697,368.5757576,3014.689394,6559.492424,982.9318182,513.7121212,500.8181818,7865.371212,377.9924242,104.9393939,7570.204545,6814.037879,1397.007576,960.2045455,2826.727273,5453.909091,560.7424242,283.5606061,39645.69697,4286.378788,843.469697,383.1893939,1395.598485,3191.454545,915.9621212,153.5378788,5558.090909,2714.212121,1191.666667,228.0833333,3211.5,594.9393939,112.0606061,132,15.66066091,10.88599782,0.718896242,0.956521739,0.647058824,-0.348359802
+231,20892.40217,719.5434783,507.1956522,1080.141304,18203.68478,573.7282609,391.1956522,1626.402174,10404.15217,494.8804348,416.5,1817.456522,14107.48913,1115.369565,5700.5,3929.76087,5278.108696,1102.891304,353.5652174,2812.23913,9010.413043,1467.282609,125.3043478,427.4673913,10797.13043,369.0652174,111.9347826,6885.315217,9380.847826,1285.847826,971.6956522,2791.086957,7542.413043,532.7391304,239.3804348,13134.90217,5898.304348,752.0108696,369.9891304,1307.608696,4230.75,615.6956522,149.2608696,3855.369565,3527.804348,1115.445652,160.3695652,3123.706522,736.4456522,109.6847826,92,14.12649163,9.665085554,0.729311694,0.884615385,0.544378698,0.901853126
+232,18953.796,732.408,580.008,1092.112,16623.196,584.248,947.868,1604.712,8533.772,483.44,840.568,1786.608,12490.296,1122.132,4266.028,2925.076,4723.56,1169.176,371.424,3978.376,8466.816,562.108,108.008,592.024,10636.736,422.108,115.352,4367.468,8722.252,1564.484,776.168,2828.096,7018.212,536.372,260.22,13550.924,5359.292,834.148,388.064,1344.668,3491.568,724.94,150.836,3892.688,3051.164,1128.74,264.528,3198.784,911.34,113.656,250,20.23903267,16.42676416,0.584160992,0.925925926,0.598086124,-0.090583792
+233,46411.41322,1036.446281,628.8595041,1176.512397,39906.18182,776.6446281,742.677686,1758.057851,21103.7686,657.7272727,740.9256198,1820,30141.02479,1458.297521,5175.677686,3508.140496,11282.42149,1523.190083,472.661157,2448.77686,20057.44628,400.6942149,384.4214876,578.7768595,24601.05785,449.8181818,135.6942149,4945.008264,19504.96694,1812.694215,806.5123967,2833.140496,15816.32231,655.0743802,308.8595041,1399.140496,10791.90083,1066.322314,481.5702479,1326.123967,9417.190083,748.214876,182.4793388,4922.14876,6745.239669,1384.876033,195.2561983,3298.77686,333.8595041,113.3553719,121,16.2356125,11.22507545,0.722485554,0.790849673,0.537777778,-1.018053128
+234,30458.43382,821.5294118,545.0073529,1117.669118,27153.73529,661.4852941,487.9632353,1601.191176,14585.27941,569.9411765,539.6102941,1784.764706,20103.72059,1247.875,6110.654412,4576.852941,7224.757353,1282.536765,400.3676471,2475.014706,14129.05147,591.2279412,156.4558824,511.6544118,16694.92647,437.4926471,124.4411765,5267.080882,13861.03676,1422.830882,1196.911765,2803.102941,11351.58088,618.5367647,288.7426471,4577.544118,8529.205882,844.9926471,436.6029412,1323.308824,6731.176471,678.375,177.0882353,5643.272059,5242.433824,1288.566176,240.0441176,3235.595588,408.5441176,113.4264706,136,16.48254595,10.70331598,0.760470281,0.900662252,0.666666667,0.194657838
+235,28057.32353,865.2058824,662.0588235,1176.794118,24285.48529,683.3088235,958.1617647,1838.220588,13791.14706,592.5147059,849.5588235,1888.279412,18826.04412,1295.411765,3021.720588,2547.558824,6731.661765,1328.544118,403.4411765,4456.573529,13110.51471,605.4705882,121.4117647,701.8823529,15326.94118,455.3970588,123.8676471,1845.720588,13264.63235,1719.779412,823.2058824,2864.205882,10332.66176,602.3676471,284.1029412,3221.117647,8034.573529,1149.897059,453.0147059,1320.441176,6172.867647,630.3382353,178.5441176,3574.088235,4940.411765,1308.455882,171.0882353,3251.470588,499.0441176,109.2647059,68,11.03473995,9.53753732,0.502943699,0.790697674,0.475524476,-0.336458143
+236,15935.91892,695.6486486,492.6756757,1061.581081,13525.68919,567.2972973,517.4459459,1538.148649,7772.986486,470.1351351,401.1081081,1752.621622,10817.06757,1078,4158.013514,2946.094595,4135.621622,1081.148649,339.027027,2649.72973,7034.608108,1018.567568,110.2837838,463.7432432,8436.189189,357.6486486,106.6756757,4964.243243,7292.081081,1246.702703,992.6081081,2779.513514,5957.108108,524.7027027,250.472973,15501.7973,4670.959459,726.7432432,364.0135135,1316.77027,3457.716216,664.2027027,146.7027027,4347.810811,2853.121622,1120.337838,141.4054054,3083.040541,696.7972973,110.1891892,74,11.15253868,8.524145492,0.644833194,0.961038961,0.747474747,0.543189458
+237,23048.6051,743.1847134,469.7133758,1080.585987,20200.78981,601.8853503,761.2038217,1561.318471,11359.66879,514.5159236,1202.318471,1760.687898,15943.54777,1172.146497,4973.197452,3104.649682,5946.076433,1154.713376,371.8853503,4787.605096,10428.75796,529.4012739,395.5859873,623.0636943,12822.49682,398.3821656,112.8535032,3697.987261,10947.38217,1624.305732,680.7898089,2811.242038,8683.821656,546.2356688,270.7388535,19136.35669,6854.764331,1081.66242,386.7515924,1345.254777,4989.273885,699.477707,163.2611465,3857.356688,4216.121019,1176.898089,247.8917197,3161.375796,785.8089172,113.0254777,157,18.65429127,11.71894438,0.77803811,0.857923497,0.577205882,0.897205986
+238,16781.36025,720.3975155,479.5776398,1075.714286,14306.69565,580.0745342,443,1537.099379,8269.291925,481.0869565,448.0310559,1789.124224,11661.68944,1131.428571,3217.42236,1727.57764,4557.26087,1131.68323,356.8322981,2898.906832,7815.670807,460.9937888,183,488.6335404,9589.701863,371.6335404,108.9130435,2692.826087,8297.043478,1300.639752,695.3478261,2831.850932,6822.149068,538.4906832,255.7826087,14718.80745,5439.15528,760.1490683,381.8136646,1338.335404,3807.024845,949.5465839,156.3229814,2504.161491,3282.906832,1156.006211,180.4720497,3129.950311,813.6459627,111.4037267,161,15.54907929,13.40706444,0.506497052,0.914772727,0.71875,-1.490357077
+239,21963.13699,724.739726,454.4657534,1070.041096,19443.28767,607.1369863,689.9589041,1631.739726,10787.64384,518.8219178,929.1369863,1813.986301,14902.23288,1136.041096,4785.712329,3024.191781,5451.863014,1152.383562,354.7534247,5074.945205,9594.109589,1861.616438,130.3424658,595.0958904,11575.08219,376.5753425,102.7534247,4189.575342,9601.219178,1516.39726,757.6438356,2792.821918,7566.712329,541.8630137,269.4657534,20771.73973,5966.465753,917.8356164,379.5342466,1406.09589,4451.164384,661.5068493,151.4520548,4680.986301,3601.342466,1152.753425,202.739726,3149.821918,658.5342466,113.5479452,73,13.39133446,7.283884441,0.839133698,0.924050633,0.651785714,0.013245557
+240,25183.93571,758.1,452.9071429,1081.678571,21216.39286,629.3642857,698.0357143,1657.535714,12558.07857,525.8214286,1001.071429,1819.521429,17581.1,1203.414286,4835.014286,3045.078571,6375.714286,1251.014286,358.0571429,4160.921429,11376.85,3787.764286,286.0928571,1008.592857,13796.85,397.0642857,111.0285714,3870.785714,11774.02143,1643.314286,804.7714286,2787.371429,9267.457143,542.9285714,258.9071429,11053.56429,7487.578571,1130.807143,383.7,1344.55,5509.9,705.6214286,520.0214286,4070.921429,4542.707143,1193.092857,219.0714286,3160.407143,669.5928571,117.6785714,140,25.29519084,8.374588263,0.943604679,0.809248555,0.374331551,0.707983451
+241,16001.17722,703.4746835,504.0822785,1075.177215,14166.08228,557.1455696,435.2025316,1540.272152,7733.234177,468.6329114,458.8417722,1800.981013,10991.8038,1104.310127,4762.189873,2961.841772,4229.240506,1083.886076,350.2405063,2798.917722,7362.088608,1824.778481,495.6582278,437.721519,8902.493671,374.1518987,108.0949367,5175.151899,7553.588608,1302.765823,784.2468354,2789.924051,6141.563291,543.0886076,249.9240506,20058.76582,4851.265823,756.6898734,373.6139241,1342.436709,3491.063291,759.6455696,150.8481013,3615.443038,2926.183544,1122.291139,181.3607595,3138.753165,799.8164557,115.6392405,158,19.12005604,11.12436288,0.81332013,0.877777778,0.580882353,0.799478723
+242,23187.66972,806.2110092,724.0550459,1145.183486,20228.11009,642.4678899,797.6330275,1681.055046,11584.49541,568.1009174,873.6238532,1827.513761,16203.81651,1243.486239,6992.12844,3723.550459,5897.550459,1258.623853,389.5229358,3968.522936,10992.76147,588.2018349,194.1559633,729.9816514,12800.90826,471.7431193,119.9908257,6610.192661,10977.97248,1525.614679,901.6422018,2831.018349,8745.137615,576.8715596,273.3302752,14344.70642,6907.87156,1121.825688,425.5045872,1355.119266,5192.220183,675.9082569,169.8990826,4692.853211,4285.357798,1254.137615,211.706422,3224.422018,518.9266055,114.1009174,109,12.29740379,11.53900238,0.345745489,0.981981982,0.598901099,0.138228888
+243,19367.25,694.75,424.8352273,1064.340909,16947.35795,556.2159091,510.2329545,1537.784091,9684.545455,482.2954545,458.6704545,1803.278409,13594.97159,1089.465909,4317.085227,2639.471591,5028,1088.119318,347.9090909,2868.869318,8567.079545,6433.8125,109.7443182,508.625,10382.56818,406.1988636,108.1931818,4727.25,8981.835227,1349.102273,842.2386364,2776.835227,7287.698864,532.6647727,229.0852273,8483.471591,5880.869318,741.7613636,374.8522727,1306.994318,4274.852273,603.0738636,141.4090909,2784.107955,3540.670455,1119.534091,151.0284091,3175.0625,717.3522727,115.7045455,176,18.96665024,12.3793208,0.757626087,0.936170213,0.651851852,1.176678634
+244,25677.76471,851.1764706,784.7529412,1129.247059,22834.74118,692.1647059,928.4823529,1767.682353,12986.54118,594.9411765,637.1764706,1874.258824,17946.61176,1297.517647,5119.552941,2512.058824,6248.364706,1329.717647,391.8823529,3575.858824,12272.54118,570.0705882,190.7529412,609.8,14618.43529,475.0235294,123.7764706,6465.152941,12390.78824,1645.905882,832.8235294,2828.082353,9802.847059,599.0352941,288,5417.835294,7775.270588,1099.494118,439.2823529,1340.623529,5783.447059,648.1411765,186.5058824,3334.164706,4757.682353,1302.482353,165.2941176,3291.588235,505.7529412,114.5411765,85,11.22867913,10.09228441,0.438368507,0.944444444,0.643939394,-1.048757739
+245,21259.99,745.945,516.69,1099.475,18511.16,611.17,600.77,1599.735,10637.59,521.15,773.02,1791.09,14533.385,1152.895,5622.015,3541.55,5449.9,1151.455,379.765,4491.765,9463.635,1837.63,983.255,660.795,11598.97,428.305,111.2,3664.295,9962.505,1505.87,848.89,2827.42,7865.18,576.815,252.15,13571.64,6332.685,1225.81,383.01,1394.48,4721.595,877.64,162.5,4960.81,3958.585,1198.605,257.305,3216.755,605.72,118.785,200,21.64605514,12.41669428,0.819118817,0.869565217,0.634920635,0.017042692
+246,30922.03279,989.3934426,561.9180328,1075.409836,28535.4918,724.8360656,623.6721311,1529.196721,15484.06557,611.6065574,659.3934426,1753.147541,21133.19672,1320.131148,5428.885246,3723.180328,7882.655738,1321.983607,410.6065574,2440.409836,14237.67213,380.1967213,592.852459,537.6393443,17523.54098,468.3934426,131.0491803,5183.42623,14566.98361,1631.278689,809.8196721,2838.04918,11733.7377,627.0983607,285.3770492,1836.721311,8463.196721,933.4262295,448.1967213,1315.672131,6892.622951,748.3770492,171.3114754,3687.819672,5539.213115,1304.147541,404.7377049,3191.42623,358.5901639,113.6721311,61,9.46946322,8.786383641,0.372916227,0.938461538,0.616161616,-1.417008906
+247,37659.89313,856.1679389,532.5572519,1112.221374,33005.52672,702.351145,854.1374046,1647.89313,18025.90076,596.5877863,1700.145038,1821.244275,24816.9771,1293.801527,5406.862595,5809.320611,8940.740458,1333.633588,405.7251908,2834.145038,16590.36641,401.4122137,133.9465649,1035.801527,19994.51908,1077.167939,151.0076336,3387.29771,16785.21374,1532.251908,1054.832061,2811.053435,13539.52672,604.2671756,289.9923664,3667.305344,10123.65649,1306.343511,444.351145,1346.312977,7717.083969,641.7251908,168.8320611,3413.671756,6169.862595,1305.78626,311.740458,3223.984733,422.0229008,117.8778626,131,16.70909652,11.26544126,0.73853962,0.744318182,0.51984127,1.485880811
+248,26954.0625,792.775,532.9625,1124.7125,22960.03125,634.70625,787.78125,1759.8875,13157.275,538.2875,920.4625,1885.55,17909.625,1200.79375,5609.3625,3700.0875,6586.025,1207.05625,382.4875,3561.33125,11586.8,812.15625,118.24375,735.8125,13843.26875,384.16875,111.6625,6320.26875,11932.05,1594.54375,1050.88125,2810.0125,9646.41875,558.73125,266.51875,16844.475,7531.1125,990.925,394.21875,1331.875,5429.65,629.4875,156.7625,4517.36875,4551.48125,1207.43125,186.06875,3195.40625,746.1625,118.4125,160,15.97889764,13.20340222,0.563226656,0.930232558,0.588235294,0.889235299
+249,22340.65385,782.2820513,549.1730769,1113.192308,19068.86538,617.8076923,543.7820513,1837.903846,10899,520.525641,514.5833333,1910.564103,14937.51923,1197.108974,4984.307692,3238.794872,5549.147436,1186.102564,371.3782051,2935.038462,9638.724359,994.9807692,111.5512821,535.7435897,11601.58974,392.8076923,112.8910256,5982.647436,10125.19872,1393.083333,815.6666667,2800.333333,8053.775641,548.9294872,267.1089744,23779.98077,6272.089744,844.0641026,395.8076923,1334.807692,4589.115385,671.4230769,156.5961538,5074.160256,3814.294872,1199.025641,200.1410256,3200.692308,759.6538462,119.9807692,156,17.48095385,11.51502234,0.752389754,0.962962963,0.666666667,0.214613592
+250,20054.27404,710.0240385,429.9615385,1058.389423,17607.22115,578.5,529.6730769,1517.072115,10040.98077,471.9326923,470.9711538,1768.149038,14023.90385,1114.894231,3368.471154,1997.110577,5308.4375,1135.370192,365.2788462,3235,8994.836538,1617.288462,124.2067308,536.0384615,11095.54808,380.9615385,110.0528846,3483.774038,9663.783654,1360.403846,720.6538462,2823.682692,7637.956731,547.0192308,242.0384615,9191.052885,6076.096154,801.4230769,386.2259615,1333.552885,4435.394231,606.7403846,147.8365385,2376.490385,3705.985577,1147.576923,175.7451923,3115.211538,776.7788462,120.3557692,208,21.91237721,13.61424713,0.783569631,0.866666667,0.531969309,1.294026362
+251,25909.73973,791.2328767,531.5616438,1118.917808,22851.30137,670.6986301,641.5205479,1585.452055,13030.32877,561.1506849,769.4931507,1753.506849,17382.05479,1228.986301,8917.191781,5422.493151,6582.232877,1259.109589,380.5205479,2662.986301,11776.28767,432.5479452,122.369863,761.1232877,14484.34247,485.7808219,138.3972603,4112.931507,11998.61644,1506.041096,853.7945205,2803.794521,9674.849315,623.6849315,271.8082192,9019.041096,7463.438356,991.5479452,424.109589,1333.205479,5602.342466,639.5753425,166.5890411,5253.547945,4636.547945,1248.383562,496.5068493,3205.726027,453.0684932,116.3013699,73,13.25680717,7.375639286,0.83093722,0.869047619,0.608333333,-1.033203415
+252,25589.06061,757.9090909,514.4242424,1080.626263,22959.68687,647.3737374,1020.666667,1567.585859,13009.53535,566.3434343,3194.848485,1851.393939,17275.43434,1203.40404,5798.616162,4173.515152,6380.060606,1206.242424,372.9191919,5966.212121,11567.81818,787.7070707,125.7979798,1015.606061,14325.75758,398.2323232,118.020202,3470.767677,11676.39394,2354.676768,1041.222222,2851.080808,9399.212121,780.8585859,261.6666667,5302.777778,7274.464646,1333.454545,418.3737374,1327.727273,5379,643.1717172,160.8989899,4592.89899,4527.767677,1193.383838,324.4949495,3105.656566,473.7272727,117.6060606,99,12.41777234,10.43036443,0.542656749,0.970588235,0.589285714,-1.529333192
+253,18197.11712,746.4594595,622.6756757,1106.585586,16162.88288,598.6396396,663.7027027,1721,9106.711712,527.6936937,967.6216216,1902.189189,12086.74775,1169,5836.144144,4015.342342,4353.189189,1177.981982,364.1081081,4574.495495,8430.288288,3126.936937,124.0630631,606.2072072,9964.495495,428.2162162,116.1711712,4495.945946,8202.648649,1598.585586,1143.990991,2808.756757,6536.648649,566.2882883,256.7657658,12767.84685,5115.702703,1200.702703,406.1171171,1317.90991,3910.171171,620.7027027,175.2252252,5393.324324,3150.189189,1181.918919,313.1621622,3189.774775,490.2972973,116.6036036,111,15.76345547,9.095073077,0.816763897,0.940677966,0.69375,1.546368339
+254,21322.86992,711.1788618,437.8943089,1081.146341,18161.74797,574.4146341,688.5934959,1592.894309,10135.99187,484.6666667,1036.910569,1762.95935,14589.90244,1118.99187,5911.01626,3773.186992,5400.382114,1172.617886,369.8130081,6236.837398,9232.97561,535.796748,97.77235772,660.6910569,11526.52033,367.5203252,108.8699187,4385.520325,10023.3252,1726.211382,759.2845528,2793.276423,8116.268293,532.5772358,249.0406504,11611.69919,6312.894309,898.6585366,383.5934959,1346.772358,4272.650407,683.4552846,158.0243902,3473.99187,3620.682927,1132.333333,278.7235772,3141.138211,852.601626,118.1544715,123,14.33700436,11.21776432,0.622733112,0.904411765,0.675824176,0.930558515
+255,16421.39922,756.7751938,759.4922481,1135.666667,13957.96899,592.6744186,645.2093023,1663.899225,7446.069767,473.4379845,619.3527132,1807.755814,10773.26357,1127.22093,2597.05814,1844.352713,4098.282946,1799.841085,389.9418605,3120.046512,7211.585271,467,254.2209302,655.1744186,9085.44186,497.7635659,127.1046512,3066.817829,7650.193798,1446.891473,703.0775194,2850.620155,6274.251938,547.7209302,270.0465116,12207,4802.748062,897.9108527,406.7209302,1326.872093,3193.573643,632.1007752,155.6976744,2874.437984,2823.864341,1146.465116,183.6434109,3306.596899,898.8023256,122.7945736,258,24.30580945,15.50958991,0.769951695,0.788990826,0.586363636,0.250156313
+256,37080.225,889.375,487.9,1110.05,34057.85,707.725,556.45,1646.375,18403,625.825,487.075,1793.75,25621.175,1332.65,4867.525,2325.75,9388.05,1403.125,435.3,2442.625,18187.375,390,299.75,474.875,21719.55,428.2,137.575,3809.625,17267.825,1600.775,894.95,2815.325,14110.825,636.55,301.275,1356.8,10251.1,901.45,470.3,1333.05,8838.125,711.1,183.775,3668.65,6566.25,1386.6,163.775,3251.55,351.275,117,40,8.975162566,6.405970411,0.700406444,0.888888889,0.5,-1.257067963
+257,23130.1369,737.2916667,452.8869048,1083.041667,20462.43452,600.3869048,610.0535714,1609.886905,11663.70238,492.4642857,1015.64881,1810.345238,16536.07738,1181.10119,5473.285714,3113.761905,6053.678571,1149.916667,368.6190476,4687.470238,10639.02381,2542.416667,262.2738095,514.3452381,13199.30357,403.1845238,110.375,4830.041667,11393.02381,1528.565476,816.9345238,2800.863095,9168.565476,561.8869048,259.0297619,13032.03571,7146.904762,919.2380952,389.1964286,1343.982143,5005.755952,838.1785714,198.5714286,3310.130952,4185.178571,1162.821429,220.2559524,3202.35119,836.5892857,118.3214286,168,19.7289099,11.01682597,0.829564926,0.954545455,0.736842105,-1.314852172
+258,23174.48148,771.0802469,527.7716049,1091.432099,19680.9321,605.308642,912.845679,1682.179012,8359.432099,482.3333333,919.9691358,1829.858025,14010.99383,1147.425926,5952.438272,3325.864198,5143.851852,1141.222222,408.0123457,3155.160494,9294.290123,2024.222222,1202.419753,789.6790123,11559.56173,1130.62963,119.1358025,7535.938272,9091.746914,1514.061728,750.4074074,2786.024691,7168.580247,582.9320988,250.3641975,10026.56173,5225.703704,1014.111111,373.1604938,1333.160494,3030.296296,983.6790123,146.0123457,4035.95679,2897.549383,1085.203704,223.0864198,3149.845679,980.5308642,118.7592593,162,17.30538013,12.17875281,0.710442462,0.931034483,0.680672269,-1.088009659
+259,28645.46154,848.4230769,450.1153846,1070.875,26144.36538,696.9423077,792.9807692,1514.865385,13745.39423,581.7884615,1227.605769,1720.009615,18802.65385,1295.730769,2293.721154,2855.673077,6650.317308,1293.673077,416.0480769,2475.730769,12779.61538,377.3942308,769.3461538,604.3076923,15648.74038,1054.298077,126.2980769,1456.634615,12501.51923,1582.451923,798.5288462,2816.230769,10003.55769,847.4230769,285.6923077,1665.076923,7548.307692,1120.528846,461.5769231,1371.413462,6257.605769,835.4038462,185.2307692,3333.182692,4822.778846,1326.567308,1163.740385,3183.019231,384.3942308,118.4326923,104,12.18910291,11.30440956,0.374023263,0.971962617,0.666666667,-1.072174477
+260,30440.98643,902.8597285,516.6289593,1101.552036,27603.61538,702.479638,595.0950226,1580.778281,15056.02262,618.8823529,608.638009,1800.533937,21159.1086,1310.692308,5084.764706,3657.158371,7553.484163,1348.162896,444.2126697,2449.276018,14055.02715,429.7330317,1302.434389,597.8552036,17061.40724,453.0045249,127.5701357,3259.067873,14124.57466,1672.457014,876.1719457,2807.429864,11295.72851,734.2443439,277.5067873,2130.058824,8431.488688,977.9547511,444.7873303,1348.529412,6845.728507,992.3031674,173.918552,5443.904977,5410.447964,1330.452489,357.7873303,3261.837104,371.5158371,123.7737557,221,18.04045682,16.14525153,0.446172594,0.932489451,0.612188366,0.443391505
+261,20446.58282,718.3496933,469,1090.852761,18238.5092,581.6687117,615.1717791,1588.601227,9857.417178,507.6932515,618.6441718,1785.96319,14109.92025,1104.858896,4125.361963,3285.184049,5124.521472,1123.472393,358.0184049,3143.184049,9119.546012,931.607362,164.1533742,831.5276074,11005.17178,371.9570552,108.2760736,4576.453988,9235.993865,1463.276074,868.398773,2786.656442,7311.288344,536.196319,243.2453988,13033.41104,5891.846626,824.1533742,369.8527607,1332.815951,4474.116564,635.4969325,150.0368098,4197.417178,3572.680982,1129.91411,192.0490798,3119.779141,695.3496933,120.8404908,163,16.52355177,13.51735956,0.575124036,0.900552486,0.646825397,-1.354428501
+262,24166.70732,770.3414634,520.6341463,1089.585366,20699.84146,616.3902439,1094.121951,1634.634146,9656.02439,492.3414634,751.2682927,1778.536585,14545.5,1146.585366,5154.365854,3891.585366,5395.426829,1165.902439,373.2439024,4386.585366,9824.512195,1495.378049,134.8902439,699.902439,12401.52439,413.0853659,120.3658537,6693.329268,9902.853659,1794.829268,847.6219512,2802.317073,7948.95122,555.7926829,260.9146341,16307.59756,6162.146341,953.0243902,407.6463415,1359.073171,3955.926829,658.195122,179.1463415,3612.146341,3498.243902,1165.939024,270.097561,3248.182927,923.2439024,119.3658537,82,12.68484892,8.650461217,0.731396701,0.931818182,0.573426573,-1.208140935
+263,29641.31159,865.057971,508.8768116,1155.108696,24681.16667,680.8333333,894.6666667,1831.565217,12315.75362,543.8115942,726.9710145,1849.123188,19594.0942,1317.942029,4841.768116,3301.65942,6985.173913,1265.891304,406.5507246,3521.014493,12685.77536,8727.615942,188.7753623,550.7318841,15763.43478,522.9565217,125.5434783,5338.724638,12805.57246,1589.818841,841.173913,2802.210145,10259.06522,618.9637681,279.173913,11815.16667,7759.224638,910.884058,419.884058,1330.036232,4823.210145,676.2536232,168.7173913,4211.42029,4285.050725,1255.021739,234.9855072,3260.57971,944.6376812,122.9565217,138,19.2806368,9.722766929,0.863542401,0.846625767,0.511111111,0.491497731
+264,13138.15663,656.8493976,412.4698795,1024.36747,11514,537.4819277,385.2590361,1410.524096,6478.186747,462.686747,381.5120482,1736.674699,8850.518072,1042.903614,4227.222892,1950.198795,3279.795181,1060.572289,364.7710843,2579.253012,5960.722892,1186.927711,1428.174699,451.7349398,6835.463855,329.7048193,102.3795181,4312.259036,6051.246988,1311.536145,705.1746988,2797.096386,4775.981928,602.6807229,229.373494,13360.3253,3756.036145,701.3915663,349.5060241,1351.656627,2867.668675,1047.343373,140.1626506,3071.951807,2360.072289,1078.024096,150.9096386,3056.018072,626.8674699,123.0722892,166,16.95525108,12.79158713,0.656377999,0.948571429,0.650980392,0.426051961
+265,31957.95652,768.2826087,440.2173913,1089.173913,25922.34783,630.3369565,905.3152174,1640.73913,13217.67391,500.3695652,1247.23913,1769.163043,21395.34783,1222.663043,4176.206522,2697.98913,7684.456522,1206.782609,381,7220.076087,13721.40217,2486.315217,289.9347826,857.576087,17434.69565,444.75,122.4130435,3358.315217,14125.6413,1764.01087,716.4456522,2820.358696,11506.01087,575.7173913,256.7065217,9625.891304,8680.391304,1144.619565,410.7934783,1376.576087,5251.184783,643.1413043,166.826087,4819.01087,4894.48913,1198.902174,360.9565217,3214.51087,953.4891304,120.9891304,92,13.76924739,8.726005725,0.773553097,0.948453608,0.696969697,0.817612656
+266,16047.84034,747.1764706,413.0588235,1053.184874,14263.15126,592.2689076,387.8907563,1432.512605,6917.890756,498.7647059,397.2268908,1703.747899,9792.302521,1174.806723,1913.848739,1238.571429,3696.016807,1180.268908,382.2773109,2389.747899,6959.436975,311.2773109,734.8739496,417.9159664,8114.764706,358.8739496,115.9831933,1502.798319,6751.571429,1342.327731,715.5378151,2813.134454,5438.352941,768.8403361,238.210084,1152.420168,3688.537815,724.7647059,399.2521008,1308.067227,3207.109244,721.5798319,158.512605,2524.411765,2454.680672,1178.319328,2301.117647,2997.218487,314.7815126,123.8571429,119,13.92318272,11.09224314,0.604408729,0.944444444,0.61025641,0.398283614
+267,27857.13253,776.746988,526.0481928,1092.53012,24373.3012,637.253012,613.3493976,1615.927711,14024.27711,559.9879518,572.0481928,1790.228916,19564.08434,1223.120482,4658.46988,2958.638554,7008.144578,1233.180723,386.2409639,3166.325301,13021.6747,3792.024096,269.8795181,667.6144578,15757.81928,434.2891566,122.0361446,4609.879518,12894.75904,1467.626506,876.4096386,2920.795181,10192.0241,582.6746988,270.2650602,6747.228916,8129.891566,962.626506,434.4096386,1324.855422,6115.831325,653.939759,165.5783133,2690.373494,4917.60241,1226.096386,178.8915663,3202.192771,512.4698795,122.4457831,83,11.58917484,9.66377335,0.551972865,0.922222222,0.532051282,0.700593738
+268,21683.05634,736.6103286,505.600939,1084.234742,19097.9108,599.1455399,621.5446009,1635.460094,10987.23474,528.2018779,738.629108,1837.262911,14837.12676,1162.333333,6870.971831,3857.971831,5508.610329,1179.497653,370.5539906,3626.962441,9784.478873,2819.248826,136.7887324,541.1126761,11764.28169,460.5915493,114.943662,6974.807512,10047.50235,1631.464789,1095.173709,2799.596244,8056.014085,579.1408451,269.4131455,16302.30516,6311.638498,994.8450704,400.1549296,1328.244131,4680.511737,670.0375587,215.8779343,3631.544601,3909.403756,1179.671362,204.9577465,3158.042254,536.713615,124.7558685,213,18.26701144,16.38199248,0.442421005,0.858870968,0.659442724,-0.83159728
+269,22534.10828,749.9745223,508.656051,1099.057325,19908.57962,608.4585987,616.2229299,1680.057325,11365.92994,541.0318471,618.4203822,1830.974522,15622.24841,1166.993631,5103.299363,3959.012739,5716.375796,1173.426752,358.5987261,3563.847134,10381.91083,1497.382166,135.1719745,571.8216561,12339.26752,393.9745223,111.2802548,6320.433121,10432.15287,1448.312102,1140.414013,2809.324841,8407.197452,548.522293,267.5350318,15568.95541,6667.019108,874.6242038,402.2929936,1337.961783,5004.184713,664.8917197,158.1910828,3887.579618,4147.216561,1199.025478,193.2038217,3208.847134,579.4076433,123.4522293,157,15.78830693,13.43380823,0.525375107,0.839572193,0.697777778,-0.570775031
+270,20960.05155,739.4742268,495.1340206,1111.42268,18235.69072,596.3298969,708.8453608,1661.28866,10449.69072,523.0412371,1455.57732,1821.505155,14284.91753,1147.886598,4919.268041,3851.391753,5448.371134,1151.793814,350.2061856,7114.020619,9612.350515,1473.525773,131.7628866,519.5463918,11692.71134,379.8762887,111.5979381,3561.020619,9752.701031,1618.969072,801.7835052,2787.56701,7792.134021,550.1134021,276.8041237,23590.58763,6285.608247,1037.886598,388.3298969,1472.670103,4747.268041,664.5154639,172.3195876,5202.42268,3853.278351,1198.092784,305.7835052,3205.185567,589.5257732,125.3402062,97,16.51629637,7.898126994,0.878249843,0.889908257,0.673611111,-0.001842684
+271,37632.70238,1033.714286,607.2738095,1121.047619,32159.67857,763.2261905,837.7738095,1559.02381,17684.20238,664.6190476,2082.678571,1796.952381,23815.03571,1386.535714,4762.571429,3197.142857,8839.178571,1360.809524,430.8571429,2822.761905,16217.71429,435.3928571,751.8809524,1030.035714,19979.65476,424.4404762,134.9285714,4113.142857,16426.34524,2005.238095,828.6785714,2825.02381,13527.72619,742.8928571,334.8095238,4782.428571,10256.27381,1006.416667,465.452381,1372.904762,7954.107143,836.3690476,183.7142857,4567.190476,6557.928571,1357.928571,540.0357143,3328.678571,400.0833333,123.4285714,84,11.44740792,9.532016901,0.553755883,0.933333333,0.7,0.737557167
+272,16662.59259,694.2839506,462.2098765,1067.654321,15046.22222,578.6296296,417.5185185,1544.691358,8653.283951,518.1604938,443.0493827,1806.728395,11685.22222,1104.901235,4626.493827,3234.641975,4417.740741,1128.54321,354.8395062,2527.049383,7825.234568,1987.604938,215.8271605,488.5432099,9424.432099,367.1481481,110.3703704,6152.728395,7967.975309,1350.753086,988.9753086,2797.234568,6386.950617,541.9259259,266.8888889,26026.41975,5051.382716,746.0493827,386.1975309,1325.246914,3818.814815,692.8518519,148.5802469,3703.111111,3197.567901,1133.024691,187.7407407,3060.395062,547.962963,123.5061728,81,13.35140422,8.179402974,0.790373775,0.964285714,0.578571429,-0.47561455
+273,15281.46457,693.1732283,493.7559055,1061.338583,13224.16535,573.4645669,427.2519685,1576.692913,7619.858268,475.9606299,369.5826772,1786.267717,10242.48031,1086.519685,4485.629921,2773.362205,3742.181102,1075.606299,352.7244094,2573.787402,6962.834646,4661.889764,909.976378,433.0866142,7977.76378,380.9370079,106.4488189,5081.637795,6907.685039,1299.299213,908.2598425,2776.897638,5602.299213,622.984252,236.2440945,16413.14173,4336.354331,734.0866142,359.3149606,1334.968504,3233.393701,899.1338583,140.3622047,4446.818898,2677.314961,1109.543307,150.8740157,3062.086614,644.2519685,126.3779528,127,15.99526266,10.42708999,0.758316863,0.940740741,0.721590909,-0.028354406
+274,28791.75168,861.2281879,576.1006711,1155.657718,25187.75168,682.4026846,698.8926174,1865.724832,14792.34899,578.409396,660.5436242,1884.95302,20268.57047,1301.255034,5387.449664,3226.395973,7255.201342,1278.006711,398.8926174,3717.812081,13476.21477,2846.90604,125.0134228,614.6778523,15959.91946,429.6577181,118.5369128,5822.308725,13645.65772,1533.006711,955.5369128,2800.590604,10828.8255,580.7785235,288.7114094,25904.55705,8604.805369,916.2550336,411.6107383,1357.449664,6515.52349,739.2684564,228.852349,4276.684564,5383.107383,1300.946309,172.3959732,3188.362416,662.7852349,125.9530201,149,14.95349849,13.20344629,0.469434987,0.914110429,0.547794118,0.229115931
+275,21176.82727,729.95,583.1909091,1082.713636,19051.68182,586.0863636,610.3045455,1642.827273,10417.95909,498.7954545,420.7090909,1804.804545,14620.18182,1133.313636,5247.563636,3614.409091,5404.527273,1122.040909,384.5909091,2654.854545,9501.65,1748.340909,689.1909091,459.2954545,11139.45,386.1636364,113.9772727,7339.904545,9762.072727,1342.695455,957.9954545,2791.804545,7755.759091,613.5363636,249.1272727,12018.62273,6221.213636,801.3954545,380.4409091,1324.631818,4668.190909,784.5954545,148.2727273,3970.459091,3787.627273,1151.309091,169.5227273,3149.109091,736.6,128.4227273,220,19.0436464,16.05876691,0.537504098,0.88,0.611111111,-0.213864311
+276,34435.44444,1054.7,675.6222222,1156.755556,31022.32222,763.0555556,1040.5,1699.222222,16641.91111,656.3777778,1571.377778,1874.688889,23066.37778,1383.133333,5306.4,4434.566667,8519.544444,1401.222222,443.8222222,2454.277778,15897.03333,394.2666667,772.7111111,1307.5,18834.75556,475.5666667,131.3666667,4305.188889,15267.12222,2380.722222,858.5222222,2808.433333,12482.17778,678.1333333,294.1666667,1597.3,8559.877778,1095.9,472.7222222,1332.333333,7240.022222,841.3555556,185.7333333,6177.844444,5253.444444,1325.955556,246.9,3268.244444,332.3,122.8,90,13.69699624,8.682105766,0.773440158,0.918367347,0.692307692,1.408944244
+277,28924.43077,920.5230769,542.7538462,1089.738462,25810.53846,711.3230769,539.5538462,1560.615385,13787.81538,592.7538462,729.1846154,1766.353846,19133.49231,1300.476923,3731.4,3325.523077,7132.6,1332.461538,408.8461538,2470.461538,13630.66154,359.4,491.6615385,724.8153846,16069.50769,437.5384615,129.6769231,3015.569231,13076.23077,1815,1122.738462,2819.384615,10657.13846,634.7538462,282.3230769,1567.969231,8062.892308,1028.707692,456.3076923,1331.276923,6818.092308,1014.461538,176.5692308,5432.784615,5010.015385,1305.4,287.4,3237.969231,352.7692308,123,65,12.52679289,7.686932249,0.789586491,0.902777778,0.5,-1.265306497
+278,25853.82443,873.9847328,507.2900763,1092.519084,23780.03053,692.0152672,565.6030534,1551.450382,12505.12214,577.8625954,610.8549618,1712.954198,17210.93893,1351.847328,3778.832061,2362.648855,6393.465649,1357.931298,436.9389313,2505.206107,12321.64885,400.5267176,251.0381679,587.740458,14487.0229,491.3435115,128.2061069,2557.992366,11841.60305,1792.137405,805.129771,2853.335878,9730.038168,827.4198473,291.8320611,2487.396947,7537.801527,1117.51145,459.8549618,1325.694656,6175.80916,709.0610687,179.0610687,3614.625954,4767.648855,1365.78626,744.0381679,3210.656489,392.0076336,127.6183206,131,18.1316551,11.2063839,0.786133827,0.779761905,0.436666667,0.529761625
+279,18500.52326,722.872093,486.6046512,1078.825581,16448.25581,579.3372093,775.6744186,1669.77907,9058.651163,494.5116279,777.0348837,1833.174419,12711.72093,1133.523256,5071.325581,3472.383721,4783.453488,1125.744186,365.5348837,4127.72093,8160.593023,844.8372093,102.8372093,581.5930233,9881.383721,361.4069767,103.8488372,3712.011628,8425.360465,1530.383721,750.2325581,2778.325581,6858.011628,529.4767442,255.2325581,21880.72093,5516.244186,969.872093,374.1976744,1371.77907,4059.523256,603.6627907,149.6511628,5305.313953,3303.162791,1154.732558,227.4186047,3194.162791,704.8953488,125.1627907,86,13.98252836,8.010538529,0.819627872,0.924731183,0.601398601,-0.569332896
+280,19288.63889,751.1759259,522.8981481,1089.472222,16472.67593,598.1759259,550.3240741,1638.407407,9334.12963,493.4907407,431.9444444,1821.685185,12993.97222,1148.268519,4248.759259,3073.407407,4883.074074,1143.787037,364.0925926,2530.435185,8527.240741,1763.472222,131.0925926,448.2314815,10440.23148,382.4722222,114.0833333,4997.009259,8822.277778,1299.805556,831.3425926,2793.601852,7119.324074,597.8796296,276.6203704,24435.77778,5582.425926,780.25,386.5925926,1320.962963,3946.916667,940.0555556,151.8888889,4237.916667,3400.592593,1169.12963,188.7962963,3199.694444,813.3518519,123.1203704,108,13.85066865,10.08950988,0.685099713,0.955752212,0.771428571,-1.428070219
+281,29175.57627,834.7033898,569.1525424,1129.338983,25368.39831,680.4322034,941.4152542,1715.305085,13215.00847,535.5932203,1155.90678,1807.322034,19894.4661,1262.720339,4575.644068,4124.016949,7123.194915,1253.728814,402.0932203,4061.271186,13264.78814,833.8983051,528.1186441,854.3559322,16340.63559,430.5508475,124.3135593,4666.364407,13177.77966,1737.237288,935.720339,2792.101695,10635.13559,588.7033898,293.0084746,26762.22034,8018.822034,1194.372881,407.4237288,1359.652542,5051.169492,763.5847458,171.3389831,3873.550847,4506.932203,1234.262712,274.0084746,3260.805085,927.5084746,127.5084746,118,17.12191209,9.056725069,0.848649726,0.936507937,0.614583333,-0.520092431
+282,23427.25882,763.6509804,511.7647059,1102.611765,20165.21961,610.5647059,660.5647059,1688.32549,8865.278431,483.572549,749.2352941,1807.882353,14480.0549,1163.639216,4827.682353,3173.039216,5321.901961,1164.286275,366.2117647,4258.560784,9527.545098,1117.788235,167.2509804,639.3647059,11965.08627,433.1294118,117.1372549,6183.152941,9439.580392,1537.290196,875.0901961,2796.611765,7565.066667,548.9098039,251.8980392,12301.12157,5633.890196,907.054902,389.3058824,1332.556863,3382.909804,605.3137255,154.8431373,5016.623529,3112.960784,1132.713725,319.2313725,3177.705882,967.9019608,129.3372549,255,22.31207516,14.8559625,0.746106945,0.930656934,0.652173913,0.316228497
+283,42052.83951,880.6419753,541.2469136,1151.148148,37381.67901,726.0246914,578.4197531,1701.975309,20905.74074,619.2222222,652.7283951,1784.617284,28727.50617,1341.432099,5018.234568,3539.08642,9985.234568,1366.481481,426.7530864,2471.197531,19664.06173,1228.814815,273.9382716,812.0617284,23347.06173,401.8395062,176.5679012,3147.493827,19179.66667,1522.444444,1036.296296,2829.320988,15624.07407,615.1728395,307.5555556,3461.419753,11866.97531,895.8148148,467.9753086,1332.135802,9139.962963,683.8641975,179.8271605,2346.135802,7289.308642,1342.098765,263.8518519,3261.185185,443.6419753,124.5679012,81,10.61051801,9.983115833,0.33876842,0.941860465,0.736363636,-0.837016654
+284,36349.50394,832.9291339,529.3228346,1175.251969,31881.20472,712.4409449,683.6220472,1765.015748,18415.08661,602.9133858,854.1732283,1794.992126,23967.87402,1287.590551,7407.889764,3882.212598,9097.606299,1328.393701,412.7244094,2504.755906,15993.15748,1894.818898,123.0787402,748.9606299,19890.0315,404.5748031,231.976378,4926.80315,16125.05512,1567.11811,885.9527559,2816.637795,12967.24409,658.7086614,289.8582677,6578.165354,9864.543307,935.0472441,450.6535433,1349.110236,7489.80315,656.9370079,167.984252,4260.291339,6139.204724,1279.566929,315.4330709,3200.480315,455.6141732,126.7007874,127,15.87491967,10.96520269,0.72311761,0.894366197,0.62254902,0.205906507
+285,17717.85507,702.7101449,477.6956522,1050.985507,15887.24638,583.5507246,1071.666667,1537.536232,8787.289855,516.2608696,1691.347826,1828.521739,11986.21739,1115.521739,7396.594203,3710.362319,4346.086957,1131.028986,351.7536232,4021.275362,8224.652174,929.6666667,149.8115942,807.3623188,9749.623188,379.8550725,110.8550725,4487.130435,7927.869565,1936.971014,1009.101449,2826.478261,6426.376812,574.7971014,252,5934.869565,5024.478261,1167.318841,406.1014493,1316.115942,3866.318841,639.4057971,161.8405797,4233.695652,3111.985507,1135.115942,484.7681159,3218.536232,467.6086957,124.4927536,69,13.42061772,7.286182002,0.839791154,0.831325301,0.479166667,0.854243945
+286,37004.6,810.3333333,496.7333333,1101.844444,33033.33333,671.8444444,985.6555556,1638.077778,19043.24444,595.6111111,1355.255556,1824.688889,26389.97778,1284,6871.777778,4406.966667,9253.988889,1281.433333,401.4,5264.966667,17551.87778,884.8222222,250.5444444,1359.022222,21284.52222,450.4222222,123.4444444,4887.033333,17609.07778,1817.855556,983.7222222,2839.288889,14092.94444,581.2666667,278.0333333,4378.722222,11133.76667,1494.311111,442.0888889,1311.4,8389.811111,680.7777778,170.5333333,2737.333333,6788.7,1270.777778,246.0888889,3183.066667,522.6222222,125.4888889,90,11.14051324,10.40956715,0.356255781,0.989010989,0.743801653,-0.462443759
+287,14262.53933,675.258427,424.1685393,1004.94382,12630.73034,570.6853933,577.4269663,1409.662921,7463.58427,514.9550562,1334.292135,1754.146067,10323.51685,1094.865169,6194.179775,3301.741573,3891.651685,1121.426966,420.7078652,4897.11236,7087.224719,626.1123596,1416.337079,609.988764,8418.640449,339.3932584,105.7303371,4359.662921,7174.764045,1490.719101,916.3033708,2799.52809,5723.213483,590.2696629,243.6516854,6509.820225,4585.88764,1506.831461,385.6629213,1396.033708,3576.752809,905.4382022,151.6067416,2713.932584,3009.033708,1140.123596,449.6179775,3134.179775,560.7191011,125.3146067,89,11.25107797,10.49798021,0.359709387,0.946808511,0.618055556,1.416160975
+288,20153.4127,751.5873016,561.2380952,1132.650794,17236.30159,608.4126984,655.7936508,1744.444444,9845.079365,515.0634921,790.6349206,1838.111111,13594.79365,1146.47619,6936.174603,3081.095238,5280.285714,1154.857143,360.031746,3813.253968,8803.190476,2046.746032,535.5555556,498.0793651,11326.36508,393.015873,107.6984127,6386.793651,9151.380952,1545.126984,834.8888889,2808.888889,7321.68254,566.7777778,280.1746032,32552.15873,6049.31746,928.6984127,387.2222222,1405.984127,4489.301587,799.7936508,159.1746032,6381.698413,3689.031746,1200.920635,262.7301587,3277.142857,597,125.7142857,63,11.75088413,7.147502369,0.793743745,0.926470588,0.65625,0.049709835
+289,21568.26531,723.3979592,476.6326531,1082.785714,19771.90816,588.377551,837.8265306,1580.357143,9885.020408,491.9489796,1390.795918,1748.959184,13926.11224,1128.081633,3205.142857,2902.734694,5107.632653,1133.030612,370.4183673,4080.622449,9490.581633,415.5714286,810.3061224,1193.5,11534.69388,869.1326531,249.0306122,4603.438776,9832.765306,1594.214286,708.3979592,2815.357143,7931.561224,533.4693878,263.377551,17914.97959,6008.530612,1117.714286,383.2959184,1332.326531,4147.612245,784.1428571,151.3367347,4322.204082,3509.153061,1119.387755,205.3979592,3121.061224,889.244898,125.6020408,98,12.3452917,10.31831262,0.549019496,0.933333333,0.685314685,0.005512416
+290,19101.65035,704.6503497,448.4195804,1054.888112,17099.84615,576.9160839,618.2027972,1586.41958,9478.951049,484.958042,350.2447552,1810.06993,13275.22378,1094.811189,5284.461538,2967.944056,4855.79021,1100.181818,437.7062937,2474.013986,8513.93007,1644.657343,663.1818182,430.041958,9964.111888,362.2097902,109.2167832,5597.216783,8817.909091,1259.167832,736.6223776,2788.65035,7106.461538,625.5734266,239.4615385,10994.66434,5634.797203,737.1818182,366.5314685,1335.272727,4224.384615,755.3006993,143.3776224,3311.937063,3432.881119,1103.370629,159.6713287,3144.531469,724.013986,128.4055944,143,16.03455995,11.52220226,0.695438625,0.934640523,0.6875,-0.471643071
+291,18137.26961,701.2058824,497.2205882,1055.068627,15457.58824,570.6519608,517.0686275,1554.073529,8794.151961,473.3480392,412.3088235,1785.602941,12157.52451,1099.75,5061.098039,3329.720588,4614.759804,1090.77451,358.6029412,2857.985294,7874.779412,2878.95098,709.1715686,439.0735294,9614.166667,385.0882353,109.8970588,7215.284314,8279.465686,1380.661765,977.0833333,2825.573529,6669.661765,588.5441176,252.2401961,19629.69118,5213.333333,760.7352941,371.8382353,1365.357843,3663.79902,783.2696078,151.6960784,4263.519608,3158.122549,1109.480392,190.1470588,3125.539216,793.8186275,128.4264706,204,18.65279733,14.30787239,0.641571674,0.923076923,0.6375,-1.461367218
+292,28593.06604,1106.481132,580.4433962,1090.396226,25911.17925,770.3867925,754.3962264,1703.566038,13883.40566,663.6415094,701.3584906,1880.40566,18572.23585,1376.141509,3679.754717,2408.254717,6841.075472,1357.311321,412.6698113,2427.933962,12537.53774,448.254717,502.4811321,644.6509434,14652.66981,459.7830189,125.7264151,1638.471698,12386.56604,1749.867925,774.3301887,2802.584906,10036.06604,713.8396226,271.4622642,1367.622642,7281.103774,1053.707547,432.6320755,1303.141509,5816.320755,2362.745283,162.1886792,1926.679245,4704.320755,1700.424528,149.3679245,3431.283019,360.3018868,128.8773585,106,13.74606309,10.75225908,0.623019329,0.92173913,0.504761905,0.792533601
+293,48137.95489,906.7819549,530.4360902,1141.338346,43155.84211,744.7819549,553.8496241,1711.691729,23663.37594,627.2781955,521.962406,1770.421053,32983.61654,1383.503759,5414.360902,3825.669173,11669.76692,1438.112782,436.887218,2487.827068,22109.94737,503.4285714,142.8496241,511.924812,26570.81203,430.9172932,136.6165414,3550.962406,22083.63158,1545.691729,1035.443609,2824.744361,17973.66165,645.8270677,320.406015,2734.729323,13721.6391,950.0526316,492.9849624,1344.947368,10516.20301,692.9398496,180.4135338,4049.052632,8339.601504,1412.541353,182.3383459,3276.090226,415.4586466,127.924812,133,15.70288373,11.12374575,0.705822511,0.910958904,0.639423077,-1.22906408
+294,44130.85185,891.462963,501.6296296,1139.296296,38897.94444,833.3518519,1104.203704,1729.814815,21281.83333,637.4814815,2428.148148,1864.481481,28893.51852,1348.703704,5039.703704,3360.981481,10224.22222,1351.944444,430.2037037,2904.351852,19135.11111,410.6851852,468,1702.62963,23483.05556,459.8518519,784.3333333,1897.037037,19234.07407,1911.722222,779.537037,2833.537037,15343.11111,600.3333333,304.8333333,2782.648148,11485.22222,1095.481481,468.7407407,1349.092593,8801.87037,735.6851852,170.2407407,3850.203704,7006.055556,1316.962963,361.7407407,3223.981481,428.5555556,125.7222222,54,11.60848725,6.517483534,0.827516603,0.830769231,0.613636364,-1.331672897
+295,18985.59563,720.5245902,518.431694,1085.595628,16818.83607,592.8797814,700.7486339,1559.185792,9552.469945,515.7814208,564.2896175,1802.540984,12851.01639,1147.644809,4616.092896,2522.710383,4755.650273,1182.338798,359.0273224,2935.196721,8737.114754,2517.125683,174.0491803,466,10584.99454,428.6284153,111.7322404,5472.819672,8586.453552,1420.360656,990.3551913,2988.765027,6881.508197,610.8907104,246.010929,6254.174863,5492.415301,904.0273224,407.7704918,1329.311475,4187.289617,633.863388,155.704918,3150.081967,3375.912568,1161.355191,203.3497268,3162.333333,487.1256831,129.6939891,183,18.05079493,13.16487579,0.684168604,0.948186528,0.768907563,-0.201437324
+296,16458.69091,698.3909091,506.0545455,1085.445455,14366.81818,566.6272727,467.1727273,1584.827273,8198.363636,484.9,475.9545455,1785.909091,11527.60909,1124.8,5339.163636,3298.009091,4264.409091,1094.090909,353.9181818,3491.909091,7320.090909,1978.218182,179.4363636,476.0363636,8685.481818,360.7636364,105.2727273,5209.054545,7598.190909,1417.909091,865.3545455,2782.363636,6193.5,528.5363636,258.6454545,24854.81818,4929.490909,790.2636364,367.6818182,1345.309091,3610.409091,624.3363636,141.5363636,5217.990909,2968.236364,1104.545455,174.4545455,3128.190909,713.0454545,128.5545455,110,15.42950284,9.5970999,0.78301986,0.88,0.564102564,-0.310287973
+297,17244.61947,765.300885,760.6371681,1148.362832,15455.0531,601.0442478,683.1150442,1739.876106,7841.141593,491.6902655,614.8053097,1884.973451,11563.92035,1171.584071,5349.681416,3787.300885,4299.19469,1176.646018,369.7168142,3207.610619,7807.911504,3661.123894,176.2566372,493.3274336,9701.867257,434.5044248,122.3982301,7398.787611,7893.982301,1476.814159,929.920354,2798.141593,6387.929204,550.0973451,285.0353982,29004.70796,4908.389381,855.5752212,397.0619469,1353.557522,3215.849558,620.4867257,156.6548673,4649.584071,2836.973451,1158.681416,224.2123894,3217.168142,915.920354,128.920354,113,13.72387954,10.60559698,0.6346689,0.974137931,0.672619048,-0.310128583
+298,29723.68394,823.9430052,483.5181347,1112.694301,25378.23834,675.4974093,698.8341969,1697.181347,12695.00518,522.9015544,1324.870466,1793.549223,19735.89119,1259.409326,5433.435233,3344.917098,7184.476684,1263.792746,387.6994819,3401.694301,12735.89637,1843.849741,119.7202073,1058.53886,16072.17098,436.984456,123.9533679,4079.15544,12819.94301,1743.26943,823.2020725,2796.797927,10271.58549,572.2590674,270.8756477,11360.04145,7825.19171,919.119171,418.7046632,1309.310881,5003.792746,635.5492228,160.2849741,3460.974093,4427.020725,1232.119171,306.2124352,3274.787565,937.4974093,132.1917098,193,18.0462378,15.03240269,0.553282449,0.889400922,0.564327485,0.170068619
+299,15281.91398,671.9892473,494.8064516,1092.989247,13601.46237,544.5698925,469.9247312,1581.236559,7754.537634,491.2903226,604.2365591,1802.27957,10279.89247,1065.849462,4992.473118,3450.913978,3822.892473,1099.645161,344.2043011,3521.913978,6986.645161,548.8924731,110.8387097,560.8172043,8375.688172,368.4623656,107.483871,4077.88172,6875.505376,1370.645161,1177.451613,2829.870968,5587.408602,546.5053763,229.9677419,5925.946237,4374.806452,866.4516129,378.7526882,1309.892473,3254.311828,602.0752688,160.344086,4289.72043,2670.032258,1090.774194,279.1505376,3123.580645,476.5268817,129.3333333,93,13.85445973,8.642610326,0.781572581,0.958762887,0.794871795,-0.221930813
+300,24599.66197,753.443662,536.7183099,1094.176056,21783.66901,604.3169014,556.8380282,1660.584507,12317.28169,537.2464789,514.8802817,1853.873239,17006.25352,1184.007042,5267.767606,3271.5,6147.204225,1197.633803,374.5633803,2673.669014,11470.02817,3022.612676,149.1267606,485.3309859,13687.95775,448.9577465,119.971831,5311.232394,11141.78169,1412.5,1148.612676,2817.725352,8854.338028,563.3873239,260.6126761,7310.492958,7048.253521,896.5422535,421.2676056,1315.183099,5418.21831,621.7253521,161.9577465,2511.239437,4254.225352,1194.633803,172.9859155,3202.15493,508.7042254,130.2887324,142,18.39200336,11.07531489,0.798359599,0.830409357,0.563492063,1.099460918
+301,25396.7561,742.2764228,468.804878,1096.105691,23122.9187,620.3902439,604.5853659,1694.04878,13501.7561,557.4878049,970.3252033,1863.463415,18891.13821,1206.585366,5036.292683,3437.813008,6649.788618,1191.869919,370.4715447,4072.138211,12655.82114,4060.130081,436.2357724,581.1382114,14895.07317,394.2764228,116.9756098,5029.886179,12965.74797,1654.723577,922.6747967,2809.861789,10320.70732,567.5691057,277.6829268,12403.7561,8158.276423,1215.04065,415.7642276,1325.382114,6161.130081,764.7723577,175.9268293,3167.04878,5133.544715,1221.300813,341.3577236,3205.674797,569.195122,131.4552846,123,13.74054847,12.67171792,0.386681322,0.866197183,0.5125,0.065030547
+302,16703.96273,699.4968944,487.0559006,1062.074534,14345.20497,565.5962733,472.3043478,1507.086957,8421.875776,478.0621118,467.5093168,1779.36646,11373.97516,1072.776398,4218.037267,2849.47205,4270.919255,1109.049689,387.6149068,2973.819876,7398.677019,465.5776398,1252.26087,478.1925466,8804.962733,351.7142857,107.2049689,4729.180124,7620.732919,1382.627329,864.6459627,2821.608696,6212.291925,566.7701863,240.7204969,15294.12422,4939.161491,791.9627329,363.7826087,1353.968944,3650.248447,978.8944099,148.3416149,4128.459627,3115.850932,1124.832298,172.8944099,3081.708075,616.4161491,130.0993789,161,14.82815447,14.15809288,0.297211943,0.975757576,0.821428571,0.869471991
+303,17981.5283,720.3915094,488.5943396,1090.787736,15744.59434,569.2830189,654.4009434,1561.981132,8560.867925,466.245283,952.1320755,1803.108491,12282.98585,1117.886792,4013.783019,3730.688679,4514.108491,1115.415094,349.4292453,5712.231132,7917.603774,801.9528302,104.9386792,635.2311321,9722.146226,384.4481132,113.6839623,4144.816038,8327.891509,1608.066038,741.9339623,2777.235849,6724.259434,532.8490566,262.7169811,21205.71698,5272.113208,974.4811321,379.9245283,1342.5,3656.311321,723.2075472,237.3254717,4166.929245,3041.330189,1137.580189,207.7735849,3141.915094,850.7971698,132.4481132,212,21.3383687,14.31620885,0.741535229,0.818532819,0.602272727,-0.123867378
+304,17451.30128,794.9679487,461.4230769,1077.435897,15526.21154,620.5,437.0897436,1503.634615,7275.096154,523.0384615,386.9935897,1748.352564,10925.42308,1195.230769,2634.358974,1063.448718,3848.737179,1191.948718,386.6987179,2385.262821,7566.711538,320,756.6858974,428.5192308,8679.75,374.7820513,115.9294872,1947.647436,6855.666667,1353.089744,687.9038462,2862.262821,5525.051282,634.5897436,247.8525641,1256.621795,3666.282051,754.0576923,398.7884615,1309.038462,3268.205128,854.3397436,157.7179487,2515.532051,2378.814103,1162.775641,824.4358974,3053.679487,297.1858974,133.275641,156,21.35422411,9.632893746,0.892473334,0.912280702,0.742857143,-0.055458743
+305,16356.43284,725.9701493,553.5820896,1101.776119,14912,598.641791,489.5970149,1619.761194,8336.61194,519.2985075,533.2537313,1789.492537,11547.47761,1129.238806,5819.626866,3882.835821,4075.044776,1124.940299,349.4328358,2951.089552,7665.253731,1508.074627,184.5820896,506.0447761,9167.985075,359.8059701,118.4925373,8084.567164,7710.955224,1398.179104,1009.238806,2778.253731,6238.791045,542.9104478,286.9701493,31975.9403,4906.567164,842.7014925,396.3432836,1355.58209,3711.164179,664.7761194,159.7313433,4422.686567,3111.179104,1167.059701,217.8358209,3171.880597,550.5671642,130.8955224,67,13.80256408,6.463722815,0.883570217,0.943661972,0.515384615,-0.594699965
+306,21103.80583,812.7475728,990.9223301,1200.446602,19200.72816,644.6893204,742.6796117,1906.15534,10382.72816,527.5436893,425.815534,1986.446602,14776.49515,1227.466019,5286.184466,2876.543689,5350.106796,1223.951456,367.7669903,2528.640777,10042.73786,692.1262136,126.9708738,443.3203883,11922.28155,418.407767,118.5631068,7510.757282,9903.776699,1343.747573,803.6893204,2814.359223,8087.68932,565.0776699,272.1456311,18007.49515,6443.213592,893.8349515,397.5825243,1349.407767,4998.281553,731.2718447,157.8349515,3685.514563,4133.864078,1255.815534,143.9514563,3180.757282,653.9320388,131.9417476,103,15.23131924,9.198727372,0.797033543,0.936363636,0.585227273,0.231173943
+307,17800.71698,704.5849057,454.254717,1061.801887,14983.53774,560.8584906,562.4245283,1598.877358,8800.320755,490.3396226,669.4150943,1811.839623,12250.15094,1112.811321,4964.424528,3631.273585,4554.40566,1103.764151,380.490566,3545.481132,7948.188679,836.8018868,601.8018868,894.7264151,9602.349057,371.5471698,108.3962264,3302.537736,8241.301887,1384.066038,760.1415094,2794.132075,6600.990566,545.8113208,231.9528302,12846.62264,5325.311321,961.745283,376.4716981,1341.518868,3857.169811,867.5,155.6320755,4396.90566,3269.622642,1154.584906,291.4433962,3127.226415,684.4716981,128.6698113,106,13.2044419,10.3138776,0.624416557,0.954954955,0.688311688,1.011723
+308,25372.7814,813.8511628,583.9860465,1128.706977,21530.82326,631.6883721,647.5488372,1785.246512,12541.85581,530.6232558,451.7953488,1878.027907,17438.33023,1238.67907,5723.35814,3636.427907,6461.47907,1224.986047,389.1069767,2831.776744,11205.15814,1263.8,122.5674419,472.4186047,13415.4186,418.5209302,115.627907,6239.051163,11887.11628,1379.860465,907.7674419,2805.730233,9496.172093,564.0930233,274.1813953,16173.43256,7426.711628,784.0790698,400.1395349,1317.023256,5459.381395,716.6372093,157.0372093,3968.944186,4596.981395,1218.64186,189.6744186,3232.990698,751.9488372,135.1860465,215,23.66423643,12.38167572,0.85219573,0.820610687,0.590659341,-0.039190606
+309,21570.72067,719.3351955,446.0782123,1099.167598,18769.07263,584.3687151,451.3351955,1563.726257,10483.30168,476.5363128,461.9832402,1749.810056,14749.26816,1130.240223,3977.24581,2554.039106,5504.195531,1117.150838,358.301676,3023.765363,9468.162011,6221.072626,152.1899441,461.0223464,11678.8324,429.2122905,112.6703911,4667.128492,10190.24581,1383.910615,768.8212291,2794.815642,8286.798883,607.5027933,252.8324022,12572.55866,6459.011173,781.2569832,388.2178771,1307.139665,4451.731844,717.1061453,150.6312849,2492.441341,3769.01676,1134.039106,141.575419,3124.134078,836.5921788,130.3296089,179,17.65525991,13.49544631,0.644758043,0.917948718,0.75210084,1.568684521
+310,21766.48889,715.5037037,462.437037,1088,18719.65926,583.4592593,507.0666667,1642.651852,10871.19259,514.5185185,599.0740741,1863.711111,15326.23704,1132.948148,4368.474074,2900.925926,5665.437037,1135.992593,356.837037,4002.911111,9911.711111,2033.303704,125.0814815,550.2,11970.63704,378.4518519,112.4888889,5061.644444,10147.66667,1430.237037,867.5259259,2778.525926,8066.822222,538.4962963,251.3333333,15255.14074,6582.214815,872.9925926,367.9703704,1350.814815,4860.311111,691.1037037,181.9703704,3804.17037,4013.903704,1161.237037,204.8,3157.074074,674.362963,133.7037037,135,15.33659286,12.34933243,0.592976081,0.838509317,0.473684211,0.079899093
+311,25056.77515,778.4497041,478.6331361,1108.047337,21531.95858,629.4556213,846.2899408,1712.828402,11588.9645,503.2071006,1322.976331,1904.461538,16377.91124,1186.828402,5538.946746,4413.360947,5899.266272,1195.313609,374.4852071,6096.47929,10677.36095,832.2071006,246.9704142,915.2662722,13091.99408,413.3136095,118.0887574,5315.893491,11262.74556,1782.08284,711.6923077,2814.236686,9138.467456,593.0710059,256.4911243,11870.11243,7016.497041,1060.704142,398.6449704,1322.213018,4826.95858,674.6686391,155.5266272,3634.940828,4095.83432,1193.526627,322.260355,3181.976331,867.0769231,132.3550296,169,17.26824674,13.0797882,0.652896218,0.871134021,0.621323529,0.942638702
+312,31215.88235,984.7058824,547.0882353,1108.960784,27989.51961,739.2745098,583.9117647,1555.911765,13815.15686,607.9117647,435.0490196,1728.911765,19575.68627,1351.22549,5815.509804,2296.539216,7136.578431,1323.676471,432.9901961,2368.019608,13754.55882,362.6372549,899.5490196,423.1470588,16179.06863,407.8333333,125.4411765,3461.676471,13111.07843,1455.931373,750.9803922,2823.627451,10672.72549,599.9019608,282.7745098,1315.470588,7081.54902,786.1372549,443.372549,1304.892157,6090.009804,821.5294118,167.0882353,2150.205882,4589.990196,1253.862745,739.6372549,3201.558824,307.7254902,132.0490196,102,13.07804613,10.27251158,0.618890156,0.927272727,0.713286713,0.585647865
+313,20108.44375,827.4125,514.50625,1053.21875,18448.325,640.7625,571.99375,1494.45625,9274.7125,545.6625,510.20625,1754.59375,13175.8,1212.4625,4410.2875,3034.0625,4990.975,1243.0375,427.54375,2444.7875,9436.23125,365.80625,1010.5625,494.9125,11090.69375,413.45625,122.69375,3406.79375,8945.43125,1585.975,878.53125,2793.5,7345.20625,687.58125,264.025,1726.34375,5273.9625,841.38125,416.725,1324.46875,4420.6375,939.0125,168.98125,5850.3625,3332.58125,1435.08125,289.825,3238.1375,330.08125,133.425,160,16.55066711,12.39273147,0.662823871,0.946745562,0.666666667,0.962249999
+314,25198.33051,766.7288136,530.940678,1457.118644,22254.90678,619.2033898,492.529661,2060.228814,12609.76271,533.059322,506.529661,1815.682203,16759.60593,1168.377119,4878.983051,3170.733051,6189.165254,1205.317797,366.6144068,2476.868644,11229.36017,6035.59322,126.9957627,460.1313559,13609.10169,402.2245763,121.9661017,4063.279661,10946.34746,1373.466102,977.4067797,2813.012712,8951.737288,589.8898305,257.4491525,6527.110169,6896.618644,829.5805085,413.279661,1318.288136,5173.495763,636.1737288,157.3008475,3829.809322,4175.161017,1185.898305,315.9957627,3203.724576,464.8813559,137.4110169,236,18.6177886,17.09224039,0.396442289,0.925490196,0.621052632,-0.097045686
+315,25478.85714,761.4081633,464.5306122,1091.010204,22231.40306,690.9234694,911.0255102,1595.066327,11721.92857,502.9183673,2707.693878,1809.122449,16890.87755,1172.47449,6237.382653,3470.255102,6278.673469,1195.69898,391.6734694,6260.244898,10980.7602,753.8520408,343.3928571,1231.331633,13620.67857,408.7755102,119.2142857,3711.55102,11674.64286,2045.984694,715.9234694,2799.571429,9554.627551,555.3010204,254.7653061,8627.47449,7235.096939,1361.423469,395.744898,1329.688776,4959.510204,662.8112245,154.2857143,3771.341837,4217.280612,1179.112245,252.6020408,3186.244898,880.0153061,135.2959184,196,19.40787296,15.01465417,0.633628716,0.834042553,0.573099415,-0.473569688
+316,29361.22472,855.928839,458.8127341,1067.861423,25473.52809,671.9812734,683.1872659,1519.382022,13782.47191,571.1348315,747.8764045,1773.059925,18975.56929,1232.2397,2754.194757,2328.816479,7030.794007,1277.157303,405.6029963,2422.093633,12865.99625,893.6928839,965.9662921,592.3745318,15463.45318,410.1348315,188.9662921,1732.573034,12720.59925,1649.779026,849.9850187,2850.191011,10267.52434,766.247191,264.6441948,1510.382022,7850.925094,1012.76779,425.6404494,1321.52809,6311.41573,1043.955056,166.1722846,3177.441948,4972.531835,1343.157303,356.1198502,3250.88764,380.6104869,139.0374532,267,22.53610137,16.50865189,0.680721305,0.853035144,0.527667984,0.500266619
+317,19021.03252,701.6666667,481.3333333,1052.487805,16933.56098,587.3252033,785.7804878,1501.284553,9525.894309,474.1544715,1088.235772,1782,13166.04065,1107.081301,6304.365854,4317.609756,5033.073171,1123.804878,367.4878049,5670.365854,8577.756098,440.203252,567.8292683,1023.333333,10518.43902,719.9837398,109.0487805,6703.422764,9145.772358,1437.430894,816.699187,2795.081301,7294.260163,565.5691057,249.3739837,12863.89431,5788.926829,1102.268293,376.8943089,1360.837398,4236.796748,719.6504065,151.398374,4698.162602,3571.552846,1134.089431,279.6341463,3123.065041,776.3089431,131.9674797,123,14.82723136,10.9755553,0.672354195,0.931818182,0.640625,1.401016618
+318,37244.09091,836.4545455,497.1428571,1094.597403,32277.15584,706.6103896,517.7532468,1564.584416,17662.61039,573.5714286,570.9090909,1775.857143,23685.18182,1238.519481,4458.844156,4812.792208,8186.688312,1279.246753,401.4805195,2492.649351,15147.1039,406.9350649,1747.974026,520.1038961,18742.41558,385.4545455,138.1948052,3722.350649,15101.54545,1541.779221,898.7012987,2810.181818,11960.75325,553.9350649,274.4285714,3019.155844,8906.337662,927.1038961,427.1558442,1336.12987,6640.935065,1033.480519,169.4805195,4499.025974,5366.792208,1233.753247,186.4155844,3204.311688,435.8961039,134.012987,77,12.23304528,8.255375224,0.73796206,0.950617284,0.658119658,-0.362006715
+319,41216.76449,871.6666667,501.4347826,1123.264493,36549.16667,732.4057971,783,1633.173913,19993.73188,599.5398551,1265.380435,1797.655797,26635.23913,1315.431159,4588.043478,3808.173913,9346.971014,1323.554348,418.1086957,2571.75,17777.11594,3252.300725,1012.626812,1171.717391,21487.81884,409.3369565,506.6050725,2843.076087,17152.75,1683.967391,832.7934783,2845.956522,13942.47826,597.5289855,312.1050725,2875.76087,10638.19203,995.3115942,445.423913,1327.253623,8130.32971,880.1050725,170.7101449,3090.181159,6421.456522,1280.655797,278.326087,3242.695652,447.3949275,139.6413043,276,21.94029913,17.3317059,0.613173224,0.831325301,0.525714286,0.161029779
+320,22751.20641,734.9644128,459.1245552,1095.078292,19779.24911,596.8825623,402.5765125,1593.580071,11004.17438,485.7580071,391.9964413,1772.41637,15386.74021,1133.886121,4193.274021,2510.480427,5663.316726,1130.871886,359.13879,2599.850534,10172.54093,3800.092527,282.8967972,440.8647687,12243.59431,392.8932384,112.5978648,5203.97153,10560.95018,1331.587189,890.5231317,2786.939502,8498.451957,559.3736655,257.6370107,15463.22064,6530.241993,751.1352313,389.797153,1329.313167,4714.957295,745.9644128,151.9608541,2916.75089,3993.163701,1156.067616,172.341637,3121.156584,805.2170819,138.5017794,281,23.15383733,16.2064047,0.714197087,0.906451613,0.608225108,-0.797008642
+321,23690.58586,783.7323232,561.2727273,1114.272727,19365.36869,663.3232323,901.3181818,1703.176768,9534.984848,499.8333333,779.9191919,1829.80303,15155.00505,1205.393939,5268.313131,2899.484848,5575.313131,1209.888889,377.1818182,4334.686869,9854.939394,600.7121212,156.6666667,562.1919192,12416.41919,522.979798,120.6717172,3113.626263,9995.863636,1568.606061,875.8939394,2809.106061,8107.681818,549.2272727,259.8535354,13497.42929,6140.792929,1334.181818,403.8333333,1367.449495,3722.055556,616.8838384,162.4191919,7105.055556,3451.661616,1176.611111,282.8131313,3244.59596,956.9343434,136.5050505,198,20.43648698,12.72942241,0.7823196,0.938388626,0.611111111,0.62167799
+322,37509.33684,836.0210526,454.4842105,1074.484211,32995.90526,685.9368421,564.1473684,1562.926316,18420.89474,580.8736842,538.9157895,1729.115789,25000.75789,1283.052632,3635.905263,2316.315789,8995.073684,1341.778947,412.1578947,2429.6,16802.66316,383.5684211,266.1473684,471.9578947,20449.35789,418.7052632,127.1684211,2566.557895,16901.63158,1495.968421,842.2,2811.663158,14090.66316,765.8105263,295.4,3853.778947,10591.21053,869.5894737,452.0210526,1351.810526,8106.294737,689.5684211,172.8421053,3764.589474,6605.894737,1326.842105,466.0421053,3236.557895,402.9052632,134.8,95,12.85914566,9.497137136,0.674197421,0.940594059,0.664335664,-0.264991409
+323,29491,828.2857143,518.2222222,1087.650794,25958.36508,786.2539683,828.5714286,1573.571429,14042.09524,564.3650794,1162.793651,1795.619048,18874.74603,1270.079365,5694.825397,5074.238095,7013.15873,1261.84127,404.6507937,2518.888889,12706.01587,382.1428571,147.7936508,1143.174603,15030.88889,395.0793651,206.7936508,3179.047619,12539.65079,1608.793651,830.2380952,2810.761905,10090.5873,565.8730159,290.6507937,4300.714286,7541.269841,940.6507937,431.9047619,1330.507937,5717.047619,705.4285714,178.1746032,4647.984127,4517.761905,1251.587302,283.2222222,3216.936508,428.2222222,133.3333333,63,10.9050573,8.824789139,0.587480644,0.851351351,0.572727273,0.039229649
+324,19180.4697,771.6136364,665.1363636,1142.515152,17549.99242,638.5984848,759.280303,1690.901515,9485.871212,539.75,590.5,1819.363636,13211.57576,1198.893939,4882.181818,3397.719697,4723.484848,1216.333333,371.1515152,3145.272727,8990.75,538.0984848,431.1515152,511.1742424,10549.49242,431.4545455,116.3787879,5239.651515,8885.704545,1506.333333,1044.492424,2820.757576,7156.772727,550.9621212,276.5151515,22814.56061,5671.113636,916.6742424,412.3560606,1387.386364,4363.939394,746.3030303,164.8712121,4542.030303,3517.174242,1206.272727,193.3181818,3201.621212,555.9924242,137.9621212,132,16.61632267,10.6853627,0.765812248,0.897959184,0.523809524,-0.436757634
+325,13958.11017,725.1525424,549.9830508,1093.220339,12566.10169,594.4067797,519.0084746,1598.322034,6838.686441,498.6864407,458.1694915,1777.228814,9727.025424,1124.016949,4945.90678,2873.627119,3552.847458,1130.661017,341.1694915,2801.59322,6437.313559,1358.864407,162.2033898,470.5,7668.855932,378.2118644,111.1016949,5197.720339,6645.042373,1333.745763,980.8644068,2800.322034,5341.144068,568.7457627,267.5254237,29062.44068,4330.559322,793.1440678,375.8559322,1352.70339,3281.144068,689.5169492,148.8728814,5620.745763,2814.084746,1181.949153,205.3474576,3167.09322,602.7881356,135.5338983,118,13.38821574,11.38027394,0.526747667,0.936507937,0.702380952,-0.111762879
+326,16780,733.8565022,486.8834081,1078.403587,14840.84753,596.8251121,481.5605381,1687.273543,8271.901345,494.7713004,377.8789238,1874.825112,11609.63677,1141.246637,4840.067265,3521.986547,4291.349776,1131.32287,378.9461883,2507.600897,7562.96861,1624.201794,423.6367713,468.7219731,9112.26009,384.3363229,111.5964126,4730.659193,7752.838565,1275.44843,869.5201794,2800.313901,6217.950673,557.0493274,252.7399103,14028.61883,4997.61435,742.8744395,373.1838565,1327.775785,3728.699552,815.9910314,152,4447.892377,3110.008969,1165.255605,193.4798206,3208.466368,688.3811659,138.161435,223,28.99388483,10.33360859,0.934331,0.874509804,0.476495726,-1.0833361
+327,21011.30476,736.7238095,530.0571429,1102.533333,17899.32381,606.2857143,509.3714286,1630.457143,10178.50476,517.8,514.6,1837.866667,14318.06667,1155.92381,4433.466667,3243.52381,5298.352381,1163.352381,353.6857143,4598.895238,9285.780952,583.9428571,127.8,570.6095238,11067.5619,381.9714286,106.7714286,5659.380952,9709.619048,1409.057143,1099.952381,2882.304762,7811.638095,550.4952381,272.352381,28667.58095,6145.238095,855.047619,395.7809524,1394.990476,4420.704762,698.6571429,155.9238095,5788.847619,3850.885714,1209.057143,205.8857143,3211.104762,582.1904762,136.7904762,105,14.5790418,9.439384034,0.762097242,0.945945946,0.636363636,0.350394633
+328,27976.10526,760.5338346,520.6578947,1094.398496,24096.53008,616.6428571,808.537594,1590.31203,14033.00376,550.7819549,1416.582707,1802.755639,19076.52632,1194.289474,6097.710526,3665.793233,7069.552632,1202.015038,367.5977444,3948.142857,12688.09023,487.1090226,145.4398496,888.6879699,15332.54135,423.8458647,236.2293233,5370.695489,12750.78571,1692.075188,1046.650376,2819.221805,10175.33083,561.3345865,269.7706767,13392.96241,8071.793233,1988.015038,416.9586466,1311.984962,6012.360902,634.8759398,170.7706767,4049.026316,4920.345865,1188.507519,231.0676692,3181.37218,525.8721805,139.6503759,266,20.58618698,16.81855788,0.57666223,0.943262411,0.7,0.639759061
+329,15627.55208,724.1041667,518.3020833,1083.229167,13233.30208,586.3229167,597.40625,1624.09375,7791.802083,487.5104167,437.21875,1828.364583,10966.26042,1137.59375,5511.6875,3458.135417,4042.25,1120.15625,367.6666667,3093.46875,6838.489583,1165.541667,229.3125,484.4270833,8453.020833,381.7291667,115.3333333,6290.510417,7181.1875,1392.34375,995.0208333,2778.333333,5878.25,536.8125,256.1458333,21251.04167,4805.416667,777.1354167,370.6041667,1358.1875,3422.354167,673.1354167,153.6979167,5600.59375,2931.270833,1166.229167,205.3020833,3192.65625,705.9270833,137.59375,96,13.27890834,9.360104996,0.709321477,0.941176471,0.615384615,0.688354469
+330,18538.06977,862.4767442,502.3488372,1047.523256,17111.39535,635.1104651,581.8837209,1452.936047,8859.703488,557.2790698,630.7790698,1795.377907,12525.71512,1186.930233,4702.662791,2989.773256,4411.662791,1373.186047,378.7616279,2437.988372,8640.77907,346.4127907,1113.546512,507.2616279,10132.63372,384.5348837,118.5755814,3632.843023,8390.563953,1659.447674,854.8313953,2809.319767,6885.023256,632.255814,250.3662791,1441.104651,5301.726744,1039.377907,413.5465116,1322.598837,4363.674419,974.505814,163.8023256,5718.116279,3426.44186,1269.784884,312.8604651,3346.151163,358.7732558,141.5697674,172,18.79666691,11.82109617,0.777491693,0.971751412,0.682539683,0.383834327
+331,29399.49315,833.8356164,455.5479452,1100.547945,27329.75342,681.7260274,584.3013699,1580.054795,14320.45205,563.4520548,650.260274,1761.890411,19856.12329,1304.808219,3985.849315,2554.178082,6890.712329,1288.986301,417.260274,2449.041096,13923.06849,396.1643836,457.0410959,652.7123288,16052.76712,403.7534247,127.8493151,2172.328767,13236.76712,1561.246575,825.369863,2795.60274,10823.21918,642.2191781,279.7671233,1836.876712,8314.383562,1015.164384,450.1232877,1332.191781,6618.123288,723.369863,168.1369863,3091.972603,5145.479452,1305.232877,489.630137,3199.260274,391.4246575,137.7534247,73,12.4607275,7.592052336,0.792956373,0.935897436,0.603305785,0.736237048
+332,37312.67227,821.8907563,454.9747899,1099.579832,33627.12605,690.4201681,819.5630252,1591.361345,18321.03361,570.789916,1058.579832,1821.630252,25071.65546,1281.823529,3801.008403,3026.210084,9139.184874,1323.983193,405.4285714,2760.495798,17266.31933,392.8235294,132.5714286,780.2941176,20590.82353,405.9915966,137.0504202,2114.504202,17184.18487,1692.756303,840.3193277,2838.378151,13911.42017,686.5210084,287.605042,2562.159664,10647.87395,1005.680672,448.4537815,1336.882353,8242.142857,681.7394958,172.5462185,3791.966387,6493.672269,1318.05042,244.9327731,3208.428571,418.4957983,137.7226891,119,18.38422918,9.461971733,0.857383114,0.838028169,0.626315789,-1.524384785
+333,21615.41489,700.856383,487.8244681,1069.739362,19158.5266,573.5904255,521.7287234,1576.723404,10878.5,512.7925532,466.2765957,1835.808511,14797.34043,1134.521277,5825.303191,2970.255319,5362.111702,1140.829787,355.3776596,2544.914894,9909.005319,3038.760638,138.712766,436.3031915,12012.35638,388.1914894,116.9946809,7184.93617,9688.957447,1336.085106,1101.175532,2808.462766,7800.276596,560.6489362,241.8989362,4471.31383,6161.691489,828.2074468,394.6542553,1295.132979,4694.260638,612.8457447,155.1542553,2607.601064,3799.808511,1137.101064,172.0957447,3140.755319,499.7287234,140.962766,188,17.57674831,13.99645792,0.604894918,0.944723618,0.696296296,-1.251461402
+334,19303.68452,715.7321429,540.0119048,1064.75,16049.91071,581.702381,506.1309524,1607.5,9255.208333,482.7619048,455.4761905,1833.047619,12711.92857,1105.886905,5162.27381,4062.410714,4774.738095,1100.208333,369.7083333,3024.130952,8079.446429,529.2202381,374.0535714,524.1904762,9793.089286,385.8869048,110.1666667,8181.559524,8510.125,1316.732143,1171.785714,2800.72619,6904.886905,556.8809524,252.297619,15366.17857,5391.964286,784.9464286,376.8511905,1318.14881,3888.5,691.1309524,145.327381,4724.357143,3291.166667,1123.761905,163.8928571,3122.904762,767.9880952,140.8690476,168,16.37642617,13.52644053,0.563713735,0.928176796,0.65625,0.68119509
+335,12209.87215,640.5844749,388.0913242,1030.876712,10306.94064,556.086758,502.456621,1376.940639,6052.972603,438.2557078,350.3972603,1768.917808,8397.03653,1033.547945,2841.178082,1610.776256,3248.228311,1051.817352,525.4063927,2551.410959,5586.146119,563.0136986,1573.273973,477,6727.497717,350.5159817,103.9497717,3360.547945,5952.858447,1377.922374,728.173516,2782.630137,4782.949772,760.4200913,221.6438356,6384.315068,3771.744292,763.5981735,354.8127854,1338.849315,2724.949772,1031.360731,140.7305936,2739.388128,2338.771689,1069.771689,141.803653,3055.730594,785.1461187,142.260274,219,19.73993073,14.40433912,0.683761402,0.956331878,0.640350877,-0.743071144
+336,20593.17123,758.5753425,581.4657534,1123.068493,18084.07534,620.4726027,631.7260274,1730.089041,10178.68493,523.0136986,535.9246575,1866.657534,14141.54795,1158.643836,5300.726027,3912.006849,5163.630137,1169.390411,361.4315068,2588.041096,9535.815068,2023.328767,347.390411,469.2945205,11215.77397,398.1712329,112.609589,5214.869863,9553.869863,1403.69863,860.0136986,2787.171233,7805.924658,561.7808219,262.0205479,23585.77397,6143.280822,1338.273973,386.1506849,1368.452055,4622.315068,860.4383562,168.4315068,6555.465753,3866.034247,1208.178082,339.8356164,3146.130137,645.0342466,140.1575342,146,15.36803568,12.55822485,0.576403453,0.901234568,0.802197802,1.105268064
+337,19388.81106,740.1705069,519.1889401,1106.797235,16907.58065,598.921659,492.2534562,1673.294931,9644.230415,497.9354839,461.875576,1831.9447,13516.54378,1136.050691,3734.470046,2626.571429,4911.147465,1154.612903,406.4700461,2711.198157,8764.930876,2898.691244,607.7050691,469.7557604,10600.67281,390.4884793,110.4792627,4817.599078,8855.359447,1349.599078,917.9170507,2800.474654,7075.857143,628.8248848,255.4009217,20465.70968,5712.926267,956.1336406,371.5023041,1342.493088,4290.101382,900.5437788,158.8525346,4706.626728,3591.24424,1176.16129,197.562212,3155.995392,661.7142857,142.4700461,217,20.67679662,13.52782827,0.756276921,0.931330472,0.671826625,-0.947464249
+338,12950.26772,745.3779528,648.6220472,1106.228346,11310.14961,598.984252,605.2834646,1572.566929,6325.732283,489.4015748,407.2834646,1778.19685,8858.070866,1135.543307,2542.212598,1290.574803,3314.133858,1172.149606,356.8503937,2540.456693,6099.291339,417.7322835,557.519685,455.1889764,7263.188976,373.6771654,110.6850394,1750.338583,6131.80315,1300.637795,657.8976378,2818.275591,5116.80315,575.2992126,255.2677165,23521.86614,4091.606299,937.5905512,371.8818898,1367.874016,3082.76378,923.5590551,145.3149606,4441.685039,2682.425197,1194.984252,642.2913386,3155.464567,630.0551181,141.9527559,127,14.03640424,11.55870656,0.567344432,0.954887218,0.755952381,0.477073648
+339,28388.72289,790.253012,469.5903614,1124.987952,24560.18072,626.7228916,550.0722892,1643.614458,13957.66265,520.313253,551.5180723,1809.53012,19384.92771,1198.13253,3726.301205,3107.662651,7195.915663,1193.108434,386.0843373,3179.084337,12673.14458,10933.57831,288.8915663,536.9518072,15170.18072,468.2650602,121.5421687,3791.86747,13357.62651,1588.662651,884.1204819,2789.686747,10707.13253,584.4216867,261.8915663,7483.819277,8341.53012,860.2409639,404.060241,1324.192771,6291.313253,690.1204819,168.2409639,2592.951807,5162.012048,1213.216867,158.3012048,3189.084337,742.253012,140.3253012,83,11.68804001,9.731209673,0.553907216,0.873684211,0.628787879,0.700992765
+340,14158.90625,706.25,545,1085.78125,12396.92188,559.921875,481.4375,1609.984375,6647.75,474.40625,500.15625,1790.078125,9538.546875,1095.625,4309.78125,3923.40625,3546.40625,1128.46875,346.765625,3248.796875,6218.21875,1017.234375,171.03125,489.953125,7594.453125,374.375,114.234375,5874.796875,6541.5,1407.15625,929.109375,2784.265625,5318.78125,515.515625,255.859375,25845.82813,4185.171875,774.03125,380.5,1329.515625,2881.203125,686.984375,157.6875,4781.5625,2432.578125,1121.9375,186.25,3141.09375,858.734375,139.390625,64,9.190036478,9.026234931,0.187962628,0.927536232,0.711111111,-1.013123699
+341,22203.15534,710.5728155,442.5339806,1058.300971,19617.67476,578.7621359,697.6650485,1580.834951,10220.63107,465.038835,527.2864078,1776.043689,14630.19903,1123.043689,4132.378641,3100.320388,5355.995146,1117.742718,362.0145631,3000.927184,9522.053398,4760.174757,202.5776699,464.1699029,11953.42718,428.3203883,117.5097087,6489.961165,9935.752427,1498.907767,856.3786408,2798.009709,8113.150485,582.223301,243.6893204,8149.475728,6098.781553,779.6796117,382.6262136,1300.92233,4140.742718,627.1893204,152.2572816,2890.495146,3533.990291,1124.276699,152.9660194,3166.825243,897.0970874,143.1747573,206,20.77789725,13.41599953,0.763602943,0.895652174,0.77443609,-0.028863213
+342,19694.14063,685.7734375,453.3125,1057.890625,17168.39844,572.2578125,982.484375,1534.632813,9136.734375,465.96875,1317.4375,1788.453125,13280.36719,1101.554688,5946.507813,4103.585938,4889.585938,1117.054688,361.9921875,5853.359375,8684.953125,857.359375,385.3359375,762.7578125,11170.27344,384.0703125,113.2421875,5257.75,9140.15625,1897.039063,793.1796875,2806.890625,7474.25,529.171875,239.515625,9951.523438,5751.96875,1097.632813,390.6484375,1329.492188,3830.734375,655.96875,170.2578125,4180.085938,3397.710938,1117.796875,250.9609375,3099.15625,908.5625,142.2890625,128,15.7425552,10.45932798,0.747378625,0.941176471,0.727272727,-0.016990584
+343,21768.63706,815.2182741,715.893401,1166.416244,18703.91624,639.3502538,768.3629442,1799.703046,10494.75127,530.1142132,448.319797,1886.522843,14470.51523,1218.532995,3520.708122,2372.484772,5435.687817,1224.28934,355.7360406,2557.837563,9514.756345,1459.266497,127.8629442,454.7817259,11421.23858,411.4340102,111.3553299,4106.06599,9772.494924,1353.246193,913.2715736,2841.002538,7921.383249,590.8020305,268.5761421,21979.01015,6452.489848,878.3705584,392.2994924,1353.522843,4830.43401,669.3147208,152.9086294,4366.994924,4053.274112,1237.205584,165.1852792,3226.203046,613.106599,148.1573604,394,26.59881822,19.59348245,0.676296178,0.914153132,0.656666667,-0.726485219
+344,19117.59829,719.7948718,470.008547,1065.982906,17245.02564,591.5897436,801.8717949,1529.547009,9147.461538,481.7521368,1436.589744,1758.102564,13079.15385,1125.188034,5248.059829,3876.923077,4829.282051,1121.615385,351.2222222,4405.384615,8656.230769,863.2905983,212.9401709,1550.34188,10421.65812,377.6495726,114.3846154,4079.709402,9056.820513,1928.846154,764.1111111,2791.196581,7411.247863,609.8034188,248.1196581,15880.74359,5732.871795,1102.675214,387.4957265,1303.076923,4122.794872,769.4957265,154.2478632,4618.282051,3467.931624,1137.82906,272.5213675,3132.051282,832.3247863,141.1367521,117,14.90555549,10.56885361,0.70515352,0.943548387,0.609375,-1.297144537
+345,21659.27273,700.3363636,452.55,1068.481818,19002.85,577.2545455,603.1954545,1561.340909,9791.536364,468.3409091,646.3590909,1782.690909,14376.08636,1099.818182,3909.072727,2649.45,5258.177273,1122.636364,357.8454545,4039.990909,9468.995455,5265.813636,102.3954545,547.4636364,11801.15,416.8363636,114.5545455,5335.181818,9677.590909,1525.459091,848.0954545,2792.504545,7742.809091,528.05,247.2318182,11109.77727,5918.2,874.2090909,383.3590909,1318.431818,3849.345455,594.1818182,145.8727273,3540.559091,3413.918182,1121.877273,179.5090909,3164.245455,921.9863636,144.7772727,220,19.88367257,14.54482594,0.681845786,0.928270042,0.679012346,-0.541813441
+346,26274.90566,857.5283019,456.5943396,1079.518868,23741.51887,692.7641509,510.4811321,1549.462264,11671.81132,566.0566038,418.7169811,1714.59434,17022.17925,1293.235849,1902.311321,1715.377358,6035.622642,1294.896226,415.5943396,2381.95283,11923.13208,361.6981132,655.4811321,452.7641509,13852.32075,397.7924528,124.7169811,1975.349057,11316.76415,1421.235849,734.5,2853.367925,9237.867925,793.5188679,275.4811321,1527.650943,6326.830189,814.4528302,428.3584906,1311.075472,5518.273585,925.3867925,168.4245283,2734.198113,4029.009434,1284.622642,858.3018868,3130.113208,304.1320755,143.2358491,106,14.36576843,9.890100536,0.725284647,0.876033058,0.630952381,-1.04194587
+347,25019.44643,707.1964286,500.2142857,1090.714286,22067.46429,584.625,559.3035714,1607.607143,12071.375,503.375,831.2142857,1839.428571,16789.16071,1133.803571,5242.321429,3345.464286,6239.160714,1164.464286,364.9464286,3171.571429,11427.125,2211,129.8928571,584.9464286,13629.82143,379.4821429,161.7321429,4650.303571,11060.05357,1531.678571,1250.839286,2786.5,8862.714286,586.6071429,258.1785714,6573.607143,7002.767857,967.75,404.7857143,1283.625,5413.517857,610.9642857,159.6428571,2811.964286,4224.660714,1149.946429,180.9107143,3125.910714,512.5714286,140.5357143,56,9.649981758,7.740714979,0.597125072,0.918032787,0.777777778,-1.337460707
+348,24653.75,792.5714286,545.9642857,1116.154762,21774.14286,628.1785714,542.3809524,1640.369048,11927.03571,560.6904762,602.8928571,1850.119048,16810.05952,1191.952381,4352.77381,4593.535714,5997.27381,1212.333333,371.7857143,3380.059524,11112.78571,967.3690476,181.3095238,555.4880952,13110.28571,406.4642857,116.8690476,6202.511905,11119.35714,1480.083333,1204.345238,2795.916667,8817.785714,553.7261905,292.5952381,16455.13095,6997.190476,891.7142857,422.6071429,1321.154762,5276.27381,706.3333333,163.5952381,4197.511905,4305.107143,1195.011905,204,3244.642857,562.5119048,144.1904762,84,14.55574403,7.947741615,0.837771502,0.875,0.6,-0.364795216
+349,18665.53614,713.4939759,451.5903614,1058.23494,15730.07831,578.246988,472.5301205,1596.951807,9213.819277,477.9277108,356.813253,1820.89759,12805.3012,1110.728916,4334.295181,2912.987952,4667.777108,1107.548193,385.6686747,2501.638554,8031.596386,1420.210843,416.0722892,432.6024096,9580.728916,355.9939759,112.1987952,5085.03012,8312.283133,1260.674699,903.0180723,2797.301205,6824.807229,640.1385542,254.1445783,16340.70482,5464.831325,742.8614458,376.1626506,1329.307229,4004.445783,687.2590361,149.6566265,4444.10241,3332.981928,1135.518072,188.1084337,3116.012048,716.4457831,144.3313253,166,19.865304,10.94784905,0.834436547,0.927374302,0.54248366,-0.932054572
+350,27341.47826,730.4695652,449.6782609,1075.382609,23342.7913,591.9304348,467.6608696,1634.417391,11732.06957,476.2956522,477.9565217,1799.878261,18207.14783,1146.921739,4133.26087,3177.773913,6642.965217,1166.886957,367.6521739,2863.113043,11877.8,988.0608696,110.0434783,436.6695652,14913.67826,403.2,114.3913043,5380.565217,11996.34783,1393.113043,858.7478261,2796.895652,9612.069565,541.3130435,245.5130435,9035.826087,7386.086957,837.8,393.8434783,1308.226087,4602.713043,615.5826087,160.8347826,3438.721739,4129.113043,1162.026087,166.7043478,3179.147826,950.5130435,145.2434783,115,16.52871479,9.856708703,0.80273309,0.905511811,0.58974359,0.510820487
+351,29000.85526,901.1973684,493.2105263,1075.328947,25624.05263,677.7631579,558.9605263,1502.921053,13119.38158,599.2105263,440.0657895,1719.618421,19140.48684,1294.236842,3908.105263,2419.894737,6929.5,1296.25,396.8552632,2423.644737,13506.80263,359.7631579,303.7631579,440.1842105,16318.78947,416.2631579,127.7368421,3899.657895,13448.69737,1472.605263,882.0789474,2818.473684,10911.17105,671.0657895,270.9605263,1745.157895,7867.078947,832.8289474,446.4605263,1309.973684,6717.828947,675.0921053,174.4078947,2998.526316,5048.881579,1288.289474,525.6315789,3227.539474,314.4342105,143.9736842,76,13.25440674,7.457130193,0.826718924,0.926829268,0.603174603,-0.296004068
+352,22217.18182,857.8181818,967.7552448,1208.447552,19964.51049,667.9230769,1163.370629,1928.265734,10895.37063,589.4475524,1302.734266,2022.454545,15063.47552,1268.671329,4749.181818,4294.972028,5654.825175,1243.076923,374.8181818,5851.587413,10358.15385,568.2167832,150.1608392,800.6153846,12104.55944,436.8531469,123.2167832,4497.79021,10307.08392,1806.034965,1102.58042,2818.664336,8376.741259,592.2167832,277.979021,10627.02797,6611.006993,1499.664336,440.9090909,1331.853147,5004.174825,663.4965035,175.4755245,4618.447552,4087.685315,1264.272727,273.965035,3318.559441,573.2097902,143.7902098,143,14.02220565,13.55476317,0.256047785,0.910828025,0.785714286,1.14558401
+353,29147.50588,797.0117647,474.8705882,1089.870588,26094.14118,646.3764706,814.0705882,1600.223529,14171.45882,543.2117647,1288.117647,1819.082353,19784.27059,1227.117647,4979.341176,3171.341176,6922.917647,1213.988235,538.6352941,4694.647059,13324.62353,1738.564706,1256.035294,912.6823529,15516.98824,381.8588235,116.2352941,2977.258824,13543.10588,1705.388235,730.5176471,2790.247059,10898.43529,695.3058824,259.9058824,7626.423529,8620.141176,1202.988235,410.8588235,1458.270588,6518.741176,910.4,172.5882353,3354.741176,5300.952941,1224.8,271.7176471,3153.505882,733.5294118,142.9764706,85,12.5122702,8.670934286,0.720942882,0.965909091,0.702479339,0.700819415
+354,25271.71739,761.3478261,438.5108696,1088.206522,21822.32609,616.2282609,624.173913,1641.478261,9527.706522,487.9130435,392.8586957,1789.173913,16296.3587,1159.293478,5154.173913,2962.086957,5818.369565,1173.695652,388.0326087,2470.978261,10535.97826,2054.673913,336.076087,440.0326087,12962.65217,447.25,124.1195652,5737.423913,10130.42391,1350.902174,848.4565217,2818.413043,8055.880435,549.3695652,245.6956522,5285.021739,5882.956522,737.423913,385.8804348,1296.641304,3499.967391,648.3478261,153.9456522,2377.532609,3281.565217,1132.586957,176.0978261,3146.23913,990.9565217,143.4130435,92,13.36430268,9.071254781,0.734353208,0.948453608,0.58974359,-1.04159717
+355,26945.32203,1121.050847,580.7118644,1080.644068,23492.05085,751.7118644,527.7457627,1518.754237,12346.51695,659.5423729,533.3135593,1754.432203,16619.90678,1312.398305,2817.288136,2351.29661,6279.288136,1413.889831,421.2457627,2454.186441,11448.13559,358.7627119,1539.923729,475.2288136,13788.61864,393.8305085,122.1101695,2400.474576,11333.5678,1648.677966,779.6186441,2803.932203,9236.381356,634.4745763,272.4661017,1505.135593,6912.5,869.9576271,429.0338983,1366.415254,5607.79661,993.6016949,166.7881356,5406.432203,4388.279661,1242.305085,167.720339,3444.364407,342.3050847,145.440678,118,14.9107142,10.22076573,0.728106019,0.936507937,0.655555556,0.525297877
+356,34353.94161,862.2116788,544.729927,1115.70073,30921.67153,684.8175182,739.8978102,1626.985401,16216.87591,594.459854,1206.79562,1789.343066,23302.9927,1283.467153,5330.678832,4496.386861,8050.335766,1320.948905,412.5182482,2473.49635,15824.46715,390.4452555,484.9416058,580.6715328,18471.54015,408.6569343,133.919708,4018.773723,15319.21898,1639.145985,953.189781,2840.240876,12542.17518,626.2335766,290.3357664,1697.386861,9560.284672,1525.481752,445.5109489,1316.59854,7960.649635,847.2262774,178.3649635,5880.160584,6090.430657,1349.291971,192.4233577,3359.569343,370.3357664,147.6788321,137,15.176355,12.48318397,0.568704885,0.901315789,0.611607143,0.226838966
+357,21415.42534,743.040724,512.081448,1279.040724,19188.00452,591.3484163,850.3936652,1923.61086,10630.9457,519.3936652,1027.352941,1869.755656,14508.25792,1145.714932,6446.714932,3100.877828,5400.19457,1170.457014,370.0180995,4198.475113,9942.180995,3395.986425,143.3574661,796.0226244,11933.78281,442.0678733,134.438914,4541.461538,9663.176471,1785.782805,948.8371041,2820,7830.072398,620.9140271,253.7782805,6206.022624,6270.285068,1028.199095,404.2714932,1310.665158,4798.651584,644.5746606,160.2262443,3102.746606,3874.298643,1169.484163,314.0904977,3193.556561,479.3846154,148.6651584,221,22.07001394,13.63429461,0.786355207,0.902040816,0.66969697,0.159273509
+358,18732.85714,704.952381,511.7142857,1073.190476,16221.8254,569.3015873,405.6031746,1588.015873,9085.698413,456.5873016,361.968254,1779.111111,12687.49206,1101.539683,4276.920635,2755.349206,4758.396825,1105.571429,351.5238095,2499.015873,8254.460317,2969.920635,105.2539683,430.3492063,9939.587302,404.7936508,116.1111111,5261.111111,8683.920635,1250.333333,838.6507937,2776.714286,7063.809524,552.7301587,236.952381,14961.22222,5552.333333,707.7777778,378.5555556,1296.698413,4051.079365,629.3174603,149.2857143,3636.095238,3413.555556,1133.968254,152.4920635,3174.492063,758.5396825,144.7777778,63,10.98359727,7.534420642,0.727629615,0.940298507,0.65625,-0.202056388
+359,27038,891.173913,555.2898551,1075.550725,22566.56522,677.8115942,502.6376812,1537.753623,11959.07246,593.9855072,480.0144928,1762.681159,16878.69565,1265.478261,4497.26087,3750.42029,6238.753623,1302.637681,404.9130435,2374.985507,11408.15942,369.5072464,805.2318841,443.0724638,13913.23188,428.0869565,127.0144928,3753.086957,11381.37681,1515.753623,882.4637681,2800.144928,9157.101449,625.0144928,276.057971,2016.826087,6608.724638,854.8550725,440.9565217,1319.637681,5374.710145,811.3043478,178.4492754,6793.130435,4213.347826,1288.231884,232.9130435,3317.231884,328.0434783,144.5652174,69,10.44291939,9.156016771,0.480913719,0.8625,0.570247934,0.812593093
+360,22549.25926,806.1555556,689.6666667,1167.844444,19442.05926,651.9407407,634.8222222,1752.807407,11088.55556,540.1851852,456.2888889,1881.177778,15526.84444,1202.437037,3665.525926,2443.214815,5641.844444,1194.325926,354.5037037,2666.125926,10005.48889,902.4148148,116.837037,465.8518519,11964.6963,387.762963,113.3555556,3872.585185,10562.65926,1357.311111,842.8148148,2798.074074,8420.318519,572.0740741,279.7333333,26811.28148,6783.488889,904.6,405.2888889,1368.859259,4948.688889,701.4444444,153.3111111,4502.792593,4278.288889,1241.6,184.5259259,3175.607407,597.0074074,146.4074074,135,15.60592758,11.88923922,0.647763788,0.9375,0.602678571,0.599276835
+361,21269.54124,791.1340206,503.0309278,1112.314433,18976.63918,627.4587629,559.5515464,1708.78866,10182.86598,526.1494845,385.9278351,1839.015464,14459.07216,1227.360825,4477.948454,3141.159794,5168.335052,1202.097938,465.8917526,2498.860825,9222.824742,1363.206186,542.1546392,440.6546392,11153.67526,395.4742268,115.5309278,6063.07732,9348.273196,1335.639175,946.8350515,2789.515464,7463.123711,558.9690722,255.3969072,10025.34536,6053.453608,795.2680412,390.1546392,1328.649485,4609.654639,821.6907216,150.6649485,3520.010309,3729.025773,1222.912371,175.757732,3170.551546,697.1649485,147.4690722,194,17.18347678,15.10612522,0.47662334,0.950980392,0.598765432,-0.875898876
+362,14697.18103,749.1293103,547.7758621,1096.810345,12011.31034,597.4568966,566.0862069,1633.137931,6752.293103,483.5603448,559.3965517,1842.474138,9543.051724,1128.508621,4251.060345,2857.887931,3639.663793,1121.224138,364.4310345,3826.724138,6074.896552,1274.181034,358.1293103,489.4741379,7327.12931,373.612069,114.612069,4070.646552,6506.775862,1489.586207,753.3362069,2794.62069,5419.706897,530.7672414,290.3275862,37242.27586,4146.974138,847.137931,377.7155172,1338.887931,2844.422414,969.5258621,149.8448276,4831.301724,2472.448276,1155.405172,231.112069,3183.362069,850.1982759,148.0948276,116,17.33125887,9.7180648,0.828002306,0.865671642,0.552380952,0.827807441
+363,27525.04938,796.9259259,501.8641975,1108.111111,23164.1358,620.6049383,523.9135802,1787.901235,12710.74074,503.1728395,597.7530864,1845.382716,18138.46914,1204.061728,3661.160494,3041.444444,6602.530864,1203.444444,387.1604938,3702.530864,11718.96296,1536.91358,788.9753086,498.2222222,14291.2963,431.8765432,122.8765432,5034.54321,12412.67901,1475.481481,829.3580247,2796.098765,9982.666667,537.5555556,279.4938272,16613.53086,7602.283951,910.5802469,408.9259259,1345.54321,5304.716049,834.1358025,158.0864198,4608.345679,4423.049383,1188.123457,177.6666667,3208.790123,869.5925926,145.8765432,81,16.80897425,6.651153218,0.918383876,0.835051546,0.519230769,0.702455388
+364,34828.43103,780.9310345,441.0862069,1119.5,30584.55172,657.8448276,1103.413793,1667.655172,15951.75862,510.6206897,1508.258621,1866.103448,23619.58621,1213.517241,5814.431034,2631.275862,8421.896552,1227.465517,390.4137931,4241.913793,15606.2069,3062.655172,111.8275862,1068.758621,19602.74138,430.5172414,268.3965517,3437.568966,15805,1892.396552,720.8448276,2789.241379,12743.39655,565.1551724,259.2586207,3516.741379,9583.5,1065.637931,420.5517241,1294.568966,6200.413793,608.8793103,153.6034483,2728.241379,5573.137931,1197.344828,248.5344828,3179.534483,933.4827586,143.5517241,58,9.4948729,8.00042016,0.538533282,0.935483871,0.805555556,-1.015757605
+365,22889.31959,768.6752577,532.2268041,1089.551546,19643.99485,609.4948454,1002.242268,1684.474227,10101.62887,487.685567,1362.525773,1876.082474,15333.03093,1183.005155,6349.14433,5021.680412,5593.597938,1182.360825,370.757732,5368.365979,10053.64948,819.814433,116.6134021,702.2319588,12552.69588,453.3195876,120.8608247,7997.257732,10091.26804,1696.510309,941.3814433,2803.896907,8142.201031,537.1958763,261.3917526,13031.98969,6291.907216,1149.778351,393.9278351,1332.546392,4012.902062,619.7268041,211.7628866,5639.195876,3586.958763,1171.242268,265.4690722,3203.757732,938.5051546,150.1185567,194,20.82598918,13.79643136,0.749095312,0.83982684,0.598765432,-0.879173702
+366,27737.47712,895.0653595,585.5359477,1112.745098,24409.13725,700.0980392,576.1372549,1608.137255,12149.39869,580.6928105,533.5751634,1772.418301,17522.49673,1291.69281,3105.183007,3835.418301,6415.816993,1298.183007,417.372549,2481.732026,12361.78431,377.0718954,872.751634,481.5947712,14174.8366,560.6339869,126.1764706,3034.601307,11989.47712,1631.96732,937.1372549,2812.562092,9701.078431,711.4444444,282.2941176,2148.248366,7042.738562,1014.294118,447.7777778,1352.529412,5881.228758,831.9281046,183.1699346,6705.437908,4321.843137,1306.052288,479.2941176,3211.281046,320.0196078,151.9542484,153,18.71092142,12.27912088,0.754539871,0.805263158,0.455357143,-0.395664571
+367,20663.31655,733.9064748,499.5107914,1107.338129,17877.29496,600.7913669,483.2374101,1684.640288,10120.06475,515.4172662,470.2302158,1859.848921,13919.07194,1156.42446,4534.115108,2803.863309,5311.489209,1172.345324,348.8920863,2727.071942,9614.482014,1806.625899,184.6690647,450.8992806,11258.32374,383.618705,110.2086331,5216.546763,9626.561151,1366.136691,899.4100719,2795.431655,7784.942446,548.6618705,269.7338129,21658.69784,6294.107914,808.5611511,399.1151079,1336.654676,4707.079137,734.5107914,152.5971223,4164.942446,3887.611511,1200.604317,198.9568345,3159.510791,587.5323741,149.9856115,139,17.15328536,11.20332557,0.757245785,0.891025641,0.584033613,0.504280165
+368,18101.32886,679.0201342,432.6510067,1046.328859,15961.95302,548.557047,567.1610738,1504.744966,8651.348993,460.4563758,439.5302013,1768.42953,12456.81208,1105.852349,5129.557047,2642.973154,4639.281879,1095.899329,342.5100671,2843.986577,8152.516779,3439.57047,131.0939597,475.8926174,9924.395973,384.1275168,110.4966443,7009.677852,8498.087248,1311.852349,898.6040268,2787.744966,7050.691275,551.147651,238.1744966,13963.84564,5426.691275,758.5973154,378.704698,1319.577181,3898.758389,780.1006711,151.0536913,3360.530201,3276.832215,1106.872483,158.1543624,3151.798658,839.3691275,149.7986577,149,15.2572029,13.69611949,0.440643468,0.903030303,0.547794118,0.432122711
+369,10426.98438,743.796875,591.296875,1126.4375,9235.375,609.65625,579.3125,1722,3733.890625,467.625,598.609375,1880.59375,6521.90625,1104.671875,6241.71875,3539.90625,2591.515625,1137.734375,433.4375,3864.8125,4331.765625,604.765625,2083.5,524.28125,5234.71875,441.9375,117.078125,7340.015625,4281.125,1592.3125,785.5,2804.46875,3576,529.890625,234.734375,20847.76563,2517.546875,844.578125,362.65625,1419.75,1484.03125,1067.546875,149.90625,6227.875,1476.1875,1059.546875,253.25,3157.453125,1003.046875,146.640625,64,12.63243739,6.987128389,0.833108183,0.876712329,0.484848485,0.753918162
+370,39270.46154,859.4487179,482.7051282,1120.24359,35919.71795,697.2435897,732.0512821,1611.217949,19025.11538,610.4358974,992.8461538,1780.948718,25721.65385,1319.602564,4203.012821,4094.833333,9387.551282,1358.74359,416.6666667,2640.371795,17923.35897,399.2820513,161.0897436,642.7564103,21456.29487,405.7307692,135.6538462,3563.679487,17563.44872,1653.666667,1032.448718,2833.948718,14317.33333,736.5641026,301.7307692,3422.423077,11187.14103,983.6794872,467.1794872,1308.358974,8735.012821,693.2179487,174.9615385,3545.961538,6761.653846,1361.974359,362.5769231,3181.371795,417.6025641,145.3461538,78,14.40467797,7.453052242,0.85574066,0.939759036,0.577777778,-1.17737518
+371,38586.02793,868,523.4357542,1117.648045,33974.61453,707.1452514,780.0446927,1627.916201,18303.05028,601.3519553,633.972067,1794.195531,24899.44134,1328.932961,6486.24581,4765.50838,8834.821229,1354.793296,423.9106145,2525.843575,17120.05587,402.4022346,342.7486034,601.6424581,20087.36313,410.7430168,137.2849162,5151.648045,16757.12291,1609.698324,1014.865922,2809.446927,13339.76536,627.7430168,289.9888268,4355.905028,10429.74302,983.2234637,453.0558659,1352.564246,7824.670391,721.7709497,178.0111732,4868.955307,6199.212291,1329.865922,284.2346369,3245.134078,426.1117318,151.4692737,179,18.95328173,13.07817681,0.723788623,0.942105263,0.596666667,-0.220004477
+372,21731.35211,685.6478873,439.1549296,1020.15493,18730.95775,569.7605634,518.9295775,1585.338028,10504.26761,454.7042254,593.3661972,1812.056338,15048.3662,1112.605634,4722.295775,3806.225352,5690.422535,1109.267606,349.6338028,2909.366197,9759.619718,3847.549296,144.8450704,490.2676056,12012.33803,399.4366197,114.3380282,7373.746479,10117.90141,1378.971831,988.3098592,2797.225352,8091.971831,523.1971831,232.056338,5777.169014,6357.577465,797.1690141,373.6197183,1297,4574.507042,681.2676056,152.7464789,2035.605634,3896.521127,1147.169014,140.4647887,3154.901408,811.5915493,147.4788732,71,13.9853446,6.55968428,0.88317699,0.959459459,0.537878788,-0.704869153
+373,25164.31313,742.4141414,469.7777778,1049.808081,20438.68687,606.2828283,776.4646465,1557.40404,12467.65657,500.1313131,1576.757576,1774.646465,17408.92929,1205.030303,6399.878788,3830.969697,6515.727273,1163.89899,375.3939394,4259.525253,11423.91919,545.2727273,312.2020202,794.1717172,14161.0303,386.4040404,114.8585859,5151.838384,12372.61616,1596.575758,900.9292929,2801.444444,10216.43434,547.2929293,268.1414141,17627.64646,7947.141414,921.4848485,396.9393939,1336.191919,5379.212121,855.4646465,170.969697,4563.292929,4885.10101,1203.878788,283.2121212,3150.565657,822.2222222,147.3434343,99,13.42651509,9.581173693,0.700552431,0.916666667,0.692307692,0.532517406
+374,23565.11905,791.4920635,575.3333333,1123.52381,20067.24603,614.1507937,702.7619048,1796.190476,10933.05556,507.2857143,1008.460317,1849.698413,15824.68254,1201.293651,6694.603175,4282.698413,5824.952381,1187.992063,379.1904762,5649.174603,10133.13492,1365.174603,450.452381,593.2698413,12675.00794,411.6190476,123.2142857,8411.674603,10801.88095,1660.238095,853.6111111,2794.722222,8809.611111,554.2063492,278.3095238,27611.11111,6688.809524,1017.119048,400.515873,1371.992063,4609.555556,711.2460317,161.3333333,5770.801587,3975.261905,1195.444444,224.1111111,3225.793651,882.8968254,147.4603175,126,14.41973228,11.26602968,0.624164979,0.954545455,0.7,-1.460138044
+375,35140.01786,845.9464286,526.8928571,1123.383929,31264.99107,688.5803571,609.6964286,1585.767857,16402.51786,573.2053571,457.1696429,1764.098214,21681.59821,1266.955357,5686.008929,4334.526786,7870.571429,1305.776786,407.2589286,2453.705357,14530.98214,389.3928571,1221.705357,484.0178571,17113.83929,396.0089286,125.6696429,4583.107143,13722.45536,1472.098214,1143.25,2827.910714,10951.125,571.5714286,284.8035714,3035.160714,8453.794643,885.0803571,442.1964286,1312.5625,6287.651786,921.5625,166.3392857,3984.321429,4885.642857,1261.580357,166,3210.276786,437.4196429,149.2321429,112,14.09784253,11.28840697,0.599040457,0.875,0.622222222,-0.638383314
+376,24281.55856,759.4954955,501.3513514,1049.972973,21130.81982,629.0900901,679.1621622,1442.927928,11561.14414,541.4684685,1190.945946,1768.945946,15837.45045,1154.126126,5131.144144,3663.810811,5709.54955,1219.477477,373.7567568,2486.081081,10485.58559,338.4414414,2372.153153,786.5495495,12703.37838,393.8558559,120.7477477,2868.837838,10227.18018,1932.432432,1089.198198,2860.252252,8402.333333,623.2072072,257.0630631,1986.324324,6354.369369,1203.576577,415.7477477,1344.018018,4887.567568,1227.684685,165.8558559,5313.54955,3948.252252,1215.675676,472.8648649,3157.216216,392.7387387,150.5495495,111,13.67670325,10.46126226,0.644153216,0.973684211,0.660714286,-0.526991413
+377,21891.90517,747.5775862,430.9137931,1083.258621,18967.94828,613.9741379,715.1637931,1505.060345,10089.55172,527,1752.103448,1767.586207,13709.35345,1183.948276,5379.862069,2940.801724,4959.448276,1177.836207,372.3793103,5421.422414,9069.439655,448.9741379,2488.801724,700.2672414,10497.56034,377.6293103,116.2413793,2766.137931,8684.939655,1807.405172,732.2327586,2800.853448,6858.508621,527.2241379,257.6637931,17878.68103,5337.008621,1499.37069,405.387931,1444.612069,4025.887931,1330.827586,197.6982759,5418.767241,3218.215517,1148.87069,312.4137931,3158.112069,551.8103448,150.8103448,116,14.41569381,10.49805578,0.685324333,0.958677686,0.594871795,0.500276947
+378,25305.91954,781.7011494,471.3333333,1114.91954,22181.8046,613,484.7126437,1736.16092,11585.58621,500.5287356,437.9310345,1813.62069,16642.7931,1222.16092,4611.942529,2835.494253,5841.563218,1199.241379,375.9310345,2912.747126,10877.27586,4180.528736,343.045977,458.2068966,13008.93103,424.0229885,119.8045977,4700.908046,11239.68966,1481.758621,904.2298851,2796.965517,8920.793103,555.3103448,272.1954023,13888.72414,6755.597701,827.4252874,401.4482759,1330.574713,4864.574713,726.6206897,156.6091954,3879.609195,3968.862069,1195.149425,177.091954,3217.37931,862.7816092,149.5517241,87,11.68078472,10.02499256,0.513237715,0.896907216,0.604166667,0.532551583
+379,35743.05263,778.7105263,468.1447368,1098.394737,31415.48684,679.4868421,1261.539474,1611.5,18137.72368,589.0657895,2663.381579,1852.763158,24693.39474,1237.026316,6075.644737,3998.5,8754.171053,1256.223684,388.6710526,4837.855263,16493.88158,601.0394737,364.7236842,1512.986842,20215.43421,390.8289474,1014.894737,3308.671053,16062.57895,1850.552632,870.5921053,2885.513158,13031.27632,587.6710526,279.8157895,6062.618421,10373.03947,1478.763158,439.6052632,1298.184211,7855.210526,667.4078947,166.3289474,3752.973684,6418.947368,1227.710526,291.5394737,3159.184211,514.6447368,148.0921053,76,13.79146599,7.345483685,0.846360289,0.915662651,0.633333333,1.514297968
+380,18317.91781,689.5205479,421.1232877,1065.561644,16465.50685,566.6027397,457.3287671,1526.39726,9008.945205,492.8356164,443.2876712,1823.054795,12243.54795,1104.479452,3442.712329,2553.643836,4426.753425,1110.972603,361.2739726,3083.561644,7939.068493,2130.383562,442.8356164,574.0410959,9181.082192,350.260274,108.6164384,3927.315068,8132.342466,1326.849315,752.8767123,2783.849315,6701.890411,603.4109589,243.3835616,10508.76712,5235.452055,820.7671233,370.5753425,1345.863014,3921.232877,725.7945205,153.5479452,3059.821918,3200.273973,1122.753425,200.5342466,3054.232877,726.9726027,149.5753425,73,10.43664852,9.30242861,0.453368139,0.948051948,0.553030303,1.470757221
+381,28437.40909,1213.068182,594.0454545,1093.659091,24298.88636,798.3636364,512.2272727,1546.522727,12711.59091,689.5227273,507.0454545,1730.272727,16926.27273,1352,3603.636364,3484.5,6309.659091,1345.045455,421.5681818,2407.295455,11609.84091,376.2727273,466,473.3181818,13292.13636,404.9772727,123.7045455,3805.227273,11333.65909,1556.75,768.3181818,2797.590909,9185.840909,585.6363636,266.5909091,1837.090909,6682.681818,847.2272727,428.1363636,1308.636364,5545.454545,712.5,179.2954545,4804.363636,4208.795455,1249.909091,142.6363636,3429.659091,332.5681818,150.6363636,44,10.69633444,5.472092975,0.859232188,0.916666667,0.55,-0.463608472
+382,34359.50485,857.7378641,538.2912621,1186.330097,30055.76699,679.1165049,621.2815534,1711.990291,16721.03883,584.631068,453.961165,1754.873786,22205.71845,1296.466019,5682.796117,3641.669903,8074.980583,1308.427184,402.407767,2489.961165,14912.01942,518.1553398,129.6699029,454.4854369,18355.99029,389.8640777,128.1456311,3613.970874,14449.3301,1430.592233,879,2821.07767,11868.6699,615.961165,305.0970874,6689.038835,9284.533981,888.1456311,445.2621359,1334.543689,7050.631068,670.9223301,166.7572816,4031.932039,5626.097087,1315.029126,338.2135922,3252.067961,465.2718447,150.4174757,103,13.74070808,9.670224171,0.710433222,0.962616822,0.792307692,1.351402348
+383,26677.7033,738.6483516,470.6318681,1070.346154,23078.78022,623.4615385,908.3626374,1522.659341,13447.51099,550.6483516,2115.104396,1773.478022,17956.23077,1187.032967,6891.192308,3619.714286,6703.851648,1201.983516,371.5714286,4824.736264,12228.3956,854.478022,239.3461538,1389.423077,14742.85165,399.5989011,512.510989,3634.527473,12045.46703,1963.148352,832.1098901,2811.642857,9779.631868,1084.192308,259.2307692,4871.824176,7728.17033,1320.483516,408.3681319,1319.851648,5729.703297,643.7912088,162.1978022,3197.791209,4818.016484,1184.43956,328.7582418,3165.346154,491.2417582,155.3736264,182,20.57297293,11.67892428,0.823247327,0.905472637,0.684210526,0.299394743
+384,27756.80909,846.5181818,812.7090909,1152.672727,24465.46364,655.5272727,1034.172727,1744.681818,13715.16364,541.3181818,927.2272727,1860.627273,19294.65455,1258.372727,4555.972727,2940.290909,7095.3,1275.8,395.6909091,4531.745455,12433.64545,705.4727273,220.7454545,641.7727273,14974.15455,451.1636364,119.2181818,3111.281818,12957.92727,1645.881818,681.1181818,2825.427273,10451.59091,581.8363636,261.2272727,8349.381818,8185.354545,887.0090909,405.5545455,1338.5,6107.172727,664.0545455,169.0818182,2985.754545,5107.045455,1268.6,204.5363636,3217.654545,747.6727273,150.8,110,18.78278315,7.707061228,0.911938982,0.873015873,0.555555556,1.220745018
+385,28301.75182,791.4160584,487.1824818,1100.094891,23979.68613,637.4233577,795.7883212,1692.19708,10929.94161,495.6423358,1064.014599,1772.620438,18644.27007,1190.058394,5337.109489,3180.109489,6547.766423,1208.416058,377.2043796,5273.284672,12041.92701,531.2554745,457.2335766,685.2116788,14669.37956,430.9635036,124.7153285,7259.20438,11784.64964,1793.985401,753.1824818,2803.59854,9358.065693,544.2408759,256.8029197,8215.313869,6887.218978,1053.686131,391.8613139,1361.416058,4044.218978,696.1313869,156.3430657,3938.153285,3852.635036,1145.445255,263.2481752,3206.525547,996.8613139,153.3138686,137,15.23922563,11.706209,0.64025435,0.964788732,0.611607143,0.665790851
+386,18879.98611,719.1666667,463.2361111,1051.708333,16613.22222,589.7152778,674.8541667,1520.944444,8981.236111,481.75,776.6597222,1760.354167,12744.86806,1112.875,4919.416667,2797.631944,4751.166667,1111.152778,396.5069444,5807.4375,8444.555556,1304.881944,664.3541667,614.0277778,10087.50694,370.4722222,114.3055556,4619.284722,8727.618056,1482.888889,767.4583333,2796.270833,6944.479167,715.1388889,252.0972222,12119.09028,5413.256944,1010.979167,380.1944444,1398.861111,4015.1875,835.7986111,149.2986111,3672.513889,3333.166667,1158.048611,232.5,3141.277778,797.4097222,152.7916667,144,15.47018818,12.19579112,0.615237924,0.947368421,0.692307692,1.508954262
+387,23097.86538,753.775641,467.5576923,1117.570513,19895.35897,601.8141026,786.3974359,1672.583333,9579.801282,494.9038462,1247.794872,1810.935897,15149.45513,1194.608974,5389.929487,2614.532051,5616.192308,1163.589744,366.6474359,6143.557692,9867.762821,2709.884615,127.2628205,612.3717949,12457.95513,444.4358974,119.1474359,3565.102564,10197.1859,1752.282051,727.4423077,2803.391026,8212.910256,636.1089744,246.6858974,10100.12821,6166.314103,1162.057692,389.4551282,1326.141026,3773.141026,621.7051282,188.3012821,4491.115385,3478.179487,1157.762821,237.4871795,3193.083333,968.0064103,153.25,156,15.87081901,12.66687727,0.602493578,0.945454545,0.75,1.539647923
+388,25618.75949,799.9240506,468.3164557,1077.468354,22588.60759,649.0886076,477.2025316,1512.544304,11461.3038,531.0379747,431.4303797,1762.898734,16641.79747,1222.518987,3665.455696,3240.063291,5999.746835,1252.265823,384.0886076,2407.063291,11317.43038,345.1392405,390.7974684,434.5696203,13895.88608,411.7088608,121.3924051,3248.43038,11197.82278,1407.468354,834.9493671,2820.518987,9049.936709,703.5316456,260.1392405,2110.227848,6397.392405,790.2531646,423.1518987,1305.481013,5364.632911,713.3670886,175.3670886,5701.746835,4008.582278,1246.797468,373.4683544,3128.139241,305.3417722,151.8481013,79,13.89863008,7.478753316,0.842885578,0.929411765,0.705357143,1.566219582
+389,21912.47,699.86,431.05,1079.54,19144.27,568.68,647.64,1464.22,10655.06,504.84,895.69,1816.66,14711.14,1127.02,5422.89,2657.05,5353.47,1146.42,360.33,3322.73,9816.06,6798.98,122.58,701.89,11891.75,425.08,124,4025.45,9428.13,1680.3,900.97,2788.47,7602.03,702.82,237.53,4556.91,6023.77,1019.23,398.3,1305.72,4624.25,595.74,150.79,2276.22,3732.9,1123.59,186.58,3094.45,501.93,152.65,100,12.76640701,10.35859315,0.584498824,0.925925926,0.641025641,-0.942811307
+390,19656.01563,760.4375,537.9296875,1105.953125,16948.33594,613.8828125,581.0625,1609.851563,9483.765625,512.859375,435.7265625,1771.257813,12697.3125,1180.976563,3638.617188,2241.304688,4723.210938,1184.851563,349.359375,2522.039063,8691.796875,1297.59375,126.5625,459.4921875,10254.92969,380,113.6640625,3871.335938,8593.671875,1310.1875,983.7578125,2811.679688,7061.695313,562.6953125,275.328125,29516.27344,5556.140625,1082.546875,383.3984375,1366.640625,4171.34375,1341.054688,157.046875,6479.1875,3527.851563,1203.046875,1042.40625,3144.296875,632.1875,154.078125,128,16.19724326,10.69996049,0.750734717,0.920863309,0.571428571,-1.001872363
+391,19700.0625,709.3125,421.925,1067.25,16398.1625,567.3875,423.075,1598.225,9640.475,474.975,343.6875,1784.1625,13635.9125,1110.15,4480.2125,3773.925,4961.8625,1095.9125,352.4625,2474.55,8311.7125,1927.4375,114.2625,423.7125,10310.95,370.7375,105.6,4171.875,8817.875,1222.075,886.3625,2776.85,7208.525,523.6875,250.275,11894.625,5871.2625,692.775,368.6,1308.5375,4223.3,626.2,151.2375,3368.5375,3568.5625,1138.025,153.175,3131.15,706.3,153.7875,80,11.03446421,9.95379825,0.431601285,0.91954023,0.559440559,-1.050815909
+392,31981.49333,926.1866667,552.5066667,1127.093333,27885.61333,733.0533333,698.8933333,1626.026667,14730.77333,600.28,575.6,1775.413333,20398.54667,1339.266667,2522.533333,3594.2,7720.64,1383.146667,425.3866667,2464.893333,14368.2,395.4,1227.24,522.68,16459.38667,475.5733333,129.9333333,2387.986667,14159.69333,1638.413333,830.0666667,2803.4,11569.16,781.3866667,290.2,1833.56,8518.666667,1009.8,460.2,1383.186667,6957.186667,961.48,179.8133333,6977,5343.48,1375.6,164.72,3276.946667,338.8,154.8666667,75,10.28403075,9.807867607,0.300763416,0.914634146,0.619834711,1.204388776
+393,38648.92857,834.6285714,513.6571429,1081.514286,32989.65714,690.2571429,493.0285714,1561.742857,18971.37143,585.5142857,595.5,1780.3,25868.98571,1303.228571,3306.671429,2678.342857,9273.657143,1333.728571,409.3142857,2441.342857,17447.9,383.3142857,757.4,477.4857143,21158.27143,427.1285714,132.2285714,2775.757143,17338.82857,1573.128571,1039.8,2816.114286,14203.77143,671,284.3714286,1744.685714,10906.44286,1027.842857,451.7285714,1325.785714,8560.628571,806.7428571,176.8571429,4144.357143,6809.657143,1322.642857,259.7571429,3139.285714,381.3857143,153.3285714,70,12.51358355,8.013535877,0.768052424,0.853658537,0.598290598,1.535807484
+394,37180.77358,1022.45283,580.1132075,1118.433962,30305.50943,764.6415094,562.0566038,1566.09434,16548.58491,650,503.9811321,1748.188679,21551.24528,1360.641509,5943,4405.584906,7516.773585,1310.584906,400.3018868,2420.679245,13737.41509,418.9433962,317.3773585,454.4339623,16287.28302,469.2264151,123.3396226,3665.433962,13074.18868,1459,784.0754717,2797.415094,10627.39623,566.3773585,272.7169811,3238.698113,8053.54717,845.7735849,438.1509434,1330.188679,5863.830189,684.8867925,164.3396226,2762.754717,4298.90566,1187.45283,238.8113208,3470.113208,452.2830189,152.6415094,53,9.416546184,7.517919739,0.602162733,0.898305085,0.588888889,-0.575368634
+395,11840.42763,666.9078947,434.9342105,1048.131579,10374.30263,545.7894737,447.3947368,1534.322368,5822.243421,464.1513158,363.5394737,1830.072368,8122.921053,1070.282895,4127.763158,3121.092105,3016.953947,1072.953947,346.5789474,2474.730263,5332.197368,2232.217105,503.4210526,427.4868421,6385.493421,362.0657895,106.0263158,4752.131579,5473.046053,1238.164474,817.2434211,2797.388158,4403.671053,519.8355263,234.3223684,12952.15132,3521.796053,703.8421053,361.0986842,1324.480263,2650.723684,787.7631579,142.5855263,3730.875,2235.092105,1086.065789,166.0855263,3065.164474,683.2434211,155.2171053,152,16.50129788,12.13540729,0.677610058,0.904761905,0.723809524,-0.689743132
+396,13834.86111,711.0763889,476.9236111,1184.284722,12469.13889,571.5902778,419.9513889,2119.159722,6831.5,486.5277778,474.5208333,2242.756944,10103.51389,1134.979167,2988.611111,1426.847222,3711.826389,1135.583333,340.9305556,2534.083333,6667.673611,535.7638889,173.6666667,452.7708333,7866.701389,362.4027778,111.7916667,3317.666667,6901.923611,1231.305556,680.8055556,2824.986111,5642.159722,592.5138889,248.8055556,18999.5,4513.4375,696.8819444,376.4513889,1345.798611,3428.326389,677.8263889,145.2291667,3980.895833,2817.069444,1144.5625,202.0069444,3147.395833,720.4652778,157.0069444,144,16.11691167,11.85573404,0.677407134,0.941176471,0.64,0.976865452
+397,19274.70588,719.254902,475.6764706,1079.245098,16957.63725,574.6372549,649.6764706,1600.22549,9364.058824,469.5784314,565.6078431,1812.303922,13643.85294,1122.921569,5496.558824,3378.362745,4952.784314,1123.754902,360.1960784,3743.333333,8645.205882,4333.882353,166.1568627,640.754902,10577.38235,397.7941176,111.0490196,6914.578431,8762.058824,1435.95098,932.6666667,2787.480392,7153.480392,545.3921569,242.3137255,11859.88235,5808.647059,810.1960784,382.3921569,1330.715686,4347.823529,630.1862745,148.6764706,3526.666667,3571.686275,1128.176471,180.1764706,3165.176471,734.9117647,154.8431373,102,14.02244242,9.457329524,0.73832748,0.971428571,0.566666667,-1.060013612
+398,22676.32653,761.952381,490.537415,1115.537415,18879.17007,608.4557823,633.5578231,1632.598639,10790.72789,500.7959184,1178.721088,1820.054422,15367.44218,1179.108844,4413.612245,3226.040816,5682.482993,1162.054422,375.1836735,3548.401361,9990.353741,6637.380952,141.9931973,848.4489796,12201.86395,434.1904762,114.3197279,4044.591837,10518.55102,1777.823129,833.5782313,2801.081633,8436.836735,541.6190476,265.3401361,17228.21769,6579.965986,1059.265306,397.829932,1342.054422,4711.054422,793.8027211,161.9659864,4261.795918,4006.612245,1183.972789,213.3877551,3168.108844,817.877551,157.6598639,147,16.74283233,11.67042544,0.717032151,0.930379747,0.617647059,0.461417935
+399,24519.00971,753.1165049,499.3398058,1099.456311,21886.07282,618.7524272,642.3786408,1637.126214,12216.84951,541.3446602,1207.970874,1860.014563,16618.81553,1178.820388,6104,4766.601942,6002.961165,1187.179612,370.1213592,5381.145631,11128.21359,1315.703883,498.0242718,776.2184466,12864.68932,455.7330097,114.3058252,5542.640777,11161.48544,1564.364078,1080.975728,2821.446602,8886.199029,548.2815534,259.461165,9289.004854,7053.165049,1249.145631,405.776699,1339.300971,5218.325243,752.1116505,158.7961165,3904.956311,4290.024272,1164.830097,214.7475728,3249.864078,564.8640777,156.6456311,206,21.47257398,13.06898957,0.793449283,0.817460317,0.597101449,-1.277633334
+400,19458.72566,738.3274336,500.8672566,1086.061947,17189.99115,585.1238938,1153.513274,1618.522124,8777.964602,481.8672566,1499.451327,1811.159292,12680.95575,1140.920354,6367.734513,4887.99115,4775.159292,1139.106195,363.5929204,7841.646018,8293.566372,998.5221239,102.2477876,943.7610619,10387.47788,433.5575221,116.6548673,4753.787611,8555.327434,1983.787611,802.7964602,2787.584071,6825.247788,543.3451327,252.159292,11947.40708,5255.309735,1184.681416,391.7876106,1335.814159,3508.787611,649.8584071,154.8672566,4883.362832,3042.964602,1127.840708,297.5132743,3163.80531,912.5309735,157.7610619,113,16.60609167,8.897601615,0.844342725,0.911290323,0.664705882,-0.027139735
+401,28998.00909,778.1909091,487.0454545,1074.509091,25126.29091,644.7272727,863.3,1570.763636,14733.05455,575.6727273,1661.2,2034.372727,19834.30909,1228.936364,7443.709091,4102.318182,7289.336364,1232.781818,388.0818182,3429.781818,13204.38182,1385.427273,150.3454545,1147.272727,16206.34545,398.7454545,183.0363636,4255.290909,12945.2,1881.218182,895.3272727,2831.290909,10563.84545,596.3818182,281.7181818,7257.8,8423,1035.654545,426.4636364,1319.054545,6319.627273,625,163.7818182,2930.372727,5227.1,1226.790909,254.5727273,3194.472727,509.9636364,157.8272727,110,14.67376617,10.57786202,0.693071421,0.814814815,0.528846154,-0.998629909
+402,21509.32821,726.1230769,502.1589744,1090.579487,18889.54359,585.2205128,557.7538462,1593.517949,11052.12821,513.7538462,808.6205128,1848.138462,14889.50769,1135.287179,6386.764103,3327.805128,5514.687179,1156.687179,354.9128205,4012.974359,9953.482051,3615.225641,163.2923077,573.7128205,11997.2359,390.825641,118.0102564,5753.661538,9672.164103,1513.384615,1094.851282,2874.579487,7852.312821,546.1948718,257.2666667,12784.25641,6354.692308,961.6051282,390.3435897,1325.738462,4740.85641,625.3897436,172.5282051,3929.333333,3843.030769,1155.774359,222.5589744,3163.189744,521.6205128,161.4717949,195,20.94928928,12.11145347,0.815943287,0.902777778,0.663265306,0.095185494
+403,17695.67568,741.9864865,549.7567568,1089.067568,15493.89189,612.527027,779.6216216,1622.567568,8939.567568,522.9324324,1647.324324,1805.486486,12237.16216,1163.351351,7856.716216,5275.635135,4581.5,1172.27027,380.7702703,6317.513514,8167.22973,495.7027027,676.8108108,797.1621622,9653.432432,384.472973,112.3243243,8142.527027,8454.945946,1676.527027,999.2297297,2802.094595,6929.189189,564.027027,280.2027027,26634.14865,5476.959459,1486.540541,406.0135135,1376.635135,4005.824324,888.8243243,157.7837838,6274.22973,3514.445946,1199.364865,450.1621622,3251.621622,578.2162162,155.972973,74,11.35966266,8.493781941,0.664020603,0.973684211,0.616666667,-0.528347442
+404,14997.93333,738.1098039,450.1176471,1077.627451,13464.13333,600.2196078,609.3490196,1509.694118,7650.843137,494.3921569,443.4784314,1765.439216,10338.85882,1145.788235,2330.015686,1192.862745,3883.435294,1137.376471,377.345098,2748.141176,7065.678431,410.2117647,1378.121569,511,8478.211765,365.5647059,109.345098,1764.145098,7197.721569,1372.701961,711.3333333,2809,5963.647059,574.0313725,251.0470588,17771.89804,4853.282353,971.3333333,383.1333333,1395.12549,3668.737255,1222.427451,147.7372549,4044.788235,3118.917647,1202.470588,628.8941176,3139.945098,642.3411765,163.5568627,255,23.82157667,14.45529604,0.794842909,0.90747331,0.625,0.156660998
+405,24673.38953,783.0232558,499.5930233,1117.360465,21345.47674,628.4418605,647.8255814,1636.72093,11984.5,502.6337209,1476.412791,1828.22093,16891.29651,1217.30814,5940.244186,3951.30814,6094.593023,1185.104651,373.4069767,5037.732558,11174.76744,781.0465116,139.9069767,1043.802326,13503.90116,594.3372093,118.5406977,5160.534884,11576.07558,1676.47093,832.5581395,2782.965116,9443.953488,556.1046512,277.8604651,19613.70349,7279.575581,1107.046512,403.122093,1355.127907,5261.77907,733.3546512,162.505814,5593.627907,4437.430233,1224.94186,337.0872093,3194.22093,830.9593023,159.8837209,172,17.39196062,13.87896642,0.602643603,0.92972973,0.530864198,-0.854649599
+406,29535.32576,740.9015152,420.2424242,1075.469697,25551.03788,598.3409091,765.6742424,1579.5,14124.31818,499.8257576,514.8333333,1771.545455,19643.93939,1165.757576,4062.628788,2170.409091,7269.727273,1166.560606,373.969697,2635.409091,12963.7803,8913.886364,127.9924242,461.5,16033.40152,437.0681818,119.8863636,4692.833333,13757.42424,1430.386364,791.5454545,2812.939394,11244.55303,575.219697,262.8181818,7974.94697,8261.454545,1061.560606,395.7424242,1301.272727,5563.424242,658.0909091,155.6136364,2427.507576,4972.060606,1165.787879,158.0075758,3222.128788,901.5454545,156.8636364,132,15.01867841,12.05742293,0.596210041,0.874172185,0.589285714,-1.264481962
+407,25347.17361,768.8888889,464.6319444,1111.104167,21827.61111,607.0625,710.8541667,1646.284722,10990.40278,490.5625,1345.576389,1769.638889,16879.96528,1198.972222,4423.701389,2760.548611,6216.777778,1183.173611,368.3680556,4223.909722,11125.26389,2842.590278,137.4513889,533.1666667,13713.41667,425.9861111,119.2083333,3700.118056,11296.97917,1745.958333,766.3680556,2795.229167,9026.958333,553.5,260.0347222,10599.20139,6864.694444,868.7013889,398.5277778,1314.854167,4335.75,663.7222222,181.2013889,3543.013889,3911.034722,1179.625,225.5625,3218.513889,951.625,157.5972222,144,15.65103663,11.98051362,0.643462873,0.935064935,0.685714286,-1.09859708
+408,18323.90411,767.3515982,683.4611872,1092.479452,15953.9726,594.8721461,552.4703196,1551.890411,7754.182648,525.8675799,980.0410959,1807.968037,11074.21918,1139.246575,8841.484018,5693.821918,4020.150685,1146.09589,362.2511416,3324.899543,7582.6621,323.3013699,256.8858447,667.4748858,8868.69863,415.0456621,116.6255708,8207.16895,7072.936073,1698.196347,916.0319635,2796.401826,5750.319635,542.7534247,239.7945205,2439.954338,3669.191781,953.8127854,385.8630137,1290.018265,3274.812785,624.913242,157.9315068,6744.753425,2384.520548,1088.123288,203.2374429,3143.187215,271.4474886,162.109589,219,20.96806888,14.23525992,0.734229073,0.904958678,0.684375,0.01210296
+409,31525.28723,864.8617021,469.0212766,1090.255319,28429.42553,661.8404255,651.4255319,1552.659574,14174.20213,584.1702128,524.712766,1786.755319,19988.23404,1241.042553,4911.106383,1938.085106,7342.659574,1279.031915,417.3829787,2436.56383,14062.94681,602.8723404,1212.361702,483.8510638,16979.58511,602.606383,123.9255319,3180.680851,13620.53191,1586.255319,786.0638298,2835.893617,11085.37234,664.4361702,273.6382979,1454.361702,7857.393617,865.5212766,430.8191489,1331.755319,6670.244681,890.9361702,169.0319149,2472.244681,4899.797872,1250.361702,254.8085106,3214,298.6595745,160.4148936,94,14.56848479,8.722786316,0.800940797,0.886792453,0.626666667,-0.174442314
+410,39536.83117,1015.766234,518.7142857,1106.818182,33490.80519,752.2077922,770.6103896,1604.948052,18467.38961,628.5844156,475.3376623,1755.636364,24744.06494,1375.727273,5944.87013,2143.12987,8591.155844,1325.025974,406.1168831,2447.727273,16204.19481,404.5974026,380.4155844,467.5844156,19873.35065,437.4935065,127.6493506,2994.61039,15681.83117,1495.506494,790.8311688,2815.727273,12470.81818,574.7272727,282.1298701,3042.571429,9548.064935,840.5194805,460.2337662,1315.519481,7012.792208,704.4025974,167.6363636,2371.376623,5573.701299,1256.155844,177.3376623,3389.298701,444.5454545,157.4415584,77,11.64948006,8.7085173,0.664210516,0.927710843,0.592307692,1.123007967
+411,14254.09896,771.796875,477.4427083,1087.536458,12920.94792,588.1510417,501.8177083,1510.244792,7379.296875,475.25,462.3802083,1701.427083,9971,1148.34375,2028.854167,1161.026042,3676.770833,1143.40625,352.265625,2588.364583,6697.104167,400.8489583,436.2916667,463.828125,8029.088542,434.5833333,107.84375,1390.635417,6897.057292,1316.635417,583.8541667,2827.276042,5653.182292,560.1666667,247.359375,16548.30208,4591.947917,937.546875,377.7552083,1337.213542,3414.208333,901.1614583,167.8333333,3021.515625,2950.354167,1207.630208,972.53125,3081.098958,654.546875,161.6354167,192,21.17370374,12.1797254,0.817992519,0.880733945,0.6,0.456482535
+412,16535.2268,688.4536082,454.3195876,1083.010309,13972.46392,556.0309278,422.0618557,1539.051546,7666.525773,455.6804124,399.5463918,1810.762887,11294.84536,1144.298969,4409.226804,2283.206186,4134.216495,1101.927835,362.2268041,2767.670103,7123.43299,5372.783505,1368.886598,428.3505155,8759.876289,415.8969072,119.1030928,4738.360825,7719.56701,1368.824742,912.9278351,2783.773196,6265.927835,532.6597938,242.5051546,10108.29897,4867.649485,787.3298969,384.3505155,1348.969072,3337.154639,979.3298969,151.6185567,4309.958763,2838.865979,1117.061856,174.9587629,3202.659794,869.4226804,157.4948454,97,15.10011713,8.279503501,0.836276972,0.932692308,0.718518519,-1.54462586
+413,33596.46763,1072.561151,543.1582734,1110.899281,29298.47482,763.9352518,599.2014388,1617.057554,15837.91367,669.1079137,533.1870504,1769.107914,20968.89928,1381.316547,6271.597122,3380.561151,7347.374101,1316.568345,396.2230216,2662.568345,13972.43165,407.618705,385.1654676,567.6043165,16393.81295,403.8776978,125.8417266,4205.899281,13099.07194,1555.395683,736.5107914,2804.467626,10790.43885,593.5179856,283.7697842,4256.827338,8273.007194,884.0359712,439.2230216,1316.553957,6271.568345,695.3381295,170.1079137,2940.625899,4864.280576,1238.482014,269.1510791,3368.978417,458.971223,160.2517986,139,14.96764446,12.11839917,0.586927216,0.95862069,0.620535714,1.489890795
+414,18360.01869,751.6261682,538.2616822,1077.233645,15681.2243,590.6542056,496.1401869,1678.074766,8639.514019,474.6915888,398.7476636,1854.121495,12396.58879,1130.64486,5331.093458,3861.121495,4681.158879,1130.392523,378.7476636,2626.626168,8116.53271,2441.037383,420.635514,444.1682243,9788.514019,393.3925234,112.4579439,6862.429907,8451.607477,1336.495327,888.3551402,2786.140187,6780.140187,539.1495327,265.2803738,23237.57944,5254.616822,772.411215,383.0280374,1317.897196,3800.981308,862.2990654,154.9813084,4811.420561,3228.028037,1156.88785,200.0841121,3177.53271,807.8785047,160.3457944,107,15.40506501,10.20591898,0.749058272,0.87704918,0.50952381,0.850272961
+415,24319.06316,764.3578947,525.9894737,1106.831579,21097.88421,620.1157895,1314.663158,1676.652632,11398.67368,505.2842105,2104.663158,1824.094737,16215.15789,1181.305263,6146.894737,4980.105263,5874.789474,1195.378947,377.1473684,10233.4,10664.03158,799.8,111.8736842,1489.884211,13333.54737,485.3157895,119.8421053,4187.031579,10941.96842,2200,787.6105263,2800.042105,8699.336842,544.5473684,267.6736842,15449.88421,6624.578947,1565.747368,408.9894737,1365.6,4356.073684,611.7157895,164.9684211,7056.021053,3910.8,1163,388.5368421,3161.884211,922.4105263,158.7684211,95,13.58214403,9.470855759,0.716777487,0.913461538,0.659722222,-0.812140953
+416,32399,872.0380952,561.3809524,1112.952381,29095.8,671.4095238,639.5428571,1610.028571,14454,579.6857143,469.247619,1770.133333,20489.4,1251.12381,5965.857143,3474.580952,7499.419048,1295.352381,400.247619,2443.838095,14401.90476,363.9238095,495.7904762,451.3904762,17249.47619,404.752381,125.6666667,3148.961905,13789.46667,1503.07619,937.6571429,2829.314286,11251.64762,617.2190476,273.9333333,1760.609524,7764.019048,835.2190476,436.0571429,1315.304762,6722.114286,694.8666667,167.3809524,2858.561905,4911.609524,1226.8,155.0285714,3210.352381,290.0761905,161.6666667,105,15.10381497,9.168492709,0.794677707,0.921052632,0.777777778,-0.062924687
+417,28995.46296,966.2777778,529.537037,1070.731481,24379.94444,696.6111111,613.5462963,1503.685185,13161.71296,607.3148148,514.5462963,1847.481481,18533.89815,1313.425926,4477.574074,2169.027778,6673.009259,1398.925926,407.2685185,2406.888889,12400.0463,375.8425926,390.4074074,535.1111111,15155.9537,505.1851852,127.8611111,2385.175926,12924.40741,1554.046296,1059.407407,2812.101852,10427.48148,871.712963,270,1427.509259,7692.5,1023.435185,429.6481481,1331.12037,6105.925926,702.8240741,171,3427.092593,5037.305556,1308.324074,149.3611111,3422.351852,328.1574074,161.0648148,108,14.34063797,9.681647882,0.737708158,0.939130435,0.639053254,0.697433714
+418,33436.69298,1023.561404,587.8421053,1105.77193,29333.76316,746.5789474,785.6666667,1584.096491,15650.87719,653.7631579,749.7982456,1765.833333,21234.05263,1376.473684,6356.605263,4185.684211,7993.447368,1384.570175,419.4736842,2699.447368,14791.71053,406.0087719,1626.991228,567.6578947,17671.86842,506.3157895,133.0614035,4144.684211,14754.34211,1895.192982,943.6842105,2811.403509,12084.36842,684.7017544,292.2192982,1683.315789,9253.964912,1071.096491,463.8070175,1343.745614,7606.473684,1064.596491,183.254386,5138.307018,5912.754386,1374.026316,210.745614,3469.22807,350.6315789,161.2807018,114,12.63484951,11.54769197,0.405814105,0.95,0.730769231,0.046991912
+419,24419.40541,813.527027,524.2837838,1090.243243,22365.93243,648.6486486,565.1891892,1570.472973,11392.44595,546.8648649,711.6351351,1798.27027,16183.72973,1216.716216,4673.027027,5034.040541,5873.783784,1258.202703,393.9864865,2473.837838,11403.64865,364.2567568,609.5675676,506.5135135,13042.62162,424.9054054,125.3513514,4084.243243,10641.21622,1491.351351,963.5405405,2811.513514,8783.067568,842.0810811,273.6486486,2355.932432,6845.783784,968.1621622,429.1756757,1312.472973,5762.310811,816.7162162,174.8918919,8923.162162,4204.189189,1298.864865,330.9189189,3151.716216,369.5135135,158.5540541,74,11.28209572,9.277394579,0.569037923,0.891566265,0.560606061,0.897020202
+420,11486.75926,664.7083333,390.6388889,1053.421296,10200.3287,562.462963,483.2453704,1424.722222,5862.101852,462.5833333,488.712963,1784.125,8193.37037,1057.199074,3263.333333,1772.208333,3005.814815,1067.814815,393.7037037,2529.375,5413.736111,437.3472222,1679.837963,504.0462963,6439.092593,559.7453704,104.5138889,2764.259259,5527.611111,1331.013889,650.1805556,2798.583333,4457.37963,557.8194444,221.375,6723.287037,3671.981481,791.3425926,355.337963,1369.893519,2712.00463,1083.476852,145.1944444,2661.759259,2335.944444,1101.912037,165.0925926,3091.476852,669.3055556,163.712963,216,18.82910086,15.91136097,0.534701619,0.850393701,0.705882353,-0.745759441
+421,13120.84884,663.4883721,446.4767442,1032.395349,11047.48837,546.5232558,501.255814,1599.802326,6366.813953,473.1976744,394.6162791,1852.197674,9028.930233,1068.383721,4655.883721,3140.383721,3309.639535,1065.651163,366.1511628,2555.802326,5749.686047,879.372093,896.2674419,442.8023256,6963.686047,350.7209302,106.4651163,5579.965116,6024.383721,1283.790698,842.744186,2787.44186,4860.162791,513.5,226.244186,14722.56977,3954.976744,734.5,371.4186047,1324.825581,2905.988372,899.4418605,142.6046512,3994.686047,2512.767442,1107.395349,195.0813953,3352.744186,691.8139535,161.1162791,86,12.15053752,9.11241749,0.661483146,0.934782609,0.661538462,-0.116657508
+422,21964.10588,674.5882353,413.6705882,1043.529412,18645.37647,550.9764706,594.5411765,1528.152941,10924.71765,466.6823529,510.1294118,1771.094118,15626.15294,1089.717647,4350.070588,2580.564706,5849.729412,1117.905882,366.7882353,3362.564706,10033.07059,1677.105882,1066.458824,499.0823529,12344.37647,368.8,110.8588235,6681.482353,10558.84706,1359.341176,754.5058824,2780.294118,8576.929412,568.9882353,232.5764706,9173.105882,6918.729412,808.1176471,380.9176471,1322.058824,5063.682353,904.0705882,143.4117647,3229.764706,4292.6,1129.788235,166.5294118,3139.411765,748.4117647,158.9647059,85,15.23113898,7.602454801,0.866521958,0.913978495,0.566666667,1.136490048
+423,13818.01266,740.9240506,525.8860759,1079.962025,12322.35443,591.556962,502.5696203,1560.544304,6451.683544,467.9746835,472.9620253,1793.911392,9485.278481,1136.873418,5453.56962,2471.936709,3472.987342,1156.443038,352.9620253,3089.594937,6268.708861,760.5696203,113.6962025,457.6075949,7588.810127,378.6962025,113.3924051,6700.113924,6522.898734,1431.696203,739.6582278,2816.265823,5354.886076,535.2531646,291.6962025,40370.24051,4190.405063,755.9493671,383.4683544,1373.924051,2990.607595,833.4177215,156.0379747,5410.468354,2552.835443,1151.670886,236.2025316,3189.278481,850.443038,158.7974684,79,12.90865101,8.437425848,0.756817986,0.963414634,0.598484848,-0.845739896
+424,29608.87121,828.8409091,482.9924242,1129.545455,27033.54545,673.7575758,1001.295455,1744.545455,11930.55303,521.5681818,1310.439394,1806.924242,19598.2197,1254.992424,6185.371212,2996.19697,6975.522727,1249.234848,391.3333333,5438.537879,12752.00758,479.0984848,135.3106061,912.7272727,15654.45455,445.0606061,128.4772727,4927.356061,12389.37879,1991.492424,713.8257576,2804.121212,9893.333333,564.3636364,268.1590909,7904.106061,7322.5,1079.265152,412.3787879,1329.030303,4455.636364,690.6515152,161.4848485,3516.643939,4125.962121,1193.469697,327.2651515,3190.068182,991.1287879,162.469697,132,17.04616751,10.40088471,0.792278437,0.929577465,0.628571429,0.680945419
+425,23731.26506,1119.518072,563.1686747,1104.108434,21185.77108,752.6144578,631.5662651,1535.710843,10782.24096,633.0361446,541.1566265,1743.626506,15093.66265,1352.108434,3173.807229,1854.542169,5542.722892,1295.939759,400.9879518,2439.46988,10333.9759,358.253012,348.4096386,461.060241,12796.3494,497.8072289,129.7349398,7101.144578,10636.3012,1501.722892,769.2771084,2856.156627,8721.204819,920.0963855,276.060241,1951.373494,6345.361446,825.253012,432.6385542,1295.662651,5225.036145,688.5783133,170.5542169,3538.240964,4035.987952,1252.457831,480.686747,3245.144578,307.253012,162.1686747,83,12.61033867,8.608269757,0.730758676,0.93258427,0.768518519,-0.303241104
+426,43552.81579,930.2894737,530.7105263,1120.986842,37405.47368,757.3026316,698.0921053,1666.065789,19905.32895,624.8684211,533.8815789,1743.434211,26725.22368,1356.526316,5103.236842,3869.552632,9362.486842,1372.368421,420.4605263,2485.078947,17880.68421,420.9078947,1249.263158,473.5,21077.46053,571.7894737,133.5394737,3955.789474,17116.10526,1567.184211,949.5657895,2783.802632,13428.23684,580.1052632,291.5,2943.75,10530.77632,989.2236842,454.4868421,1340.407895,7587.881579,936.1842105,173.5657895,3656.236842,6115.421053,1311.868421,182.9210526,3291.052632,435.5789474,160.7368421,76,11.1398851,9.12835049,0.573179983,0.926829268,0.584615385,-1.501269888
+427,22602.83226,756.2903226,474.4129032,1087.251613,19659.53548,608.7741935,807.7483871,1618.335484,10453.34194,497.8774194,1030.303226,1793.535484,14841.11613,1182.032258,6012.76129,3300.96129,5350.845161,1186.954839,362.2516129,2901.8,9670.651613,1278.309677,139.6645161,603.3483871,11928.61935,402.2709677,122.5290323,5496.864516,10070.2,1576.006452,816.3935484,2790.2,8074.425806,544.0580645,261.4451613,15279.89032,6087.070968,1645.296774,399.2709677,1325.032258,4260.483871,643.0322581,154.0129032,4040.774194,3637.787097,1177.529032,233.6645161,3145.148387,890.2903226,163.5096774,155,15.03049565,13.2552574,0.471453532,0.962732919,0.691964286,0.232494037
+428,43985.92576,921.0742358,510.8646288,1113.266376,37713.42358,736.2532751,639.5938865,1636.912664,21649.15721,625,926.4366812,1789.593886,29301.75109,1380.864629,5374.104803,3052.283843,10895.93886,1414.580786,438.7467249,2497.637555,20196.78603,414.7467249,498.2663755,627.441048,24532.62445,446.5458515,140.8340611,2593.310044,19983.32751,1792.868996,873.8471616,2848.790393,16361.1048,712.0611354,305.9126638,1761.79476,12825.62445,1141.707424,482.279476,1318.0131,10032.16594,788.6244541,187.9563319,3732.934498,7963.353712,1545.20524,211.930131,3306.052402,380.2620087,165.650655,229,18.84224973,15.9977283,0.528336708,0.901574803,0.63434903,-0.644008719
+429,38523.53623,922,524.942029,1112.318841,33468.94203,767.7681159,728.3913043,1605.014493,18018.34783,616.7246377,598.5362319,1771.507246,25156.11594,1425.536232,6380.797101,3540.391304,9258.043478,1414.536232,435.9855072,2457.057971,16937.4058,436.9130435,771.1014493,654.9565217,20668.72464,408.2463768,138.2463768,3080.391304,17079.5942,1717.507246,903.1304348,2836.492754,13728.65217,686.2173913,318.4057971,4389.15942,11122.91304,1002,489.5507246,1346.608696,8286.869565,823.5797101,188.7101449,3952.521739,6876.826087,1444.797101,659.2028986,3174.101449,418.8985507,161.2173913,69,10.3220088,8.728544744,0.533778049,0.932432432,0.627272727,1.370530906
+430,20019.9026,700.8571429,473.6363636,1075.233766,17234.3961,580.7467532,509.3571429,1531.551948,9948.597403,501.2532468,1314.272727,1789.792208,13485.17532,1119.149351,5782.058442,3215.305195,5061.525974,1142.714286,378.5454545,6067.233766,9158.551948,547.9155844,1236.896104,524.3441558,10865.5974,358.512987,108.1493506,4509.545455,9209.084416,1513.441558,839.7987013,2803.74026,7470.584416,559.987013,252.8311688,17144.35065,6022.642857,1238.12987,385.0324675,1389.188312,4447.850649,979.6298701,151.1818182,5142.642857,3754.279221,1156.655844,215.5714286,3120.506494,585.1298701,163.7792208,154,15.48037674,12.77717624,0.564579206,0.98089172,0.684444444,-1.002210278
+431,21265.89143,745.76,501.68,1096.508571,18919.67429,608.2228571,551.88,1632.371429,10391.69714,496.5485714,369.1657143,1777.057143,15021,1147.525714,4130.92,3223.262857,5303.537143,1155.085714,367.3142857,2538.8,9522.508571,2467.474286,439.9257143,436.2171429,11541.74857,387.9771429,112.7714286,6439.891429,9777.697143,1288.068571,873.6857143,2779.205714,7762.051429,536.0057143,253.9371429,16899.99429,6274.08,751.9257143,381.6114286,1338.668571,4776.114286,804.72,150.6171429,4293.765714,3977.851429,1191.428571,173.1085714,3595.331429,704.0057143,164.3085714,175,16.39411521,15.03578123,0.398553635,0.853658537,0.643382353,-1.256435072
+432,18626.54639,714.6701031,489.257732,1082.061856,16081.75258,585.814433,821.1237113,1594.886598,8895.278351,472.5257732,602.6907216,1810.28866,12733.71134,1133.061856,4564.030928,2687.886598,4688.14433,1141.536082,364.556701,4736.814433,8420.659794,1186.175258,519.4948454,451.6701031,10338.04124,389.185567,113.0618557,4588.938144,9000.350515,1693.762887,815.556701,2797.804124,7157.608247,541.628866,271.3814433,25321.27835,5593.680412,916.628866,391.6391753,1413.051546,3982.391753,812.4948454,153.5463918,5052.886598,3465.57732,1166.113402,219.443299,3150.412371,856.1134021,163.9690722,97,15.58741049,8.159948842,0.852028061,0.923809524,0.532967033,-0.617108072
+433,31974.175,866.625,629.85,1108.675,28611.975,694.525,972.375,1680.125,14212,574.9,1001.975,1786.9,20372.45,1265.2,5528.6,6536.6,7195.875,1293.45,400.35,2711.025,14153.025,390.425,1118.1,576.025,17032.775,1300.125,131.425,4983.75,13767.925,1549.7,1029.4,2827.85,11059.4,661.025,287.725,2257.1,8314.6,1171.95,464.375,1351.15,7005.1,907.175,182.1,7442.075,5201.275,1322.425,409.325,3188.3,314.675,162.875,40,8.589564815,6.654275038,0.632337633,0.888888889,0.634920635,0.032224332
+434,18276.75,730.6875,499.2890625,1095.101563,16365.33594,596.5078125,635.4140625,1588.554688,9104.945313,498.6171875,1304.71875,1772.890625,12348.63281,1134.765625,5138.5,2775.140625,4590.835938,1137.773438,347.6875,3183.601563,8296.875,577.1796875,192.0859375,1355.101563,10011.5625,355.2265625,105.3984375,4212.296875,8252.226563,1617.109375,794.8671875,2812.21875,6798.671875,538.6015625,261.2734375,28719.25,5440.125,1065.367188,375.0859375,1368.703125,4160.320313,1493.796875,147.0625,5373.554688,3480.351563,1180.953125,303.9609375,3130.726563,627.40625,165.1484375,128,15.04076371,11.0976242,0.674979499,0.948148148,0.60952381,0.960374198
+435,22628.02326,743.1782946,449.3565891,1068.968992,19836.31008,592.8062016,512.2015504,1561.852713,11277.50388,504.496124,1699.612403,1783.899225,15822.85271,1153.372093,4912.604651,3215.232558,5707.589147,1165.031008,395.9767442,8242.170543,10292.30233,683.6976744,529.124031,728.8682171,12337.5814,365.5426357,114.2093023,3248.75969,10507.78295,1641.651163,731.3875969,2791.751938,8571.488372,583.5581395,251.3100775,9532.147287,6796.147287,1157.472868,394.0930233,1437.387597,5050.007752,761.1317829,155.3255814,4890.410853,4247.108527,1186.155039,305.0310078,3163.48062,745.6899225,165.875969,129,21.08247048,8.393932843,0.917321411,0.848684211,0.477777778,0.960677345
+436,23642.27203,746.8390805,486.1915709,1080.32567,20450.2069,600.045977,628.4367816,1619.45977,11672.57854,494.091954,758.5363985,1819.019157,16235.87356,1168.007663,5913.498084,3888.846743,5927.724138,1159.854406,368.0536398,3260,10450.56322,2125.766284,138.0498084,519.0804598,12654.4023,393.6398467,112.3601533,5717.83908,11010.15709,1428.850575,874.4176245,2785.796935,8754.980843,559.6360153,254.4291188,10131.04981,6751.471264,913.8045977,392.2145594,1307.704981,5061.114943,663.7471264,155.7164751,3567.517241,4254.375479,1180.693487,165.0727969,3159.888889,782.4252874,167.4559387,261,23.19379233,16.87491844,0.686042094,0.87,0.58,-1.413343359
+437,26304.0625,781.8515625,537.6796875,1096.289063,21432.875,632.4765625,852.1015625,1745.507813,10294.64063,489.78125,838.9921875,1875.640625,16746.52344,1170.671875,5371.75,4383.140625,6251.195313,1158.46875,364.75,4014.992188,10769.03906,1688.460938,122.546875,658.2265625,13289.82813,436.4921875,121.1484375,7871.1875,10772.92188,1924.679688,866.703125,2791.679688,8708.109375,548.484375,242.8359375,8089.390625,6334.8125,997.46875,388.7109375,1314.070313,3620.695313,601.734375,148.5390625,4109.382813,3472.359375,1126.367188,237.28125,3147.304688,1004.921875,164.953125,128,14.36408644,11.68504207,0.581578767,0.955223881,0.568888889,0.647063329
+438,25371.32203,736.6271186,480.3050847,1064.887006,22326.32768,605.6610169,493.1864407,1478.977401,12360.34463,523.1355932,536.6553672,1737.971751,16752.25989,1172.502825,5980.045198,3119.214689,6233.011299,1203.672316,383.4745763,2764.158192,11164.36158,681.1242938,730.1016949,499.2316384,13294.72881,391.779661,120.9435028,4548.892655,10828.0339,1457.242938,999.3615819,2816.39548,8868.028249,591.4915254,258.1638418,5149.412429,6977.180791,891.1016949,409.2881356,1336.451977,5126.338983,835.0169492,166.5084746,4702.20339,4242.225989,1182.706215,278.2768362,3185.039548,472.480226,167.039548,177,16.79094487,13.69890536,0.578262496,0.951612903,0.650735294,0.505084433
+439,19740.31609,732.7356322,549.8965517,1101.143678,16712.13218,596.7816092,500.4252874,1736.281609,9733.885057,504.6609195,425.4885057,1886.557471,13686.83908,1142.436782,5162.304598,3010.87931,4907.948276,1144.229885,345.6494253,2517.528736,8719.293103,2422.402299,151.6954023,453.591954,10298.18391,378.3103448,108.7413793,7342.425287,9181.890805,1300.385057,1056.666667,2853.436782,7389.183908,556.683908,264.0574713,25297.34483,5952.143678,769.5862069,381.2758621,1350.172414,4331.183908,722.5114943,146.5689655,4624.362069,3725.735632,1166.5,164.091954,3169.316092,603.9252874,165.4022989,174,16.03237805,14.25736786,0.457351698,0.935483871,0.639705882,-1.252536205
+440,17586.84,724.544,458.68,1078.472,15440.456,574.232,514.24,1561.992,8063.952,458.584,689.256,1783.272,11946.536,1112.104,4460.432,2723.184,4431.872,1126.784,353.344,4371.28,7796.992,3951.52,108.744,674.064,9998.24,431.504,114.976,5407.792,7889.136,1509.784,803.224,2830.304,6456.064,530.032,249.576,14284.688,4990.784,851.048,389.952,1333.48,3215.192,652.816,148.144,4551.776,2905.736,1134.912,219.616,3182.592,931.096,163.848,125,16.16278979,9.953848819,0.787863681,0.961538462,0.668449198,-1.22684167
+441,24564.45313,776.0234375,501.8125,1093.492188,21351.35156,621.84375,1117.828125,1654.46875,10434.875,497.46875,1493.351563,1756.632813,16687.85156,1199.679688,7076.320313,2621.0625,6059.5,1186.796875,372.15625,8206.78125,10841.03125,1728.710938,591.046875,798.4375,13713.83594,433.59375,119.515625,5091.695313,11462.10156,1960.03125,725.859375,2814.570313,9086.46875,573.7734375,270.1015625,17295.375,6978.601563,1303.304688,403.3125,1375.953125,4345.742188,816.0625,382.359375,4979.953125,4012.507813,1178.03125,337.4140625,3233.3125,969.140625,163.9375,128,16.86146455,10.17654691,0.797333682,0.914285714,0.666666667,-1.462143993
+442,19078.99099,714.0900901,462.8198198,1039.054054,16452.81081,586.2522523,561.1711712,1500.396396,9549.351351,485.9279279,748.1171171,1749.828829,13003.65766,1123.684685,6038.522523,4661.954955,4865.189189,1113.324324,356.9009009,4434.738739,8322.459459,845.7657658,128.5135135,690.6396396,9984.738739,450.1081081,105.3423423,3672.162162,8664,1354.297297,908.6936937,2784.63964,6928.630631,528.6576577,233.8648649,6655.414414,5381.063063,958.5495495,382.7387387,1300.171171,3959.495495,647.6396396,147.3693694,2930.918919,3329.324324,1126.693694,196.3243243,3134.666667,765.8108108,165.3513514,111,13.86591538,10.59318519,0.645248193,0.917355372,0.60989011,1.154515215
+443,17496.14286,682.0285714,454.9619048,1049.209524,15621.14286,560.6571429,514.4190476,1488.971429,8440.990476,458.2952381,362.0095238,1773.542857,12224.69524,1082.580952,4508.895238,2777.885714,4540.371429,1083.780952,363.7714286,2560.171429,7898.819048,1974.409524,506.7809524,437.2285714,9603.952381,371.4666667,106.447619,5252.457143,8189.152381,1307.771429,774.9047619,2782.885714,6592.952381,596.2761905,245.1714286,13539.86667,5234.990476,755.3619048,375.6761905,1331.52381,3847.438095,750.1428571,147.3238095,3819.390476,3240.914286,1126.733333,156.1333333,3122.809524,796.5809524,164.7238095,105,14.79396047,9.595834973,0.761102249,0.9375,0.625,0.871502887
+444,16187.8125,878.5625,549.5625,1094.25,15218.5625,733.21875,747.6875,1536.375,7198.25,563,691.1875,1809.28125,9583.40625,1273,3982.90625,4029.0625,4326.28125,1271.46875,399.84375,2463.4375,7370.96875,374.5625,2942.3125,579.1875,7936.09375,480.25,127.15625,3008.9375,6850.5625,1661.6875,906.40625,2807.46875,5664.90625,813.6875,271.53125,1656.34375,4224.375,964.5625,446.0625,1412.4375,3664.75,1363.28125,170.46875,7813.96875,2597.8125,1275.125,551.28125,3166.75,321.6875,164.9375,32,8.121660027,5.514856154,0.734109914,0.888888889,0.571428571,0.73608868
+445,33049.01613,844.5806452,434.9354839,1093.983871,29281.46774,675.7580645,604,1573.66129,15610.67742,563.2258065,713.3225806,1755.983871,21699.67742,1284.677419,1764.532258,1702.693548,8077.33871,1416.822581,406.5645161,2518.516129,15291.80645,382.1451613,379.2096774,750.1935484,18053.09677,405.4193548,125.8387097,1186,14725.30645,1648.935484,863.8870968,2883.532258,12006.12903,845.483871,300.8064516,1532.5,9401.096774,949.5,461.4032258,1372.677419,7849.983871,733.0645161,181.0322581,2554.758065,5934.387097,1347.887097,415.8225806,3103.758065,367.1935484,166.5645161,62,12.4571751,6.654460741,0.845366353,0.911764706,0.574074074,0.627377353
+446,21752.29677,717.4580645,489.4129032,1051.335484,19438.18065,589.5225806,893.2322581,1492.619355,10895.3871,521.2064516,1162.812903,1858.974194,15149.54839,1146.064516,7228.696774,3481.509677,5418.593548,1177.987097,366.2645161,3984.006452,10272.96129,2666.6,518.7806452,805.4129032,12145.96774,413.0129032,113.9483871,6600.303226,9911.503226,1780.677419,977.1741935,2818.935484,8105.793548,650.2129032,252.916129,4379.051613,6574.006452,1031.083871,406.1290323,1313.935484,4953.812903,714.2322581,158.1096774,3302.393548,4036.432258,1159.341935,250.2967742,3128.587097,505.8774194,167.0387097,155,21.15525227,9.875871896,0.884347938,0.890804598,0.679824561,1.406306658
+447,24322.83333,786.3333333,564.4444444,1135.555556,21772.86667,624.6333333,730.8333333,1663.244444,12031.54444,504.3111111,383.6777778,1786.633333,17303.34444,1196.066667,3094.688889,1769.155556,6182.877778,1183.755556,372.0888889,2475.133333,11100.46667,2320.188889,124.4,425.8666667,13353.43333,396.6333333,112.8111111,3697.244444,11464.9,1298.222222,844.8333333,2783.911111,9051.633333,553.1444444,262.8333333,11463.15556,7332.311111,732.4333333,400.5333333,1332.411111,5619.344444,727.1555556,157.7555556,4027.566667,4691.9,1229.422222,158.6333333,3709.688889,714.2333333,168.0111111,90,13.35065248,9.028245357,0.736681376,0.909090909,0.584415584,-0.465456887
+448,20699.48113,776.5283019,523.0377358,1100.966981,17069.26887,615.6415094,549.495283,1732.136792,9905.886792,493.8207547,533.0424528,1869.962264,13915.78774,1190.971698,5717.25,3427.259434,5133.485849,1185.400943,371.3349057,3135.990566,9068.264151,2497.221698,112.9009434,547.7641509,11081.22642,425.8584906,119.0566038,5655.108491,9618.985849,1406.226415,887.2877358,2799.457547,7786.051887,565.6320755,280.5141509,24462.25472,6054.5,807.5707547,407.1792453,1335.716981,4295.858491,686.2688679,162.3396226,5109.080189,3757.136792,1211.080189,188.8349057,3209.273585,840.9339623,169.5283019,212,21.02767429,14.97480846,0.702029736,0.848,0.512077295,1.234967868
+449,17889.71141,728.5167785,520.0201342,1095.33557,15164.65772,584.4026846,702.8389262,1593.926174,8389.651007,472.3691275,619.6241611,1777.134228,12153.1745,1163.90604,5437.14094,2926.691275,4538.973154,1125.308725,367.6107383,3719.731544,7802.114094,5539.114094,809.9597315,483.6644295,9663.268456,412.0805369,114.3489933,7221.973154,8414.375839,1603.375839,874.3758389,2789.630872,6705.268456,551.442953,269.4295302,26209.98658,5286.288591,883.2751678,387.4026846,1368.852349,3701.563758,878.0469799,157.6711409,6526.255034,3162.724832,1138.785235,203.7651007,3210.342282,867.7852349,167.033557,149,17.06372334,12.12212139,0.703795058,0.892215569,0.62605042,-1.277314742
+450,28825.41732,916.6771654,470.1259843,1052.259843,25258.31496,697.976378,802.1811024,1510.141732,13180.25984,605.8976378,1397.259843,1744.84252,18357.68504,1268.385827,3653.456693,2665.062992,6654.110236,1329.417323,401.1732283,2460.92126,12713.54331,373.7952756,1493.724409,916.0866142,14916.87402,1127.417323,124.8897638,1607.291339,12602.90551,1551.795276,784.9291339,2814.740157,10177.91339,670.1023622,277.992126,1454.314961,7723.188976,1336,444,1315.370079,6243.566929,1013.732283,171.7322835,4534.110236,4880.220472,1279.811024,261.4724409,3292.110236,339.2677165,168.4330709,127,14.09248679,11.55448935,0.57250072,0.947761194,0.697802198,-0.418142159
+451,20457.70952,706.6238095,419.0428571,1069.733333,17271.16667,573.8142857,609.5,1558.895238,9466.209524,471.0380952,749.0571429,1788.6,13476.50952,1185.633333,4151.633333,2716.057143,5027.980952,1142.461905,358.3047619,3836.133333,8621.928571,4973.404762,108.1761905,431.047619,10860.04762,417.8047619,115.6857143,3742.938095,9041.638095,1534.980952,811.052381,2794.161905,7378.604762,565.1333333,237.0380952,6680.152381,5660.485714,878.6857143,393.5,1307.738095,3779.290476,637.347619,146.1571429,2355.766667,3341.247619,1123.17619,155.5428571,3146.795238,903.2619048,171.0047619,210,17.87479878,15.13379646,0.532141417,0.945945946,0.726643599,-0.943647245
+452,25968.70283,734.4245283,433.8820755,1085.976415,22532.71226,594.5754717,711.8726415,1621.896226,11687.48585,474.4764151,930.3584906,1777.570755,17445.2217,1174.882075,5681.603774,3030.900943,6417.716981,1156.34434,361.2028302,4165.254717,11424.9717,1179.259434,138.8301887,448.4858491,14353.78774,424.7877358,117.7783019,5223.599057,11593.25943,1478.377358,780.8867925,2791.40566,9348.334906,549.2783019,249.9575472,8691.051887,7127.367925,837.1037736,389.2169811,1312.825472,4579.886792,662.0990566,150.5377358,3404.650943,4150,1149.226415,217.5849057,3204.377358,939.8915094,171.0896226,212,22.1661457,12.73703021,0.818422889,0.894514768,0.560846561,-0.970930454
+453,22529.79508,866.7786885,489.2786885,1054.262295,19782.27869,656.2704918,583.5491803,1452.508197,10376.78689,565.7213115,436.5901639,1717.754098,14879.19672,1243.827869,3896.918033,3043.45082,5383.04918,1246.360656,387.8032787,2433.762295,9685.303279,562.6885246,867.3442623,433.4590164,11789.41803,384.1393443,123.1393443,4341.52459,9430.942623,1398.778689,922.5491803,2808.008197,7772.467213,673.7622951,261.7295082,1778.827869,6204.385246,841.852459,421.3852459,1311.786885,4721.893443,842.5245902,172.1229508,6182.459016,3862.565574,1270.442623,554.1311475,3133.795082,407.5491803,169.3114754,122,15.97595092,10.43469885,0.757228199,0.917293233,0.677777778,-0.961066079
+454,37043.02083,945.6875,639.8229167,1137.864583,31395.60417,769.3645833,941.0625,1614.833333,17342.5,620.1145833,505.5208333,1764.239583,23768.23958,1419.114583,4760.0625,4836.0625,8515.041667,1406.708333,429.7916667,2449.677083,15661.82292,430.1979167,1707.052083,487.4479167,18407.82292,438.5833333,136.3645833,3651.8125,15525.5625,1592.135417,995.03125,2811.135417,12474.5,632.3958333,320.625,5561.666667,9831.25,913.3229167,469.34375,1363.635417,7161.53125,1111.572917,182.8645833,5683.4375,5689.760417,1366.875,416.2708333,3239.552083,425.8229167,169.2395833,96,12.42192296,10.08013018,0.584381519,0.905660377,0.571428571,0.086051658
+455,21654.97973,743.4594595,471.5608108,1058.837838,18627.47973,613.1554054,846.1621622,1493.108108,10449.12162,515.722973,1720.101351,1838.608108,14247.66216,1142.006757,6164.5,4248.081081,5245.77027,1169.486486,408.6351351,4017.844595,9464.824324,462.277027,2825.121622,1286.912162,11002.27703,1086.493243,116.722973,5375.216216,9260.972973,1528.837838,847.6959459,2802.554054,7342.635135,534.7972973,256.3513514,12053.9527,5889.439189,3133.067568,398.7837838,1361.939189,4376.216216,1361.716216,157.5067568,4915.168919,3594.608108,1149.682432,363.3716216,3183.810811,556.8175676,169.8851351,148,15.00001823,12.68268265,0.533957767,0.95483871,0.711538462,-0.018712772
+456,14896.08197,700.0491803,534.3934426,1066.655738,12964.63934,571.7213115,596.204918,1551.918033,7532.368852,493.2377049,640.8934426,1823.344262,10362.38525,1098.237705,7352.434426,4074.877049,3837.663934,1109.745902,402.8114754,5610.090164,7013.122951,587.0901639,1169.385246,630.0737705,8233.967213,377.0081967,109.352459,8333.07377,7101.540984,1373.016393,1049.516393,2794.319672,5790.819672,541.5163934,250.8934426,21949.72131,4626.606557,958.9590164,389.1065574,1391.606557,3416.598361,969.8606557,158.9918033,5429.344262,2931.319672,1141.02459,210.2131148,3176.655738,570.852459,167.5,122,14.6214684,10.77772936,0.675765409,0.983870968,0.792207792,1.239444699
+457,21031.432,718.032,428.472,1075.32,18101.824,586.872,396.168,1579.656,10218.44,499.808,358.176,1804.296,14502.328,1116.976,4343.624,2759.84,5204.664,1128.568,381.424,2466.992,9232.672,3254.816,689.752,430.936,11012.864,371.952,104.456,5098.784,9457.48,1291.24,815.64,2792.864,7615.52,539.568,238.824,5265.768,6253.56,747.32,370.048,1316.824,4574.96,776.48,145.056,2527.624,3867.752,1162.368,138.768,3204.616,683.064,169.2,125,13.68946595,11.93804783,0.489397393,0.939849624,0.686813187,-1.005599952
+458,22139.81481,731.8271605,478.7283951,1063.987654,18364.02469,569.1728395,626.4197531,1607.444444,11045.76543,490.962963,367.9135802,1794.740741,15925.91358,1144.481481,3797.62963,2770.271605,5878.234568,1136.506173,354.962963,2456,10015.12346,697.5679012,200.4814815,438.7654321,12434.28395,365.962963,112.654321,4907.864198,10724.8642,1276.802469,1063.395062,2775.888889,8690.358025,537.691358,252.1111111,9007.654321,7010.654321,723.308642,399.3580247,1324.765432,5093.691358,776.691358,152.1234568,3181.962963,4370.666667,1182.37037,214.7160494,3177.82716,725.4320988,167.4197531,81,11.54986222,9.17614615,0.607289002,0.941860465,0.736363636,1.336201546
+459,19186.20833,845.3888889,857.3055556,1143.194444,17283.30556,662.0833333,866.1527778,1734.513889,9437.180556,538.1527778,918.1527778,1843.902778,13574.02778,1253.930556,4270.083333,2943.152778,4839.347222,1282.597222,384.7222222,3452.986111,8679.569444,985.6805556,157.8888889,553.9583333,10481.63889,424.6527778,117.8888889,4628.527778,8884.222222,1496.222222,861.8333333,2805.791667,7222.611111,592.0555556,264.4166667,7723.027778,5858.972222,952.0972222,406.75,1319.361111,4361.513889,647.0972222,151.6388889,3118.402778,3673.097222,1252.791667,178.7777778,3201.875,735.9027778,168.2222222,72,9.90472066,9.537040979,0.26993574,0.935064935,0.595041322,1.252715827
+460,44864.62602,953.6097561,588.7479675,1113.747967,38313.66667,750.1788618,877.8536585,1601.01626,20747.84553,655.5365854,1127.121951,1745.203252,28248.22764,1406.96748,4503.073171,3991.203252,10173.29268,1402.918699,432.504065,2556.414634,19168.29268,424.1056911,447.8861789,455.4390244,23106.94309,796.2195122,132.4715447,2903.95122,18766.90244,1565.658537,988.1869919,2826.01626,15045.62602,615.4878049,314.2439024,2422.243902,11972.84553,1271.365854,477.0731707,1329.658537,8764.146341,746.8617886,179.0813008,2715.439024,7222.260163,1361.186992,210.9756098,3352.439024,439.2439024,169.1788618,123,16.46500092,9.655500175,0.810003002,0.92481203,0.745454545,-1.224677222
+461,28047.73077,783.1923077,486.6346154,1106.615385,23612.03846,610.6538462,545.2884615,1665.480769,13333.01923,500.5384615,383.5,1762.057692,18823.19231,1185.980769,4627.538462,3432.538462,6642.826923,1172.942308,392.3461538,2493.634615,12163,1065.192308,123.7115385,433.5384615,14797.90385,391.0769231,113.4423077,6113.403846,12724.13462,1300.442308,809.4230769,2783.711538,10038.19231,535.2692308,257.3076923,16146.48077,7794.423077,760.7692308,399.25,1306.634615,5725.538462,674.2884615,144.4615385,3400.134615,4883.538462,1206.75,152.4807692,3167.557692,805.2884615,168.5961538,52,10.61528303,6.815560205,0.766661367,0.912280702,0.52,-0.65417619
+462,28587.98305,833.7627119,457.7627119,1093.288136,26058.15254,664.2372881,636.5932203,1532.152542,13614.54237,568.0677966,487.9152542,1727.745763,19264.50847,1306.152542,2317.389831,3082.152542,6866.271186,1303.644068,407.7118644,2429.830508,13263.9661,386.8644068,527.7627119,513.0677966,15290.44068,407.1864407,124.6101695,2463.220339,12784.91525,1421.389831,866.0677966,2839.949153,10447.72881,770.5084746,300.5932203,2188.169492,8485.779661,849.1355932,448.2711864,1300.711864,6408.949153,743.7457627,178.5254237,3392.59322,5103.067797,1315.389831,878.7118644,3138.169492,417.1355932,170.779661,59,10.8492188,7.383199195,0.732721903,0.907692308,0.670454545,0.264309473
+463,38731.29134,932.7795276,515.1889764,1109.417323,32711.00787,746.8818898,622.4488189,1576.92126,18092.71654,639.7874016,562.6141732,1754.181102,24263.72441,1381.92126,5492.267717,3386.385827,8937.677165,1378.976378,420.3307087,2454.472441,15956.56693,406.0393701,136.4094488,448.8503937,19708.59055,782.5511811,126.9606299,3597.330709,15725.45669,1493.204724,905.7795276,2823.464567,12809.1811,617.1102362,286.984252,3819.464567,10019.96063,934.4015748,460.7165354,1330.700787,7452.622047,665.519685,173.1181102,3574.149606,6108.653543,1322.771654,232.7795276,3354.771654,453.1181102,171.9448819,127,17.00761409,9.680565534,0.822205955,0.933823529,0.651282051,0.679796578
+464,16593.54098,706.2786885,450.1065574,1063.229508,14533.10656,571.4590164,747.6639344,1539.868852,7713.581967,469.0655738,590.647541,1771.967213,11173.09016,1105.065574,4007.016393,2307.286885,4076.639344,1100.090164,350.352459,3346.893443,7178.844262,730.9754098,102.6639344,524.5983607,9167.303279,390.9672131,113.4344262,4180.639344,7362.786885,1391.188525,748.1229508,2797.737705,5971.885246,510.2786885,247.5491803,17547.2541,4668.811475,811.1229508,387.295082,1332.172131,3060.344262,719.3032787,151.8278689,3857.098361,2780.286885,1122.647541,224.2540984,3160.631148,918.5409836,171.4672131,122,13.37988034,11.64292398,0.492731371,0.960629921,0.726190476,0.410042722
+465,38283.25581,1000.5,509.9651163,1105.325581,33304.15116,745.1162791,899.5,1571.069767,17532.15116,649.9767442,754.2093023,1800.011628,24603.65116,1367.453488,3811.709302,2733.395349,8790.383721,1401.55814,422.1744186,2671.209302,17007.13953,408.5813953,891.2209302,795.8023256,19954.25581,419.9186047,131.2790698,2425.813953,16715.0814,1807.372093,895.4302326,2853.651163,13621.76744,626.6046512,292.2093023,1482.418605,10391.56977,1116.906977,470.4883721,1344.988372,8578.395349,851.0697674,179.627907,3330.244186,6556.895349,1365,142.4302326,3292.302326,353.4651163,171.3953488,86,12.15016753,9.355616837,0.638045093,0.945054945,0.710743802,-1.071352393
+466,16037.05405,681.0878378,430.0405405,1057.358108,13858.22973,555.6959459,466.6418919,1499,6694.304054,440.8243243,465.8918919,1734.236486,10817.71622,1071.777027,2987.195946,1674.162162,4075.506757,1094.310811,354.9256757,3090.006757,7075.837838,689.5540541,608.4324324,520.3175676,8758.398649,370.7297297,112.777027,3447.77027,7364.168919,1333.162162,715.0743243,2825.506757,6049.283784,519.3716216,238.3716216,14377.72297,4651.141892,754.9527027,365.2972973,1326.378378,2791.905405,793.2567568,164.9527027,3931.317568,2583.783784,1079.195946,214.4797297,3161.925676,978.7432432,172.4324324,148,16.32706885,12.85581445,0.61645176,0.913580247,0.616666667,0.794960233
+467,30975.4918,813.1311475,455.3114754,1089.311475,27199.36066,647.2131148,618.8032787,1573.147541,13924.44262,560.9344262,602.1147541,1785.606557,20056.72131,1218.770492,3849.245902,2428.57377,7426.57377,1307.852459,399.7377049,2494.885246,14046.96721,480.852459,593.7704918,594.7868852,16976.78689,575.5737705,125.4918033,3431.934426,13917.21311,1521.52459,934.5737705,2809.459016,11288.83607,643.9508197,272.4918033,1795.655738,8644.163934,931.8196721,447.2131148,1327.196721,7140.442623,769.442623,180.8360656,4502.967213,5400.42623,1291.032787,242.8360656,3283.721311,313.704918,171.0491803,61,9.889191302,9.369547251,0.319894019,0.884057971,0.554545455,0.407588296
+468,38000.62264,869.4339623,528.7169811,1083.811321,33622.30189,673.5283019,638.7358491,1596.150943,18240.71698,603.9056604,645,1741.037736,25664.56604,1345.811321,7949.415094,2994.924528,9207.207547,1371.415094,421.2264151,2459.226415,17872.81132,405.8113208,1068.698113,602.754717,21621.9434,454.9056604,136.4716981,2358.90566,17414.30189,1919.679245,1043.698113,2838.339623,14332.39623,655.6981132,303.4150943,1622.45283,11312.64151,1098.924528,474.6792453,1364.811321,9307.490566,955.2830189,183.754717,4755.528302,7216.924528,1391.962264,205.1509434,3161.301887,363.0754717,171.4528302,53,10.65382515,6.658193323,0.78065837,0.963636364,0.588888889,0.707765044
+469,25144.63218,744.545977,476.8965517,1094.729885,22228.63793,629.0287356,937.2068966,1574.367816,12184.28736,525.2413793,1347.097701,1780.695402,16511.53448,1156.132184,6256.471264,3378.511494,6023.477011,1177.402299,371.1206897,4333.482759,10992.45402,2916.66092,288.5689655,964.5344828,13169.48851,392.1436782,114.3793103,6356.321839,10599.85057,1908.729885,909.8390805,2806.442529,8435.609195,567.045977,257.2298851,10211.03448,6689.454023,1235.913793,406.4425287,1312.034483,4999.362069,636.4827586,156.1321839,3529.712644,4038.683908,1149.126437,232.2873563,3158.327586,535.2068966,174.816092,174,19.30033178,11.71186114,0.794837947,0.961325967,0.568627451,-0.821070775
+470,20898.69307,726.8712871,463.0445545,1068.386139,17865.66832,583.4752475,881.6534653,1599.846535,10009.05446,482.2920792,1020.960396,1816.193069,14205.48515,1147.475248,4750.693069,3486.663366,5242.945545,1144.891089,363.2178218,5923.480198,9398.143564,1390.039604,103.4009901,1133.950495,11377.0297,454.8861386,112.7079208,3579.351485,9779.673267,1598.90099,758.5693069,2793.242574,7878.608911,536.7920792,260.0891089,16239.37129,6241.252475,972.5346535,397.7029703,1357.386139,4528.108911,679.3564356,154.7128713,4983.306931,3877.193069,1167.940594,276.4257426,3163.752475,828.3465347,176.1237624,202,20.85661596,13.71215648,0.753499248,0.87826087,0.561111111,1.074069659
+471,29129.40796,748.0099502,438.8955224,1087.447761,25193.28856,601.1044776,716.4228856,1584.263682,12152.94527,477.0945274,962.6965174,1776.114428,19282.63682,1160.074627,5995.532338,3230.119403,7087.80597,1182.278607,376.039801,5198.905473,12369.32338,1004.761194,845.4378109,738.2885572,15653.67164,414.6766169,117.6517413,4798.303483,12501.31841,1726.258706,709.5671642,2807.208955,10182.40299,532.4726368,250.1393035,7898.726368,7640.0199,1084.706468,396.9104478,1315.80597,4609.054726,861.0149254,160.4875622,3988.676617,4279.855721,1141.119403,327.7313433,3173.149254,993.9402985,174.7810945,201,20.73223571,13.32328279,0.766171562,0.858974359,0.661184211,-1.559555616
+472,28045.75194,817.0775194,592.0852713,1130.124031,24482.36434,648.4651163,537.9224806,1622.627907,12879.66667,561.2713178,562.2248062,1771.713178,18176.69767,1207.44186,6330.387597,4341.914729,6720.875969,1274.589147,395.0232558,2447.658915,12657.30233,1378.953488,140.7209302,452.8682171,15274.06202,438.255814,123.503876,5078.054264,12064.82946,1507.612403,928.9147287,2803.883721,9959.643411,587.4883721,274.1472868,2221.046512,6932.643411,869.9457364,423.7829457,1299.596899,5882.767442,631.627907,170.4573643,3549.054264,4384.472868,1224.44186,163.8604651,3198.03876,283.5813953,174.4496124,129,13.35991517,12.51238743,0.350502242,0.934782609,0.658163265,0.652241373
+473,27951.85093,854.1055901,532.6024845,1097.043478,25405.04348,661.5217391,550.1801242,1570.024845,12872.50311,568.5714286,558.0993789,1737.024845,18246.2236,1231.354037,4595.31677,3640.322981,6813.832298,1298.745342,392.2546584,2436.987578,12949.22981,369.6708075,223.3850932,463.0062112,15396.13043,585.6397516,121.6521739,3725.229814,12431.90062,1468.142857,911.5465839,2807.453416,10290.08696,619.9254658,270.4285714,2362.708075,7621.198758,875.0434783,430.0062112,1306.944099,6425.571429,657.7701863,170.2857143,4754.621118,4760.204969,1245.242236,251.9503106,3305.552795,300.2795031,175.552795,161,18.44566678,11.78073892,0.769478733,0.894444444,0.638888889,-0.154313588
+474,34427.14925,973.238806,508.0298507,1077.746269,30791.31343,759.0746269,571.9850746,1549.522388,16669.92537,639.9104478,522.7910448,1780.149254,23294.53731,1410.149254,4137.089552,2951.761194,8519.731343,1417.58209,426.5522388,2414.014925,16480.68657,399.238806,999.0298507,510.9552239,20113.46269,419.4328358,134.5373134,2915.910448,16794.07463,1610.029851,912.9701493,2804.492537,13780.68657,697.7014925,288.1343284,1583.656716,10518.9403,1013.238806,478.880597,1359.716418,8372.089552,899.4029851,194.8208955,4894.880597,6670.38806,1403.895522,462.4179104,3247.149254,328.5373134,172.1492537,67,9.421473896,9.265106625,0.181434135,0.957142857,0.744444444,-0.536114211
+475,23711.40127,736.8280255,485.6687898,1092.178344,19603.08917,612.0254777,804.2675159,1606.267516,11704.18471,526.2993631,1657.299363,1784.89172,15994.88535,1169.757962,6217.853503,4034.585987,5939.770701,1204.121019,352.1210191,4939.656051,10575.92357,1006.573248,276.2738854,1102.949045,12634.71338,383.3184713,108.1847134,5989.764331,10762.84713,1675.757962,774.2420382,2811.573248,8881.719745,553.388535,254.9426752,18602.19108,7042.88535,1104.55414,378.7898089,1397.356688,5165.063694,775.866242,155.0764331,4919.076433,4391.681529,1193.783439,235.0254777,3174.694268,623.2420382,177.0063694,157,17.34893854,11.61757644,0.742684122,0.97515528,0.670940171,0.371276986
+476,21154.71014,706.0869565,442.7681159,1057.463768,18027.61594,571.4492754,490.0869565,1552.485507,10330.95652,477.4130435,401.2826087,1770.956522,14386.81884,1110.427536,5057.376812,3033.818841,5306.971014,1120.985507,358.884058,2699.23913,9362.565217,2398.710145,311.7971014,442.0072464,11457.73913,383.0724638,110.2536232,5833.572464,9795.15942,1289.927536,772.2318841,2780.028986,7897.202899,536.1014493,247.9347826,12249.81159,6263.23913,773.3623188,377.173913,1307.246377,4630.485507,788.5652174,158.942029,3014.231884,3873.485507,1151.818841,171.826087,3153.021739,761.5434783,175.5724638,138,14.50932775,12.73258692,0.479494427,0.92,0.657142857,0.183932123
+477,22168.14545,779.0454545,530.5909091,1105.481818,18003.25455,617.6545455,1111.6,1615.272727,10587.10909,503.8363636,1120.090909,1763.763636,14986.74545,1242.918182,7566.890909,3529.681818,5568.745455,1171.263636,379.7545455,5487.8,9883.881818,596.4181818,236.0272727,753.1181818,12261.35455,417.2,121.0272727,6396.5,10830.66364,1900.327273,782.4727273,2812.545455,8780.681818,563.8181818,286.6636364,26024.8,6785.227273,941.8545455,412.8545455,1406.509091,4737.463636,713.7545455,162.4090909,6426.145455,4253.845455,1213.436364,322.7181818,3204.872727,876.9363636,173.8727273,110,14.22897395,10.7928245,0.651660952,0.894308943,0.564102564,1.40876598
+478,26105.41935,762.7741935,472.9354839,1102.107527,21303.94624,604.2258065,518.655914,1712.83871,11118.88172,480.483871,478.3870968,1854,16916.43011,1169.849462,4178.698925,2850.225806,6232.096774,1161.526882,369.1182796,2849.075269,10717.31183,2068.83871,133.7204301,445.1075269,13182.2043,425.3870968,120.9032258,6189.150538,11288.36559,1434.602151,913.5698925,2787.946237,9016.688172,538.5483871,251.311828,11420.95699,6885.236559,806.7741935,393.4086022,1292.010753,4254.763441,646.9354839,155.1290323,3659.258065,3879.709677,1163.623656,163.688172,3159,962.2580645,173.6021505,93,13.02622884,10.09039308,0.632425481,0.869158879,0.603896104,0.001390173
+479,22510.38776,800.7142857,631.5306122,1233.316327,18527.83673,628.2142857,848.6020408,1945.316327,8551.918367,492.3571429,647.3163265,1836.091837,14191.2449,1156.887755,8252.826531,4746.142857,5165.357143,1160.867347,365.3877551,3246.204082,9308.836735,1365.602041,129.1530612,534.0714286,11403.2449,432.8367347,123.0612245,11467.93878,9201.683673,1637.704082,1040.091837,2806.704082,7414.938776,533.622449,257.4489796,14633.7449,5484.459184,1049.183673,386.8979592,1310.071429,3078.693878,622.3163265,159.377551,5609.540816,3038.214286,1122.397959,226.377551,3206.77551,1015.673469,173.0918367,98,12.63144695,10.33685379,0.57473041,0.91588785,0.538461538,0.852790442
+480,34121.42857,1168.530612,550.0408163,1087.408163,29959.65306,778.4285714,701.2244898,1570.857143,15544.55102,677.8163265,1073.857143,1824.591837,22202.46939,1383.326531,3782.938776,2934.795918,7616.938776,1376.979592,420.3673469,2509.714286,15210.65306,364.1020408,671.6326531,1032.040816,18499.79592,409.5510204,138.4081633,2671.795918,15106.79592,1854.959184,830.8367347,2799.081633,12377.26531,623.8367347,284.4693878,1400.795918,9345.285714,1204.816327,445.6938776,1326.204082,7518.204082,766.755102,162.2857143,3108,5919.346939,1288.163265,332.3877551,3206.306122,320.755102,173,49,9.768356751,6.585947788,0.73853745,0.924528302,0.777777778,-0.037678899
+481,27039.53543,1077.393701,591.8031496,1104.11811,24339.9685,776.2755906,630.3858268,1572.897638,12871.35433,650.9448819,554.2204724,1775.07874,17206.74803,1374.527559,5571.433071,4533.590551,6294.346457,1311.811024,406.9685039,2430.086614,11668.2126,392.5511811,679.2598425,467.8661417,13088.7874,442.7007874,126.8267717,4492.283465,10808.76378,1529.007874,1025.267717,2813.535433,8763.771654,642.2362205,286.5433071,2374.23622,6798.952756,918.6299213,442.8897638,1323.188976,5331.535433,776.7480315,172.6456693,6346.84252,4054.614173,1275.629921,386.8110236,3355.834646,390.0551181,174.1338583,127,15.92420003,10.78082969,0.735974567,0.869863014,0.574660633,-1.093382841
+482,23205.66541,730.906015,500.943609,1088.800752,19954.3985,605.3796992,555.9548872,1643.849624,11153.60526,504.6992481,530.4887218,1807.902256,15467.35714,1151.556391,5567.048872,3893.842105,5724.996241,1154.327068,348.7443609,2723.612782,10253.08647,3589.571429,148.906015,494.2067669,11930.33459,394.8834586,108.4699248,6817.958647,10368.71429,1392.62782,1142.323308,2925.672932,8401.838346,566.924812,250.5225564,11637.23308,6806.823308,793.1654135,382.5263158,1318.116541,5042.150376,699.612782,146.1654135,3878.661654,4125.548872,1166.195489,144.6503759,3176.665414,611.8045113,180.4473684,266,24.14335884,15.06847671,0.781324411,0.860841424,0.550724638,0.483596906
+483,19288.71681,736.5132743,468.6814159,1097.858407,16081.31858,574.7079646,527.3274336,1584.716814,9041.814159,472.1327434,800.1769912,1793.522124,12890.58407,1131.256637,4113.522124,3456.433628,4778.504425,1124.070796,357.2831858,3198.495575,8149.079646,3786.19469,95.53097345,552.159292,9888.575221,399.7256637,110.2212389,4169.026549,8582.858407,1493.690265,857.7964602,2814.707965,6891.584071,563.5840708,257.0884956,19333.49558,5430.132743,928.1504425,385.9115044,1326.707965,3864.389381,655.7787611,150.079646,4396.902655,3309.982301,1140.371681,181.619469,3134.831858,811.8230088,173.9026549,113,15.25918039,9.607803733,0.776886327,0.941666667,0.627777778,-1.095303168
+484,25480.34752,741.5744681,462.0638298,1090.092199,21916.3617,605.6170213,740.9716312,1689.29078,10818.23404,477.4397163,483.8297872,1802.06383,16572.75177,1161.666667,4213.460993,2654.978723,6020.255319,1160.638298,364.1489362,2781.93617,10508.34752,740.8439716,279.7021277,494.2624113,12830.13475,430.1205674,118.0567376,5828.425532,10606.04255,1422.007092,855.248227,2804.992908,8365.021277,537.0992908,258.248227,13762.79433,6538.156028,803.7659574,395.0141844,1312.510638,4222.312057,680.1205674,151.3262411,4275.808511,3698.780142,1139.851064,185.5106383,3152.191489,951.0070922,176.4326241,141,17.40989594,11.48539442,0.751524708,0.865030675,0.592436975,-1.080816764
+485,19728.02058,732.6502058,427.9958848,1081.465021,18102.06584,610.6378601,592.9259259,1562.45679,9805.399177,502.9176955,593.872428,1765.119342,13941.7284,1136.44856,3462.209877,2072.773663,4985.308642,1156.975309,364.8930041,3364.625514,9156.823045,955.8888889,514.1604938,551.0411523,10785.07819,366.5473251,109.3045267,4042.004115,9177.024691,1364.242798,692.7078189,2835.263374,7421.728395,579.4897119,249.6748971,11761.45679,6201.477366,823.3374486,380.0658436,1329.1893,4609.374486,772.9465021,151.8559671,2728.736626,3860.559671,1177.296296,190.1687243,3167.477366,672.2098765,180.1604938,243,21.29613832,14.63097429,0.726634007,0.97983871,0.680672269,0.565795048
+486,17684.13433,735.4626866,514.5074627,1055.298507,14371.34328,574.3283582,1141.955224,1583.671642,8814.134328,493.8358209,2444.567164,1805.970149,12696.31343,1127.58209,7246.373134,5230.373134,4675.134328,1224.910448,357.358209,9754.626866,7985.865672,402.1791045,118.4776119,1278.283582,9975.701493,391.5223881,111.1940299,5931.208955,8518.104478,2089.402985,798.7910448,2774.253731,7056.328358,556.5223881,252.9850746,13667.74627,5839.80597,1301.447761,380.119403,1357.298507,4183.238806,651.7910448,173.2089552,5624.970149,3670.223881,1173.656716,277.5074627,3202.686567,742.7462687,174.9850746,67,9.624072678,8.928422125,0.373282674,0.971014493,0.67,0.85689348
+487,14360.80795,678.6291391,451.5827815,1065.523179,12082.75497,551.5496689,436.7880795,1528.993377,6819.582781,457.4635762,424.9470199,1795.410596,9672.225166,1111.15894,3260.682119,1882.887417,3623.370861,1114.099338,350.2384106,2906.013245,6497.86755,662.8410596,114.6953642,481.1788079,7781.81457,363.0397351,112.1456954,4607.741722,6880.072848,1306.099338,839.0596026,2815.119205,5590.675497,519.2847682,252.9668874,18096.92715,4390.549669,726.5629139,376.1986755,1354.953642,3122.304636,674.1589404,148.2582781,4034.907285,2748.331126,1127.89404,145.0662252,3114.960265,859.0397351,176.9072848,151,15.6064591,12.64010773,0.586529355,0.915151515,0.674107143,1.135098472
+488,40040.14035,875.2982456,532.8947368,1136.877193,35704.78947,690.5263158,573.6842105,1654.561404,19019.4386,594.2631579,465.122807,1806.736842,26553.38596,1329.789474,6267.54386,3636.052632,10011.92982,1391.929825,427.1754386,2427.368421,18386.54386,400.1403509,274.3157895,439.3508772,22835.31579,434.3333333,131.6842105,4907.22807,18172.84211,1554.736842,948.0350877,2820.438596,14894.05263,607.6315789,301.9473684,1928.263158,11268.89474,927.7719298,461.8596491,1312.263158,9293.596491,698.6842105,187.7719298,4505.912281,7034.473684,1374.508772,166.6491228,3284.45614,308.4035088,177.4736842,57,11.19288377,6.900140227,0.787373978,0.904761905,0.59375,-0.192254779
+489,27389.28718,762.9076923,528.1384615,1091.410256,23795.91282,624.4102564,545.8102564,1583.635897,13416.94359,534.8769231,526.4974359,1782.871795,17829.24103,1168.164103,5177.425641,2984.861538,6580.610256,1201.235897,374.8205128,2693.882051,11700.41538,4083.317949,680.2512821,509.4974359,13993.63077,477.8,116.8871795,5650.215385,11460.85128,1435.579487,1016.030769,2805.2,9201.266667,541.4410256,257.9487179,8861.569231,7243.328205,1019.266667,410.8307692,1335.697436,5332.220513,798.0102564,159.2051282,3653.297436,4301.615385,1167.112821,173.8410256,3221.25641,544.9282051,180.4820513,195,21.18294187,12.50212139,0.807258816,0.898617512,0.513157895,-0.855823895
+490,20181.28571,767.0168067,521.9495798,1091.89916,16902.37815,595.3865546,714.8151261,1719.067227,9953.252101,515.5714286,760.7647059,1877.907563,14253.84874,1145.731092,5007.941176,4918.218487,5195.915966,1145,359.2857143,3860.823529,8795.823529,681.9663866,409.2773109,577.7815126,10702.55462,385.4705882,113.1008403,6185.840336,9216.638655,1532.957983,1050.462185,2805.428571,7310.806723,530.8403361,250.8991597,15717.2605,6067.02521,973.2689076,390.6386555,1340.554622,4382.663866,765.1176471,154.9495798,4545.97479,3754.478992,1176.159664,216.4453782,4713.218487,702.4201681,177.5042017,119,15.42465365,10.52063161,0.731290633,0.894736842,0.607142857,0.703261786
+491,19423.68045,751.3195489,532.2180451,1085.240602,17013.42481,599.3383459,704.6503759,1616.003759,9502.270677,502.6541353,821.5526316,1831.81203,13808.53383,1162.669173,5121.454887,3903.593985,4937.349624,1145.462406,359.1278195,4264.281955,8698.195489,956.3120301,376.6541353,486.8571429,10489.13158,373.7894737,112.7932331,5517.278195,9110.402256,1490.601504,1127.924812,2783.417293,7308.469925,545.5,252.6466165,12901.18421,5953.496241,947.9285714,392.2218045,1367.424812,4493.327068,845.2556391,155.5263158,5805.101504,3736.101504,1181.503759,221.2631579,3540.665414,719.5075188,180.3496241,266,21.91161975,15.85078963,0.69043281,0.910958904,0.665,-0.902902877
+492,19745.6875,676.65,419.76875,1061.75,16871.95625,561.66875,389.7875,1480.25625,9805.76875,488.5,445.25625,1727.94375,13543.5625,1084.06875,4085.13125,2708.125,4844.3125,1108.3875,353.85625,3489.8625,8872.125,1945.99375,750.1625,526.10625,10374.39375,360.675,109.025,3779.20625,8954.6625,1309.2125,810.46875,2782.8125,7418.45,541.18125,248.35,7959.70625,5848.4125,785.5625,378.61875,1326.81875,4190.0375,804.3375,147.80625,2388.99375,3645.74375,1122.89375,155.15625,3138.63125,582.125,178.85,160,15.16796245,13.42098786,0.465924078,0.958083832,0.761904762,1.384298412
+493,15703.82081,728.7687861,484.5895954,1068.138728,14284.95376,596.3583815,480.0982659,1622.086705,8157.462428,497.1965318,408.416185,1824.549133,10946.94798,1132.248555,4852.433526,3154.791908,3927.618497,1135.011561,371.1560694,2526.283237,7363.34104,1938.543353,808.2369942,442.9132948,8631.919075,376.1907514,106.2716763,5622.809249,7401.271676,1345.063584,959.6300578,2800.040462,6031.855491,561.2601156,245.0693642,12421.78613,4851.895954,761.1791908,379.265896,1320.16185,3610.67052,844.8092486,145.3410405,4836.098266,3051.427746,1189.16185,165.5433526,3179.086705,651.7398844,178.7919075,173,16.23596959,13.67350396,0.539206575,0.97740113,0.720833333,-1.053098173
+494,20448.89474,733.5037594,507.2105263,1069.270677,17314.65414,590,515.593985,1615.661654,9810.81203,479.3684211,822.481203,1817.706767,14296.41353,1172.157895,6463.676692,3748.240602,5252.879699,1145.721805,394.037594,5831.285714,8914.857143,2554.225564,518.3157895,770.4887218,11328.29323,412.9172932,122.556391,6145.12782,9301.233083,1504,878.2932331,2800.120301,7545.43609,533.1278195,238.3909774,13412.21805,5968.067669,955.9473684,390.5714286,1365.18797,4422.308271,816.7518797,152.9774436,4625.721805,3719.909774,1179.368421,241.0902256,3161.142857,784.5338346,180.8721805,133,17.87613874,9.917632302,0.831985595,0.898648649,0.671717172,0.063846195
+495,16717.85075,816.1940299,600.1044776,1095.61194,15247.49254,640.0149254,642.4477612,1551.492537,8193.507463,563.0746269,668.9104478,1768.970149,11088.16418,1253.283582,3658.552239,4149.41791,4548.895522,1280.925373,393.761194,2515.537313,8135.865672,379.2985075,771.8955224,568.8358209,9159.089552,470.6716418,124.1343284,3496.38806,7668.985075,1599.477612,1091.358209,2810.328358,6502.179104,1006.865672,258.6567164,2401.477612,5118.074627,939.4328358,429.6268657,1381.537313,4229.328358,810.119403,181.4029851,9395.059701,3148.940299,1265.462687,442.4626866,3219.044776,370.6268657,177.9253731,67,11.33370366,8.909525283,0.618088021,0.858974359,0.558333333,0.556140438
+496,43851.03297,909.7912088,495.4725275,1124.285714,38970.01099,732.4175824,676.1538462,1609.802198,21203.03297,621.6483516,943.4285714,1797.747253,29411.56044,1366.285714,4270.879121,4345.054945,10753.57143,1386.21978,429.021978,2442.505495,19674.84615,419.3626374,612.3956044,682.2197802,23968.10989,447.9340659,130.6703297,3685.813187,19477.21978,1785.395604,957.6263736,2821.483516,15762.97802,622.2967033,302.4615385,1862.901099,12334.27473,1280.67033,476.4615385,1308.978022,9379.626374,800.0989011,178.4505495,3945.208791,7682.648352,1388.758242,150.3736264,3266.43956,401.1758242,178.032967,91,15.43831767,8.027641946,0.854177429,0.85046729,0.56875,1.521708251
+497,42428.94915,967.1186441,702.5762712,1137.59322,37041.13559,769.5254237,699.7966102,1651.576271,20054.16949,632.5762712,473.220339,1735.813559,27445.84746,1412.050847,3662.644068,5047.627119,9486.847458,1401.084746,451.4237288,2420.813559,18292.86441,419.3389831,891.2711864,474.4915254,21906.47458,428.0338983,134.9830508,5820.372881,18267.83051,1575.728814,1378.322034,2861.389831,14785.0678,610.6271186,304.4237288,4221.474576,11649.98305,947.8135593,470.7288136,1340.881356,8565.525424,922.2372881,190.3050847,4911.305085,7047.830508,1394.59322,241.440678,3259.491525,429.8644068,178.6440678,59,11.70055465,6.412084822,0.836468205,1,0.702380952,-0.357722233
+498,39463.22973,893.7972973,515.6081081,1135.648649,34346.16216,731.8581081,735.1891892,1597.736486,18834.41216,619.2364865,641.1891892,1735.648649,25783.81757,1374.885135,5027.702703,5324.797297,9471.641892,1411.5,429.472973,2478.878378,17068.97973,447.1081081,298.6621622,516.5810811,20917.72973,627.4459459,130.6216216,3780.493243,16956.41892,1579.837838,1096.385135,2824.175676,13704.2027,686.5135135,303.7972973,3696.635135,10937.43243,1098.189189,473.0810811,1332.5,8170.756757,712.6824324,178.3513514,3573.527027,6672.777027,1386.087838,233.0945946,3267.655405,441.222973,179.3040541,148,18.5882607,10.57722018,0.822318915,0.836158192,0.528571429,-1.175521806
+499,26292.65942,766.3115942,489.6014493,1078.492754,22702.01449,623.7391304,742.2028986,1470.775362,12958.5942,548.5724638,1449.753623,1772.855072,17588.95652,1211.514493,7064.181159,3506.978261,6610.746377,1229.623188,387.9927536,5530.333333,11590.8913,1304.217391,1642.463768,961.8623188,14059.71739,406.057971,120.2246377,2963.673913,11347.33333,1955.181159,823.7753623,2827.934783,9194.297101,608.0869565,260.2536232,6088.057971,7353.369565,1161.876812,412.7391304,1410.724638,5301.985507,998.0217391,163.3115942,4404.985507,4391.101449,1185.550725,370.4637681,3114.978261,483.4492754,179.9782609,138,15.73824671,11.41944783,0.688131741,0.932432432,0.616071429,0.747407505
+500,35212.17021,846.1382979,522.6595745,1109.978723,31911.03191,724.4042553,1042.808511,1645.723404,17461.04255,602.3510638,2728.148936,1799.265957,24183.05319,1316.085106,7381.234043,4300.765957,8776.053191,1345.159574,413.0744681,5757.361702,16328.3617,1424.734043,781.5106383,1781.223404,19136.55319,618.0851064,150.9148936,4067.010638,15988.51064,2212.457447,819.6595745,2881.925532,12858.17021,617.3829787,289.8829787,5058.223404,10421.93617,1606.37234,445.106383,1352.851064,7721.404255,838.106383,175.0106383,4391.287234,6381.617021,1306.819149,379.1914894,3215.468085,505.4148936,176.6702128,94,14.16376386,8.800377455,0.783548658,0.930693069,0.696296296,-1.269369465
+501,25232.47761,763.3208955,460.738806,1082.753731,21492.05224,621.1492537,733.8731343,1545.708955,12546.35075,542.3134328,1074.947761,1798.992537,17081.91791,1184.559701,4892.507463,3600.656716,6156.850746,1212.313433,447.7313433,3135.731343,11374.12687,1174.589552,1045.88806,667.5298507,13244.77612,416.2089552,150.7164179,4759.343284,11318.35821,1563.067164,844.6343284,2814.432836,9133.462687,571.2761194,259.9253731,11027.08955,7345.485075,2328.664179,418.4626866,1332.350746,5382.485075,883.9253731,161.5746269,3980.164179,4542.223881,1220.664179,208.4477612,3232.044776,564.9104478,179.1641791,134,14.62803128,11.75489382,0.59518749,0.97810219,0.683673469,-0.760607989
+502,22738.63125,748.85,504.7125,1099.05,20355.8375,601.15,475.03125,1713.65,11096.075,507.03125,458.60625,1893.5875,15998.04375,1169.05625,3869.2,3326.50625,5704.00625,1177.80625,367.64375,2861.9,10069.2875,2744.575,298.65625,464.90625,12165.33125,387.975,113.93125,5175.03125,10313.00625,1332.3375,969.6625,2796.29375,8259.0875,537.1,244.45625,9805.04375,6886.96875,809.2375,386.98125,1310.175,5097.13125,729.9625,152.275,3792.4625,4247.9875,1181.6375,148.94375,3613.25625,692.65625,182.025,160,16.62407963,12.75301343,0.64147849,0.91954023,0.592592593,0.13200122
+503,20210.01282,767.1410256,509.5,1111.25641,18214.89744,612.6025641,617.2051282,1576.166667,10023.32051,504.1282051,688.025641,1792.666667,14638.53846,1183.666667,3138.051282,2807.641026,5136.153846,1203.294872,365.7307692,3089.24359,9323.730769,450.4230769,512.6025641,547.9615385,11169.41026,377.4230769,111.0384615,2951.512821,9611.602564,1405.641026,895.6538462,2804.666667,7813.371795,575.4871795,279.1666667,17558.70513,6339.910256,845.9487179,405.0641026,1322.653846,4781.935897,884.8717949,158.9358974,4483.923077,3993.730769,1214.358974,201.1410256,3151.794872,733.3974359,178.5,78,12.46017399,8.367296534,0.740983485,0.951219512,0.666666667,-0.249680747
+504,20435.80374,710,465.6448598,1089.140187,17539.56075,568.046729,446.2242991,1634.186916,7856.401869,440.953271,434.2897196,1753.46729,12739.39252,1067.186916,4179.261682,3339.682243,4694.915888,1094.242991,339.5327103,2704.869159,8270.943925,738.7943925,364.5700935,433.0280374,10068.19626,389.2803738,112.6448598,6402.925234,8142.785047,1364.308411,869.9439252,2797.971963,6630.261682,508.1869159,235.3925234,10391.35514,4810.168224,759.9252336,364.2897196,1311.299065,2756.71028,749.4859813,148.2803738,3566.336449,2632.046729,1055.523364,169.0373832,3129.233645,1009.140187,179.8037383,107,13.96322119,10.14219271,0.687324486,0.955357143,0.633136095,0.777295686
+505,34271.62727,860.0818182,573.5545455,1127.963636,30002.1,675.9909091,549.5545455,1669.754545,15594.45455,583.7818182,524.1454545,1793.909091,22658.83636,1243.527273,6022.736364,3734.036364,8264.681818,1308.218182,403.6272727,2516.436364,15535.79091,652.1727273,153.3818182,488.4363636,18592.83636,422.2272727,130.0454545,4538.009091,14784.54545,1505.472727,818.1272727,2819.772727,12084.65455,584.6636364,281.9454545,2005.318182,8004.345455,867.5818182,429.1818182,1301.372727,6879.272727,646.9636364,174.4727273,3648.536364,5099.990909,1230.672727,149.1272727,3231.281818,270.1181818,178.3454545,110,14.03701062,10.14586277,0.691063871,0.948275862,0.666666667,-1.528250695
+506,21428.87302,942.5555556,616.2380952,1101.904762,19186.5873,689.2063492,851.5714286,1533.746032,10119.31746,607.1428571,595.1587302,1759.888889,13755.38095,1281.031746,6396.650794,4885.492063,5638.968254,1298.904762,392.5238095,2446.063492,9798.492063,388.2380952,1789.349206,485.968254,11104.20635,455.5555556,122.6666667,3928.031746,9344.793651,1733.619048,954.4920635,2816.539683,7853.777778,611.031746,263.5079365,1995.619048,5982.396825,1009.904762,451.8888889,1346.31746,4842.777778,1092,179.7301587,8048.301587,3659.15873,1264,171.7777778,3265.587302,358.6507937,178.6190476,63,10.91767707,7.837097648,0.696212613,0.875,0.525,-1.370384358
+507,33600.71429,898.1111111,494.5714286,1091.428571,29678.80952,698.6507937,672.2063492,1575.206349,16578.49206,601.6825397,521.6349206,1747.746032,22877.38095,1344.920635,5365.063492,2915.222222,8264.619048,1354.698413,420.015873,2459.269841,16461.49206,404.968254,282.0952381,461.6825397,19244.90476,505.968254,128.5238095,2529.396825,15679.61905,1536.650794,848.3333333,2823.349206,12745.87302,628.1269841,293.5238095,1881.142857,10125.01587,940.2539683,465.3968254,1302.619048,8129.15873,681.952381,177.2857143,3337.142857,6473.68254,1360.936508,271.8095238,3388.238095,378.7777778,179.5079365,63,10.5052514,8.189675444,0.626303662,0.9,0.572727273,0.759405193
+508,40115.71429,863.2346939,517.3571429,1122.193878,35686.27551,755.5306122,901.6632653,1635.091837,19155.18367,603.2959184,911.5714286,1806.377551,26444.42857,1331.632653,6874.040816,4019.285714,9393.408163,1360.959184,418.6428571,3320.877551,17892.05102,419.6734694,1346.979592,924.4897959,21297.27551,712.877551,172.1122449,3608.989796,16939.64286,1704.5,874.2346939,2807.612245,13923.30612,613.6938776,301.4897959,3107.112245,11017.09184,1050.520408,473.2040816,1398.540816,8314.744898,969.9897959,174.9693878,4737.806122,6664.346939,1345.979592,356.1530612,3237.928571,464.8163265,179.8571429,98,12.22200818,10.5502242,0.504835995,0.924528302,0.680555556,-0.917058052
+509,30981.05556,807.7888889,498.3555556,1090.033333,27241.62222,660.8555556,1161.077778,1583.355556,15627.36667,579.4333333,2244.366667,1821.933333,20839.14444,1259.077778,8298.711111,4456.433333,8135.555556,1352.711111,400.6222222,8087.255556,14101.51111,496.5888889,546.8111111,1543.933333,17041.97778,485.7444444,129.7888889,3441.255556,13940.91111,2088.388889,831.8222222,2812.155556,11240.7,580.4222222,277.7444444,10026.15556,9248.933333,1803.944444,428.9666667,1370.366667,6727.322222,725.6111111,169.5222222,4501.2,5723,1279.1,453.3888889,3190.955556,515.3111111,179.9111111,90,12.11130561,9.756883227,0.592458089,0.947368421,0.576923077,-0.303131443
+510,24488.47368,851.6783626,574.245614,1124.099415,20896.33918,670.6023392,738.2280702,1675.80117,11572.26316,539.0116959,1124.046784,1822.380117,16484.19883,1294.526316,5020.304094,4512.19883,5934.02924,1251.760234,458.2573099,5935.526316,10595.38012,1110.035088,1235.584795,775.7017544,13017.2924,411.3918129,123.4502924,6139.666667,10910.25731,1765.309942,946.0935673,2804.005848,8723.087719,566.1578947,278.0584795,13727.18713,6781.05848,1238.25731,415.5263158,1355.356725,5144.959064,1077.707602,168.3567251,5726.181287,4255.116959,1280.935673,258.7017544,3200.245614,773.0526316,182.8128655,171,16.8595163,13.30061899,0.614510433,0.919354839,0.678571429,0.20125107
+511,18943.3,696.9818182,432.9636364,1065.763636,15878,568.1636364,530.2727273,1516.6,9118.627273,457.2454545,408.0454545,1748.590909,12881.90909,1114.145455,4117.390909,2729.536364,4763,1097.036364,350.3727273,2707.654545,8176.718182,4659.154545,114.7,457.0363636,9975.972727,398.1454545,110.9636364,6207.036364,8656.3,1365.881818,955.6909091,2779.836364,7046.809091,544.8636364,236.9545455,9491.536364,5495.845455,771.0272727,385.0818182,1294.581818,3917.727273,624.2090909,147.3636364,3361.972727,3352.990909,1118.436364,133.4272727,3165.8,794.4090909,180.4181818,110,13.66665051,10.82260502,0.610652265,0.909090909,0.604395604,0.312756629
+512,20375.92958,712.1197183,522.7816901,1090.584507,17801.6338,578.3873239,518.5,1684.929577,8649.774648,459.1267606,431.1126761,1826.478873,13392.02817,1104.802817,5278.626761,3434.830986,4931.408451,1117.922535,358.9507042,2528.690141,8608.007042,2783.415493,188.3028169,440.971831,10592.62676,419.5915493,117.8380282,7581.84507,8862.15493,1313.880282,998.8028169,2789.225352,7110.288732,515.7394366,263.471831,18804.23944,5536.06338,745.3309859,383.5140845,1317.387324,3424.443662,733.2042254,149.971831,5906.197183,3084.119718,1118.204225,181.1338028,3189.147887,970.9647887,180.6690141,142,14.1279449,13.13345589,0.368548872,0.97260274,0.596638655,1.2737347
+513,32857.71875,919.15625,505.65625,1087.351563,29171.75,706.4609375,694.59375,1539.3125,15347.17969,607.4375,468.484375,1753.484375,21499.78125,1293.179688,4414.398438,2778.921875,7966.765625,1330.125,404.484375,2433.875,14729.52344,428.828125,1233.234375,470.6875,17509.96875,428.3046875,124.1796875,2982.734375,14525.35938,1578.71875,845.40625,2805.59375,11759.8125,621.203125,281.0625,1847.601563,8903.15625,871.7109375,438.859375,1348.757813,7259.679688,963.71875,173.171875,6272.3125,5725.953125,1310.109375,219.28125,3318.726563,344.3203125,180.9609375,128,14.8117993,11.8930478,0.596054251,0.882758621,0.653061224,-0.612853781
+514,38397.82895,976.0394737,529.8684211,1130.789474,31930.42105,760.75,645.9210526,1623.315789,17601.13158,626.2894737,524.6578947,1752.171053,24525.01316,1424.776316,4797.723684,3757.052632,8775.802632,1406.144737,464.5263158,2411.289474,13765.81579,382.7894737,727.5,465.4078947,16629.25,401.1973684,128.1842105,4578.092105,13848.22368,1521.486842,853.1578947,2795.184211,11254.82895,589.5394737,297.9342105,2442.026316,8759.342105,909.0394737,434.3157895,1318.671053,6596.013158,772.0789474,174.7763158,5017.394737,5381.592105,1308.881579,227.9473684,3206.473684,413.7763158,180.5526316,76,12.90970786,8.135034004,0.77647458,0.863636364,0.575757576,0.645735228
+515,39573.47826,942.8695652,527.4057971,1116.115942,34317.72464,775.3768116,689,1614.434783,19033.66667,641.4927536,503.3043478,1727.26087,26784.76812,1466.391304,3467.42029,3715.536232,8940.826087,1429.043478,460.3333333,2493.536232,17957.6087,398.2753623,768.8550725,445.3768116,21789.75362,427.6666667,131.826087,4978.318841,18353.91304,1523.666667,983.7826087,2818.318841,15067.63768,608.7971014,305.6521739,2114.434783,12025.15942,925.5217391,473.4927536,1330.086957,8835.594203,814.9710145,184.884058,3999.275362,7426.405797,1409.347826,207.057971,3284.231884,421.9710145,180.2318841,69,11.38035202,7.96673675,0.714100607,0.907894737,0.638888889,0.295991243
+516,35972.26923,832.6794872,503.2948718,1133.615385,29139.69231,666.9871795,654.0384615,1681.948718,17478.32051,542.1282051,2537.371795,1818.576923,24148.29487,1281.910256,4717.551282,2966.679487,8705.217949,1246.410256,397.7435897,6052.589744,15737.07692,908.7692308,110.974359,891.3461538,19266.84615,420.8076923,127.5384615,3340.833333,16607.01282,1694.24359,662.2564103,2821.679487,13251.32051,583.8974359,299.2564103,19231.57692,10487.55128,1454.589744,431.4487179,1359.74359,7342.012821,652.9871795,159.2179487,3641.179487,6423.935897,1277.461538,209.1923077,3273.871795,816.8974359,181.0897436,78,13.2683526,8.342803138,0.777587615,0.917647059,0.577777778,-1.411479675
+517,42097.6875,1093.40625,597.5104167,1135.958333,36983.97917,820.0729167,725.2708333,1674.53125,19815.5625,694.0520833,562.21875,1738.729167,27497.44792,1507.75,5306.5,3548.59375,9864.802083,1514.145833,455.1875,2449.09375,18533.94792,438.5,332.1979167,453.6875,22691.26042,457.21875,141.7083333,4077.6875,18529.76042,1816.5,904.9895833,2810.572917,15308.23958,661.90625,330.6770833,1553.916667,11493.96875,1155.770833,490.3958333,1309.989583,9047.166667,722.40625,189.1041667,3102.520833,6846.90625,1448.15625,362.6041667,3390.802083,315.6875,182.7916667,96,11.98949958,10.45601686,0.489331515,0.897196262,0.666666667,-0.792157235
+518,30535.62963,871.5925926,530.7962963,1099.222222,27752.2963,704.1296296,682.537037,1601.166667,14436.90741,591.5555556,644.7037037,1739.259259,20701.12963,1345.703704,4622.740741,3463.481481,7585.62963,1361.5,412.5925926,2785.796296,14511.35185,420.7592593,1008.814815,587.3148148,17550.61111,422.4814815,135.8703704,2393.148148,14569.61111,1941.62963,814.1666667,2797.944444,11701.42593,660.7592593,310.6296296,2149.962963,9107.388889,1008.055556,469.4074074,1373.240741,7544.166667,924.5185185,186.9259259,5262.574074,5965.296296,1393.092593,218.9259259,3232.814815,335.0555556,182.462963,54,10.08362034,6.90874459,0.728406469,0.964285714,0.771428571,0.335543807
+519,19650.55319,714.9078014,466.6241135,1086.93617,16694.82979,575.3687943,591.751773,1549.893617,9270.652482,464.822695,472.3971631,1761.87234,13257.51773,1125.212766,4524.865248,2640.865248,4948.780142,1127.468085,358.0496454,3022.560284,8684.900709,3517.695035,123.751773,484.5744681,10579.35461,402.2695035,117.8014184,5495.567376,9195.446809,1317.624113,793.964539,2799.141844,7365.560284,574.2836879,275.0212766,17804.84397,5639.22695,741.1843972,383.6808511,1321.900709,4112.673759,692.2624113,150.4964539,3416.014184,3488.929078,1143.390071,159.0992908,3262.191489,874.212766,184.1631206,141,14.74776872,12.60496688,0.519116784,0.94,0.671428571,0.768327339
+520,33187.04918,1066.852459,568.6229508,1135.704918,28627.34426,771.6721311,707.8360656,1619.278689,15292.65574,669.7704918,753.6393443,1713.754098,21716.19672,1409.967213,3091.704918,3308.459016,7565.852459,1424.737705,423.4590164,2554.344262,14565.08197,399.8032787,996.6393443,567.1639344,17987.96721,489.3278689,131.2786885,4067.229508,14772.68852,1690.737705,863.7213115,2815.114754,11859.5082,613.2786885,300.0655738,1701.47541,9352.196721,1065.032787,473.442623,1338.016393,7501.491803,877.6229508,189.0163934,4102.327869,6037.737705,1381.327869,397.3278689,3272.311475,327.1967213,183.147541,61,9.92943956,8.088408664,0.580039092,0.924242424,0.677777778,0.041398377
+521,45845.80795,889.1589404,502.1324503,1124.198675,39854.2649,755.218543,688.807947,1631.596026,22507.46358,643.4437086,528.9668874,1773.092715,30940.29139,1397.735099,5646.562914,3725.271523,11359.65563,1432.02649,441.7682119,2457.437086,21037.07947,439.7880795,175.9470199,610.4569536,25771.70199,428.9933775,141.9668874,3644.013245,20769,1569.033113,856.8211921,2816.039735,17060.88079,686.0860927,319.8410596,3075.688742,13721.03974,916.5298013,489.2317881,1329.748344,10216.95364,706.8543046,182.8675497,4092.97351,8529.357616,1420.205298,279.1125828,3270.264901,451.3377483,186.2715232,151,18.12119216,11.4560085,0.774814659,0.883040936,0.599206349,-0.628552697
+522,27605.86538,793.7692308,480.4326923,1110.903846,24241.16346,660.4134615,1012.278846,1578.25,13689.42308,571.7692308,2452.048077,1782.115385,18473.125,1230.240385,6328.307692,4102.144231,6942.884615,1251.413462,418.7980769,5015.807692,12652.64423,1650.355769,1308.192308,1589.365385,14959.89423,404.8461538,129.6634615,2860.942308,12229.82692,2082.461538,834.1057692,2825.567308,9850.913462,595.6442308,277.9711538,9192.048077,8056.413462,2481.163462,436.6057692,1356.548077,5930.692308,950.9038462,169.1057692,4585.865385,4911.403846,1240.298077,468.7403846,3211.259615,523.8557692,184.5576923,104,16.08713765,9.317612755,0.81518801,0.920353982,0.590909091,-1.240857526
+523,17515.02105,733.4421053,480.3368421,1075.389474,14762.88421,574.4947368,472.1684211,1509.684211,8645.557895,475.3684211,416.7684211,1779.526316,12443.6,1126.094737,4738.663158,2983.578947,4508.894737,1141.789474,361.4105263,2811.442105,7844.684211,3508.221053,390.1157895,465.1368421,9666.631579,383.4105263,110.6210526,6722.452632,8236.484211,1266.252632,898.1473684,2783.905263,6785.4,562.2631579,246.4421053,10926.75789,5512.821053,746.7578947,384.6315789,1314.536842,3944.473684,709.1684211,156.6631579,3419.368421,3432.526316,1152.389474,175.5263158,3130.610526,748.3684211,185.8210526,95,13.81473159,9.221578627,0.74459388,0.922330097,0.633333333,0.20162307
+524,35587.12389,920.3185841,710.1769912,1171.973451,30505.04425,731.4955752,599.9292035,1743.132743,15272.69912,594.0973451,557.920354,1812.637168,22044.38053,1287.070796,8253.725664,6527.309735,8038.345133,1332.743363,411.8849558,2438.99115,15060.89381,374.1061947,637.7522124,589.0884956,17605.9115,424.5044248,166.1504425,7218.946903,13919.74336,1550.628319,790.4955752,2826.415929,11222.38938,598.4424779,286.380531,3347.106195,7148.610619,846.6460177,441.1946903,1300.929204,6114.858407,737.8938053,166.5752212,3361.79646,4555.460177,1225.646018,185.8230088,3195.238938,255.2389381,184.5132743,113,16.50963196,9.868283917,0.801698309,0.81884058,0.604278075,1.526168996
+525,39006.00645,900.4129032,565.2451613,1106.045161,34626.6129,693.1290323,690.5548387,1613.954839,18641.39355,601.3935484,598.4516129,1768.16129,26189.11613,1309.722581,7039.858065,3181.23871,9563.832258,1372.387097,420.0645161,2449.380645,17976.65161,419.1612903,155.5032258,502.7096774,21828.32258,441.9612903,135.3419355,5024.187097,17304.63871,1534.174194,955.3354839,2822.187097,14448.56129,587.083871,300.6580645,1692.716129,10005.65806,894.0387097,447.8258065,1309.051613,8187.083871,638.1096774,169.2580645,2946.825806,6262.541935,1277.516129,137.5032258,3293.929032,277.0064516,187.6322581,155,17.76605766,11.34714156,0.769457697,0.962732919,0.569852941,-0.666330748
+526,37814.11667,914.6416667,519.4166667,1085.3,32450.48333,707.9833333,601.2083333,1526.5,18553.00833,597.7083333,481.9583333,1735.683333,25329.625,1311.583333,3600.408333,2590.466667,9340.891667,1433.316667,406.5666667,2438.108333,17225.01667,392.5833333,674.1666667,468.15,20915.13333,411.4333333,125.5916667,3824.625,17111.39167,1588.016667,1012.266667,2862.875,14264.15,709.9666667,289.8416667,2115.275,10982.63333,903.8833333,463.1583333,1343.316667,8623.7,816.2833333,178.375,6012.091667,7030.083333,1339.633333,151.6916667,3329.35,366.0583333,186.9666667,120,14.80038942,10.84172115,0.680735339,0.930232558,0.625,-0.096172197
+527,53880.94737,1018.289474,554.7894737,1178.342105,46121.42105,790.6052632,742.3157895,1742.394737,25813.15789,667.2105263,473.1578947,1736.421053,35716.07895,1476.157895,3623.894737,3947.315789,12375.86842,1482.815789,445.8947368,2467.394737,23676.68421,440.0526316,439.2894737,476.7368421,28968.84211,449.2894737,139.1578947,2469.552632,23948.02632,1619.342105,1027.710526,2857.236842,19361.92105,639.1052632,328.1842105,2031.236842,15174.34211,946.3157895,506.5789474,1322.842105,11578.44737,761.8947368,190.6315789,3569.921053,9373.052632,1437.184211,135,3339.552632,387.7368421,183.0263158,38,8.597197279,5.686607638,0.749990137,0.926829268,0.678571429,1.127409693
+528,32400.40187,801.1401869,503.0654206,1081.102804,29374.00935,700.411215,952.4299065,1569.158879,16007.60748,569.1401869,2189.570093,1803.53271,22427.27103,1267.925234,6536.803738,3657.971963,8067.738318,1305.233645,421.5981308,3580.242991,14996.43925,421.1401869,947.0654206,3059.82243,17949.20561,1181.009346,629.4392523,5194.429907,14721.6729,2153.46729,803.7570093,2824.878505,11821.24299,621.0841121,276.9345794,3708.738318,9735.682243,1179.11215,437.9439252,1340.757009,7218.962617,876.2990654,174.364486,8416.140187,5984.785047,1280.233645,347.6635514,3229.607477,502.2990654,185.2429907,107,15.9893987,9.363920221,0.8105763,0.87704918,0.607954545,1.536743006
+529,18043.48936,732.2836879,459.4680851,1101.70922,16171.23404,576.6028369,539.5319149,1573.929078,8940.652482,491.6879433,544.4042553,1790.822695,12909.30496,1130.553191,2213.617021,1908.907801,4683.737589,1158.021277,352.4397163,3307.744681,8253.659574,2990.744681,164.9858156,571.4397163,10009.40426,375.964539,109.1347518,2080.007092,8547.191489,1297.12766,671.4751773,2843.687943,7022.085106,570.2269504,249.8723404,9820.574468,5667.297872,791.964539,386.9078014,1331.163121,4219.375887,688.6524823,147.7659574,2544.716312,3553.021277,1178.843972,174.5531915,3145.921986,739.2411348,188.2411348,141,16.28009172,11.72704031,0.693631407,0.886792453,0.629464286,0.184635882
+530,20529.65487,736.8672566,501.8584071,1085.39823,16628.28319,607.079646,695.7964602,1647.920354,9963.672566,489.3539823,488.6283186,1833.840708,13938.93805,1136.389381,3682.920354,2162.336283,5126.681416,1160.495575,368.5221239,2959.955752,9033.371681,1651.99115,718.4513274,461.1769912,11013.83186,401.6814159,114.5132743,3000.274336,9457.088496,1426.230088,654.3274336,2794.20354,7649.389381,550.5752212,254.6371681,11866.58407,6022.486726,803.5929204,397.3539823,1335.292035,4238.628319,812.300885,157.5221239,3732.734513,3765.336283,1156.79646,148.1504425,3188.265487,836.4513274,186.3628319,113,15.12327404,10.17244366,0.739974416,0.926229508,0.588541667,-1.430454927
+531,19426.65066,728.3406114,491.8558952,1075.799127,16869.48472,583.0305677,694.4366812,1572.593886,8190.567686,465.9388646,1043.79476,1781.49345,12887.65502,1136.432314,7007.772926,3800.165939,4724.69869,1126.882096,382.1746725,4776.737991,8307.017467,415.4803493,846.0917031,758.3973799,10447.73799,396.1135371,118.7161572,8140.497817,8572.497817,1623.633188,948.510917,2800.28821,6976.80786,528.9257642,250.30131,16913.73799,5334.772926,883.8908297,384.0829694,1343.484716,3254.117904,862.7379913,187.1266376,6440.174672,3022.681223,1122.349345,244.2139738,3209.144105,984.6157205,188.9213974,229,18.42277962,15.99371734,0.496303686,0.934693878,0.673529412,1.287539484
+532,38170.50704,867.3098592,539.8028169,1102.957746,33918.53521,703.8169014,677.6338028,1608.774648,18513.32394,594.2816901,717.0704225,1779.549296,26077.4507,1312.802817,4913.014085,4514.014085,9521.633803,1366.591549,416.8732394,2455.267606,18553.42254,397.3661972,770.5211268,574.5211268,21627.4507,428.5352113,127.1549296,3605.830986,17895.90141,1740.971831,1112.830986,2817.915493,14953.8169,635.9859155,297.3943662,2101.521127,11416.90141,964.5352113,475.8309859,1317.971831,9316.887324,862.2394366,186.4225352,6115.492958,7342.521127,1375.760563,155.2253521,3263.366197,354.1408451,185.3239437,71,13.92857874,7.092822015,0.860631666,0.865853659,0.606837607,1.329854602
+533,40452.17647,870.0882353,504.7205882,1102.661765,35786.79412,701.3088235,783.4264706,1589.235294,19574.97059,611.4264706,583.3823529,1782.426471,27393.54412,1323.632353,3959.955882,5526.5,10131.04412,1361.838235,418.5441176,2489.088235,18684.47059,405.1764706,494.3676471,500.5588235,22584.19118,497.1764706,131.0441176,3275.764706,18313.57353,1512.294118,1038.647059,2824.073529,14606.77941,611.0882353,311.3970588,2708.161765,11563.66176,948.1617647,454.6176471,1328.897059,8893.735294,748.25,177.5147059,4289.397059,7248.661765,1365.161765,167.1029412,3197.955882,396.4117647,186.0294118,68,11.13013316,9.073845305,0.579108639,0.829268293,0.515151515,-0.0557517
+534,19696.02941,726.3235294,456.8235294,1106.735294,17262.31373,583.3333333,508.0882353,1615.960784,9907.166667,496.0686275,382.5,1804.647059,13735.73529,1137.519608,3931.696078,2606.333333,4913.352941,1140.098039,383.3039216,2548.470588,9054.529412,3822.872549,368.254902,435.372549,10592.81373,388.1568627,108.6862745,5657.833333,8960.5,1299.343137,901.2843137,2781.509804,7361.803922,566.1862745,243.9901961,11319.19608,5978.803922,787.2647059,371.4607843,1305.892157,4357.77451,703.5980392,146.8333333,3288.568627,3678.127451,1171.598039,143.2843137,3174.470588,663.9215686,187.1078431,102,18.59082838,7.698900229,0.91022067,0.886956522,0.435897436,0.927989109
+535,18405.11258,743.807947,487.4635762,1076.364238,15308.11921,582.1589404,660.8476821,1552.165563,8640.523179,483.794702,1031.470199,1789.81457,12269.01325,1150.112583,5896.397351,3209.350993,4617.543046,1152.225166,362.5761589,4405.768212,8142.523179,765.3112583,229.2582781,938.384106,10021.95364,403.1125828,118.2715232,4456.960265,8672.463576,1564.589404,700.7019868,2778.768212,7177.231788,543.8344371,269.6821192,22176.18543,5538.039735,1030.291391,389.9006623,1364.218543,3883.304636,675.0397351,154.6754967,4205.97351,3505.993377,1152.331126,254.3178808,3178.708609,886.7682119,188.2119205,151,16.70731359,12.23078624,0.681238215,0.94375,0.683257919,-1.24203926
+536,18072.42083,718.2833333,483.9916667,1064.666667,15081.73333,582.2541667,514.8291667,1592.808333,7947.708333,455.0583333,624.9666667,1764.75,12119.4625,1110.3,4532.4375,3033.370833,4491.216667,1143.725,355.9833333,3257.75,7791.991667,960.5083333,186.75,649.675,9521.945833,387.9791667,113.1125,4047.6125,8246.808333,1436.670833,832.4833333,2813.9125,6525.85,531.1708333,261.6375,18867.8,5181.795833,898.5125,379.05,1330.3625,3293.608333,628.2875,153.5666667,5275.283333,3028.770833,1134.4125,227.975,3161.783333,955.0208333,191.6083333,240,22.67416368,13.68286932,0.797395991,0.91954023,0.695652174,-0.143716134
+537,14709.82292,652.625,391.5208333,1029.0625,12506.89583,539.3020833,458.46875,1440,6084.614583,431.8125,646.6979167,1722.75,9557.572917,1041.552083,3700.479167,2047.989583,3667.46875,1065.927083,364.7395833,3745.135417,6288.520833,418.65625,2008.53125,575.28125,7965.583333,351.6770833,112.9791667,3410.708333,6498.166667,1495.489583,733.5729167,2804.677083,5388.114583,511.8229167,227.6145833,9348.739583,4118.15625,798.0520833,361.7083333,1327.677083,2446.760417,1118.395833,181.4479167,3899.4375,2343.229167,1044,240.34375,3066.802083,998.2708333,185.71875,96,11.67222005,10.52710991,0.431956584,0.96969697,0.79338843,0.623777795
+538,40380.02381,902.5595238,544.7142857,1119.738095,34981.09524,717.3928571,811.4047619,1678.095238,19479.30952,600.8214286,638.4404762,1776.011905,27167.19048,1331.714286,8288.083333,4283.952381,10158.85714,1399.738095,431.5119048,2447.940476,18518.52381,396.1666667,483.797619,662.202381,23344.83333,538.4761905,188.2619048,4491.428571,18365.07143,1651.488095,930.2619048,2839.202381,15470.21429,630.7261905,300.0833333,2425.47619,11340.96429,903.297619,463.6904762,1309.27381,9205.380952,746.2738095,184.202381,4080.154762,7120.27381,1380.071429,269.75,3270.702381,296.0595238,187.797619,84,11.44747653,9.624147514,0.541466714,0.913043478,0.583333333,0.92385079
+539,29362.78378,901.1216216,585.7162162,1099.418919,26303.7973,724.3918919,941.5810811,1588.5,13907.56757,605.7027027,1451.675676,1825.162162,19297.47297,1352.094595,5364.162162,6131.716216,7490.851351,1356.364865,427.0810811,2596.391892,13067.01351,414.6081081,936.8783784,1140.472973,15270.48649,1336.256757,130.0810811,4402.310811,12671.47297,1910.756757,987.5405405,2814.405405,10445.5,611.472973,291.7837838,2432.797297,8237.027027,1556.918919,446.0540541,1334.135135,6272.837838,798.2972973,173.7162162,6533.486486,5091.108108,1327.77027,272.8243243,3224.891892,404.8108108,187.5,74,12.56696966,8.716942084,0.720322662,0.787234043,0.517482517,-0.483549307
+540,16125.8945,704.9449541,478.0275229,1076.018349,14268.55046,580.4908257,492.9266055,1564.16055,8058.477064,488.1697248,378.706422,1788.853211,10985.1789,1102.83945,4863.119266,3412.857798,3985.802752,1123.298165,355.8623853,2515.100917,7468.110092,1837.963303,285.7568807,446.0366972,8671.215596,373.5458716,107.3944954,5988.5,7446.110092,1270.954128,895.3623853,2774.229358,6175.637615,529.6834862,247.0366972,15143.99083,4909.284404,755.293578,369.3944954,1322.114679,3669.623853,659.9357798,153.5779817,4712.348624,3117.802752,1161.137615,133.0642202,3161.509174,641.2385321,190.4816514,218,17.74185874,15.98906345,0.433391699,0.943722944,0.75432526,1.059027437
+541,21176.27381,745.7738095,487.5714286,1088.678571,18328.16667,600.2857143,1187.107143,1604.071429,10032.60714,496.0714286,773.4642857,1770.75,14558.79762,1161.047619,5450.916667,2853.595238,5388.452381,1139.547619,358.2619048,3826.52381,9268.119048,6817.511905,122.9761905,575.0833333,11458.45238,470.3452381,112.4047619,6718.571429,9758.857143,1773.619048,846.5357143,2792.928571,7802.869048,601.4404762,255.1190476,11763.5,6308.02381,955.3095238,397.7857143,1303.761905,4544.345238,626.9047619,162.25,3687.988095,3794.309524,1174.809524,169.047619,3187.238095,800.297619,187.1547619,84,17.4700547,7.040466164,0.915199118,0.807692308,0.477272727,-1.095752855
+542,55214.46667,996.0888889,563.1333333,1180.022222,49313.91111,823.1111111,625.7555556,1892.488889,25504.77778,678.1333333,751.3777778,1832.244444,37231.82222,1455.711111,4044.355556,2590.511111,13213.86667,1510.933333,452.6222222,2456.355556,25370.64444,418.5555556,228.6888889,504.9777778,29980.37778,446.5777778,699.7555556,3128.511111,24116.02222,1633.488889,780.9333333,2848.644444,19894.4,623.9333333,336.5111111,1710.955556,13281.4,900.4,501.4444444,1322.466667,11334.46667,696.6666667,190.9111111,1834.022222,8400.466667,1375.933333,251.9777778,3249.844444,266.2666667,186.3555556,45,7.774602526,7.568616163,0.22866478,0.957446809,0.703125,-0.927295218
+543,46242.1875,927.8333333,486.5416667,1139.541667,41110.89583,750.5416667,871.125,1690.104167,22000.41667,627.7291667,466.8333333,1785.791667,31442.0625,1405.291667,4882.604167,2433.1875,11270.875,1450.9375,446.6041667,2441.8125,21999.04167,423.0416667,292.2083333,434.4791667,26501.16667,443.5833333,141.4583333,3241.625,21639.39583,1569.166667,855.5625,2835.895833,17988.39583,635.7083333,328.4791667,1794.270833,13480.70833,924.5208333,499.7708333,1327.0625,10933.4375,725.3958333,192.75,3876.1875,8416.270833,1452.0625,171.75,3398.708333,306.4375,187.3541667,48,8.822876148,7.053657115,0.600701142,0.96,0.6,0.282549258
+544,37140.14729,845.124031,524.379845,1117.852713,33091.21705,723.8372093,680.7364341,1573.310078,18295.96124,590.2015504,584.4728682,1777.193798,25276.67442,1324.24031,5500.697674,4497.689922,9011.023256,1332.953488,417.2248062,2615.325581,17063.83721,419.7131783,983.6821705,573.9302326,20316.41085,508.1627907,136.751938,3494.465116,16352.44961,1540.465116,988.6744186,2806.751938,13356.87597,604.0155039,285.1472868,2608.612403,10666.20155,924.8372093,466.8527132,1324.356589,7904.984496,885.8217054,171.124031,3609.20155,6406.023256,1339.643411,214.5116279,3195.271318,467.9302326,189.8527132,129,14.61503979,11.55467529,0.612330755,0.914893617,0.708791209,-1.028889595
+545,46194.95294,880.6705882,502.4705882,1135.517647,40557.47059,728.2352941,582.6705882,1671.2,22943.76471,623.6117647,530.5647059,1744.517647,31320.14118,1371.294118,4401.411765,3988.317647,11215.88235,1408.482353,437.9294118,2690.235294,21161.81176,478.7529412,253.8823529,530.4705882,25170.82353,420.3529412,133.8117647,2983.023529,20592.76471,1524.811765,958.0352941,2845.364706,16618.87059,645.4117647,310.2588235,5109.211765,13323.07059,921.3647059,478.6941176,1343.176471,9633.741176,688.3176471,174.9647059,2532.694118,7877.788235,1374.270588,309.5411765,3200.670588,479.4823529,188.8117647,85,12.5878093,9.146447777,0.687048497,0.944444444,0.643939394,0.918113896
+546,26168.4386,784.3157895,502.9035088,1083.842105,22685.4386,629.1140351,707.377193,1655.377193,13064.87719,533.254386,1083.885965,1823.877193,18899.97368,1219.894737,5593.394737,4687.421053,6779.192982,1202.929825,380.5175439,4822.912281,11926.31579,612.6754386,551.5438596,1072.070175,14525.87719,423.2192982,115.2017544,4029.815789,12529.5614,1496.859649,1016.245614,2806.157895,10063.18421,567.0438596,267.6052632,11257.48246,8270.482456,1158.578947,400.9824561,1352.333333,6013.763158,847.9649123,158.2982456,5574.140351,5125.745614,1234.350877,279.9561404,3501.210526,705.6315789,189.7368421,114,12.94961856,11.67887074,0.432007808,0.926829268,0.626373626,1.535125778
+547,18458.26812,705.6956522,436.6811594,1047.014493,15764.7029,568.5724638,489.826087,1517.782609,8955.072464,476.673913,387.8985507,1756.362319,12635.42754,1111.347826,3522.130435,2085.007246,4702.42029,1117.434783,359.5072464,2864.391304,8211.144928,828.9927536,622.5942029,459.1376812,10046.47101,355.1014493,109.2608696,3572.442029,8464.347826,1266.311594,791.6304348,2814.173913,6864.963768,533.3043478,243.8985507,11636.66667,5381.826087,746.9057971,369.615942,1331.586957,3982.275362,914.8115942,149.5072464,3657.84058,3304.014493,1141.550725,201.0652174,3145.050725,761.673913,189.0942029,138,16.03685388,11.22067482,0.714455822,0.958333333,0.704081633,0.851186729
+548,19355.36697,719.3027523,486.8440367,1082.972477,15803.95413,575.3944954,580.2844037,1588.963303,9093.990826,464.2477064,603.1559633,1820,12890.44954,1100.366972,3976.045872,3158.293578,4761.458716,1119.853211,355.3027523,2940.082569,8248.192661,3066.788991,116.0275229,460.1743119,9982.577982,403.7155963,114.5137615,4722.669725,8748.59633,1476.93578,939.2018349,2794.46789,7147.908257,548.266055,252.6972477,14662.33945,5493.587156,796.8256881,379.8899083,1315.073394,3886.990826,636.412844,147.5137615,4068.119266,3377.550459,1135.972477,151.6330275,3137.93578,862.5688073,187.8073394,109,16.22646742,9.36884378,0.816475295,0.825757576,0.619318182,1.346826896
+549,35084.9011,1070.489011,551.7637363,1109.098901,31828.63187,772.2637363,639.3021978,1615.384615,16898.21429,652.2582418,582.1483516,1750.412088,23053.04396,1416.631868,3913.912088,3423.835165,8245.478022,1473.648352,414.8021978,2456.131868,15340.79121,409.6538462,444.8626374,510.8076923,17641.17033,416.0274725,133.3681319,2423.89011,14459.07143,1717.818681,938.3571429,2831.912088,11715.6044,704.7802198,293.5604396,1885.104396,9241.225275,1023.241758,464.3736264,1326.467033,7287.307692,714.0769231,176.0054945,3473.296703,5699.653846,1342.483516,706.1813187,3355.384615,384.989011,191.1703297,182,19.16121561,12.34429784,0.764828831,0.914572864,0.674074074,1.178904339
+550,34591.77612,1030.328358,522.2089552,1107.208955,30749.50746,782.2537313,595.5373134,1572.223881,16322.16418,656.8358209,550.0746269,1739.19403,22687.77612,1459.313433,3344.41791,3455.791045,7590.880597,1388.41791,436.4029851,2411.074627,14611.83582,376.8955224,985.7164179,548.119403,17280.56716,381.4626866,120.2686567,3399,14773.65672,1543.373134,1142.61194,2817.985075,11911.29851,585.9552239,283.9253731,2291.104478,9535.61194,868.3283582,447.3880597,1331.776119,7182.313433,844.3134328,175.1641791,4922.074627,5867.835821,1287.970149,144.641791,3264.044776,432.5522388,188.4925373,67,10.39177123,8.366384412,0.593143096,0.943661972,0.744444444,1.419029294
+551,18269.03448,721.6810345,489.2672414,1074.474138,15563.07759,588.9051724,458.362069,1582.232759,8849.646552,491.7327586,439.5172414,1834.051724,12136.75,1105.698276,4719.758621,3739.732759,4396.491379,1121.181034,404.5431034,2632.568966,8086.931034,500.3448276,667.3362069,459.4482759,9234.827586,366.4224138,107.6724138,7178.75,8163.37069,1382.818966,1193.862069,2841.508621,6640.301724,548.4396552,244.5948276,12968.17241,5310.387931,763.0948276,370.9827586,1324.655172,3837.241379,910.6293103,149.4396552,4416.62069,3273.077586,1137.137931,165.7327586,3133.836207,603.4396552,190.4913793,116,14.23172741,10.78401751,0.652551002,0.928,0.69047619,1.125817469
+552,26007.82474,787.1649485,485.4742268,1107.371134,22895.92784,619.4020619,1076.690722,1692.938144,12209.18557,512.4329897,1679.247423,1818.56701,17829.91753,1185.082474,6442.505155,4191.072165,6454.938144,1197.948454,379.5154639,7825.216495,11438.15464,514.4845361,123.5463918,840.6907216,14743.13402,415.8865979,117.7835052,3869.989691,12101.74227,1785.907216,716.7113402,2788.402062,9798.876289,545.6185567,282.5154639,17129.63918,7601.536082,1378.14433,406.0824742,1363.134021,4859.082474,723.9793814,154.7319588,5792.793814,4566.762887,1222.42268,373.0206186,3197.969072,935.0721649,188.5463918,97,12.05067005,10.35571877,0.511391315,0.96039604,0.734848485,-1.322609557
+553,42758.09375,1073.265625,562.203125,1119.921875,38783.92188,775.09375,1114.296875,1680.5625,20257.42188,670.34375,2220.65625,1819.015625,28007.625,1422.0625,3822.984375,3338.578125,10375.60938,1446.578125,422.75,2842.609375,19803.25,423.359375,494.046875,604.703125,23592.4375,510.4375,225.953125,5037.921875,19475.125,2212.328125,791.203125,2801.359375,15950.90625,634.046875,323.171875,1640.890625,12304.29688,1776.0625,490.421875,1326.265625,10006.375,754.25,185.03125,5506.359375,7548.453125,1379.953125,308.609375,3336.5625,322.53125,190.234375,64,9.766636609,8.687248017,0.456970099,0.941176471,0.581818182,0.323770468
+554,48515,1052.319149,567.6382979,1161.765957,43402.82979,853.3617021,877.6382979,1773.617021,23283.14894,680.7446809,632.2765957,1792,33539.40426,1621.340426,5707.553191,3086.978723,11245.85106,1532.382979,469.6382979,2472.574468,17328.25532,391.6170213,887.9361702,445.6382979,20117.08511,488.5744681,132.1914894,4656.212766,16578.19149,1833.808511,844.2765957,2822.978723,13520.40426,611.2340426,301.9787234,1726.021277,10402.68085,1047.212766,438.8510638,1347.06383,7953.106383,979.2978723,187.3404255,4839.042553,6448.829787,1370.191489,294.2765957,3203.170213,411.6382979,188.893617,47,9.370106194,6.688444383,0.700342791,0.979166667,0.652777778,-0.557786686
+555,31385.70968,878.4408602,807.8602151,1158.612903,26791.03226,718.0322581,880.7956989,1761.290323,15391.02151,601.9677419,663.7956989,1864.290323,21033.55914,1331.752688,4895.344086,2626.827957,7911.591398,1370.451613,412.8817204,4530.365591,13893.3871,842.8709677,379.0645161,626.7956989,17193.07527,556.2365591,130.8924731,6968.397849,14044.55914,1629.010753,905.5053763,2846.258065,11244.06452,615.1505376,288.4301075,10477.11828,9082.408602,1142.956989,461.2043011,1388.892473,6762.537634,743.2365591,181.7849462,5921.129032,5747.591398,1332.88172,174.5913978,3278.731183,549.3010753,190.7634409,93,11.38232382,10.73083236,0.333463877,0.978947368,0.645833333,0.055328611
+556,22830.34234,785.2792793,562.1351351,1165.981982,18918.31532,622.7657658,463.8738739,1970.684685,10951.45946,498.4774775,529.954955,2034.036036,15689.16216,1209.927928,4423.774775,2762.054054,5803.783784,1183.81982,368.1261261,2918.783784,10172.86486,880.1081081,118.8378378,490.1621622,12508.81081,386.5945946,115.4414414,4669.657658,10624.69369,1346.765766,792.3513514,2811.774775,8529.306306,571.7387387,285.0540541,27986.48649,6789.63964,823.009009,402.5675676,1325.513514,4898.207207,662.4774775,157.036036,3747.369369,4158.333333,1210.18018,140.4234234,3209.738739,818.3783784,189.0810811,111,16.04793236,9.141304775,0.821904658,0.956896552,0.822222222,-1.524825732
+557,27362.31707,883.5528455,503.203252,1066.837398,24168.90244,665.7886179,608.6260163,1494.105691,13033.1626,584.2926829,575.9756098,1747.390244,18053.97561,1252.739837,3303.98374,3151.804878,7012.439024,1317.130081,400.3495935,2459.886179,12582.52846,378.4390244,858.4634146,513.495935,14821.74797,414.4634146,125.4227642,2248.650407,12274.11382,1626.195122,879.8943089,2806.634146,10030.76423,639.3252033,275.2601626,1726.552846,7807.886179,944.4146341,438.2845528,1363.552846,6247.869919,834.5528455,171.7886179,5637.390244,4907.99187,1296.520325,388.3252033,3274.926829,338.6504065,192.3821138,123,19.47577988,8.466813184,0.900558178,0.842465753,0.525641026,1.098230953
+558,23453.44531,1054.023438,597.015625,1125.3125,20541.875,823.125,572.828125,1553.84375,11125.15625,662.5234375,496.015625,1726.367188,15528.89063,1514.96875,2811.195313,2062.570313,5305.851563,1384.625,482.3359375,2418.28125,4680.34375,234.1171875,333.109375,352.7578125,7082.632813,285.3359375,98.328125,2029.601563,6162.023438,1257.140625,833.8984375,2794.953125,5368.3125,516.7890625,212.4609375,1407.898438,4547.929688,699.9453125,366.578125,1290.914063,3452.359375,748.28125,144.140625,1953.664063,2938.414063,1106.234375,153.53125,3007.71875,418.59375,193.8359375,128,14.76320727,11.28500873,0.644741253,0.962406015,0.615384615,-0.479167164
+559,40622.88636,897.1931818,476.9318182,1113.477273,35278.54545,729.5454545,688.6818182,1594.102273,19498.86364,610.75,471.2954545,1761.113636,27411.09091,1384.329545,3620.477273,3058.090909,9765.443182,1398.420455,419.3636364,2437.625,17830.65909,422.6704545,545.5795455,483.3409091,21359.86364,429.8068182,134.75,3292.761364,17623.73864,1573.397727,914,2818.636364,14197.11364,725.6704545,309.3522727,3674.431818,11277.09091,904.6022727,473.1704545,1341.75,8404.068182,795.4090909,187.6590909,3792.965909,6879.181818,1363.761364,232.4204545,3229.818182,441.3977273,192.1590909,88,13.50955242,9.055969776,0.742055675,0.907216495,0.733333333,0.006208945
+560,25240.5098,806.7843137,455.6568627,1081.539216,21974.20588,691.9705882,698.5588235,1514.264706,12478.70588,575.3333333,1171.058824,1781.980392,17231.84314,1286.676471,3497.901961,2150.813725,6453.294118,1275.5,391.6568627,3071.95098,11576.43137,415.4117647,190.7745098,1500.401961,13726.42157,558.1764706,145.8333333,1503.215686,11391.77451,1609.960784,711.3333333,2808.107843,9392.852941,646.5490196,263.6176471,6049.382353,7755.95098,1057.833333,432.9313725,1330.196078,5631.117647,645.4411765,167.5196078,3952.578431,4685.098039,1286.578431,1127.460784,3150.294118,510.8235294,192.0294118,102,12.1339698,11.09759555,0.404384624,0.962264151,0.653846154,-1.462646563
+561,29096.62179,780.0064103,486.8910256,1119.262821,25430.17308,630.9038462,719.0384615,1668.583333,13702.39103,501.2371795,1147.089744,1812.044872,20237.46795,1187.089744,4865.692308,3651.615385,7203.474359,1202.24359,374.1602564,4411.198718,12910.22436,3043.948718,117.7628205,641.25,16611.98077,432.3076923,123.2564103,5483.320513,13442.10897,1713.551282,909.6666667,2810.602564,10908.57051,557.0576923,270.6217949,10348.59615,8438.474359,1030.538462,404.6474359,1324.410256,5510.589744,708.0705128,156.0448718,3560.096154,4994.564103,1207.00641,205.9615385,3215.217949,926.5833333,193.7371795,156,21.28593332,10.49788351,0.869924974,0.816753927,0.539792388,0.692692739
+562,21597.72109,756.3877551,517.3265306,1094.687075,17690.63265,595.2585034,586.0748299,1690.115646,7953.204082,458.3877551,660.7687075,1801.081633,13362.42177,1109.29932,6240.47619,3924.680272,4888.340136,1136.040816,348.9047619,4367.034014,8548.258503,1307.795918,108.8095238,633.9931973,10321.60544,409.9931973,115.4557823,7679.55102,8301.034014,1579.387755,850.7482993,2790.571429,6809.62585,515.7142857,242.4761905,14286.4966,4829.088435,1043.326531,379.7346939,1304.244898,2716.931973,809.6734694,155.0952381,4822.612245,2602.496599,1078.197279,233.7142857,3135.92517,1027.108844,191.7278912,147,15.44182786,12.15148975,0.61705449,0.967105263,0.816666667,1.482397743
+563,40704.46377,932.8985507,668.826087,1162.666667,35439.36232,736.4637681,722.8550725,1779.463768,18244.50725,618.4347826,466.884058,1806.028986,25836.91304,1315.724638,9683.652174,5165.217391,9182.318841,1380.724638,428.4057971,2399.898551,17570.10145,384.5217391,432.6231884,499.0144928,20776.02899,421.2173913,142.4927536,6722.826087,16378.18841,1529.130435,841.1884058,2809.42029,13492.13043,591.1449275,293.7391304,2641.275362,8456.971014,828.8405797,444.5797101,1311.681159,7248.231884,690.9710145,172.4782609,3052.391304,5544.318841,1283.681159,152.5507246,3172.130435,251.2318841,192.3043478,69,11.99744454,7.737175645,0.764265298,0.896103896,0.627272727,0.916070134
+564,37314.89167,863.475,528.2416667,1108.233333,33055.25,741.9916667,1034.908333,1616.591667,18314.44167,617.0333333,1455.5,1795.8,25916.49167,1358.308333,6783.758333,4935.008333,9272.583333,1338.933333,417.3083333,4211.325,17570.16667,433.9083333,959.95,1206.066667,20706.30833,449.2083333,133.1833333,3916.666667,17067.68333,2028.691667,798.5166667,2823.541667,13917.56667,684.6,299.3583333,6324.366667,11319.61667,1360.416667,458.725,1355.283333,8296.625,919.9416667,179.3166667,4312.883333,6806.425,1350.475,452.0833333,3262.466667,500.6083333,195.5333333,120,20.04613801,8.087858926,0.914996314,0.909090909,0.46875,0.770479709
+565,28467.13761,771.1651376,463.8165138,1069.422018,23578.49541,649.4220183,998.0458716,1558.752294,13522.74312,561.9633028,1474.146789,1812.706422,18704.50459,1232.651376,5487.165138,3462.256881,6865.752294,1236.321101,415.9082569,6886.53211,12443.22936,782.6788991,921.6055046,1135.587156,14878.75229,441.0550459,120.1559633,3649.522936,12596.80734,1734.642202,815.3211009,2826.009174,10220.23853,626.146789,270.559633,8718.119266,8181.642202,1617.165138,426.8348624,1383.027523,6014.93578,839.5412844,166.4220183,3313.605505,5136.091743,1241.33945,259.7431193,3139.715596,566.9908257,192.2018349,109,13.53760763,10.54858741,0.626767694,0.96460177,0.598901099,0.792974191
+566,19032.30409,761.5087719,566.5087719,1112.660819,16748.88304,624.0409357,614.9766082,1718.74269,9437.520468,518.0818713,426.1929825,1837.888889,13189.35088,1177.584795,5287.081871,3172.678363,4749.25731,1189.269006,363.9122807,2587.678363,8894.619883,3639.982456,185.1637427,446.0877193,10290.48538,417.6140351,113.0701754,5727.883041,8813.005848,1362.865497,966.1637427,2792.397661,7248.385965,592.7660819,263.8888889,12990.50877,5816.28655,886.9473684,384.502924,1304.74269,4345.631579,636.0467836,160.3391813,4912.444444,3692,1202.25731,124.380117,3200.374269,655.9181287,195.380117,171,18.16943537,12.21598653,0.740245059,0.929347826,0.678571429,-0.174013629
+567,16239.37594,800.4285714,799.0977444,1194.609023,13726.96241,645.0075188,714.0827068,1967.368421,7766.774436,490.5488722,568.6315789,1893.172932,11247.15038,1295.962406,6208.578947,3498.781955,4178.984962,1179.451128,460.3759398,3567.796992,7221.616541,812.0977444,1742.007519,552.9473684,8744.556391,422.8421053,115.6390977,5879.578947,7582.849624,1671.481203,810.2481203,2794.887218,6159.383459,835.1654135,257.3233083,11912.33083,4773.526316,977.7969925,394.2105263,1382.105263,3442.180451,1122.022556,159.4210526,4431.421053,3002.736842,1200.977444,649.1353383,3241.849624,848.6616541,192.7593985,133,14.21370354,12.02856781,0.532761296,0.923611111,0.730769231,-0.841608189
+568,23820.76364,751.6590909,477.75,1098.818182,21334.44545,604.6363636,725.3772727,1635.55,11236.12727,475.0090909,997.5181818,1787,16483.14545,1161.209091,5056.822727,3293.936364,6027.581818,1189.018182,374.0590909,4535.277273,10551.75909,3181.545455,145.0181818,683.0545455,13393.50455,430.6454545,118.1818182,5507.568182,10860.27727,1625.918182,895.5545455,2794.804545,8809.540909,543.6409091,262.0181818,12355.75909,6824.731818,991.9,397.3409091,1333.595455,4646.259091,680.2818182,150.5136364,3579.277273,4005.8,1166.918182,177.0954545,3211.963636,915.5,197.2227273,220,21.63426047,13.3635039,0.786413059,0.93220339,0.616246499,0.537550058
+569,38959.69608,980.5686275,523.0686275,1102.54902,33030.96078,744.6764706,918.6078431,1595.480392,18209.76471,640.372549,981.3333333,1792.509804,25516.13725,1354.617647,4610.960784,3841.176471,9489.833333,1418.009804,423.0588235,2667.068627,17487.15686,415.372549,502,599.3137255,21396.71569,454.5294118,139.3235294,2635.127451,17389.82353,1600.647059,804.4607843,2812.411765,14389.07843,620.8921569,305.0196078,1688.862745,10817.70588,1114.656863,476.1078431,1320.813725,8537.127451,753.5196078,183.9215686,3966.72549,6757.54902,1380.264706,265.4019608,3418.764706,313.3823529,194.8137255,102,14.04348777,9.622476929,0.728363066,0.871794872,0.579545455,-0.052171503
+570,26849.64151,825.5471698,584.0377358,1133.754717,26117.67925,736.8113208,886.0188679,1682.886792,12420.33962,569.4339623,1307.45283,1859.981132,18929.98113,1252.924528,7222.622642,4238.641509,6499.641509,1259.962264,392.3018868,2611.811321,13972.67925,395.245283,383.6792453,930.9811321,15603.62264,430.754717,2927.018868,4926.641509,12605.62264,1757.264151,829.2830189,2879.415094,10509.64151,567.3584906,268.5471698,2025.018868,7153.075472,933.1886792,440.0566038,1314.245283,6308.981132,674.1320755,170.5471698,2735.641509,4450.207547,1208.207547,389.9056604,3220.509434,261.245283,192.9622642,53,9.167848771,7.599841951,0.559297864,0.946428571,0.6625,-0.075023442
+571,39471.60638,875.212766,486.9255319,1093.606383,36646.10638,722.5531915,863.3085106,1581.521277,19674.84043,606.8297872,1297.574468,1780.085106,27178.56383,1314.93617,3121.202128,2848.882979,9865.319149,1354.808511,417.7340426,2467.212766,19830.32979,396.893617,844.9042553,1225.617021,22867.90426,423.7340426,131.4255319,2008.595745,18843.59574,2040.829787,917.3404255,2829.106383,15848.82979,628.6702128,305.4148936,1572.223404,12324.26596,1066.680851,476.0531915,1335.43617,10101.91489,851.7234043,175.712766,3720.468085,7726.978723,1361.606383,141.7978723,3273.659574,353.5212766,192.5851064,94,15.83839534,8.297703761,0.851781003,0.886792453,0.696296296,1.55365058
+572,31641.76404,1002.280899,569.9101124,1103.314607,27549.92135,826.3146067,818.988764,1593.561798,15656.37079,645.0674157,968.505618,1805.955056,21156.37079,1374.146067,4993.213483,4522.134831,7935.033708,1341.370787,418.7640449,2493.146067,14566.67416,425.5393258,473.258427,1309.460674,17292.2809,421.011236,136.247191,3058.067416,14070.80899,1677.662921,834.988764,2828.11236,11694.95506,631.752809,276.6853933,3452.651685,9329.179775,901.7865169,439.9550562,1317.078652,6931.280899,707.5617978,171.247191,5095.662921,5763.617978,1307.191011,373.5617978,3308.651685,455.8988764,194.7865169,89,12.42023764,9.37555653,0.655884473,0.936842105,0.618055556,-0.743557074
+573,35392.17143,824.5714286,471.8714286,1081.385714,31174.45714,676.7857143,1029.871429,1527.928571,17309.22857,573.9428571,2657.957143,1757.342857,23947.68571,1282.385714,6797,4192.985714,8863.085714,1290.085714,403.8428571,4126.185714,16383.81429,919.0428571,1155.328571,2712.557143,19419.88571,435.4142857,122.9857143,2971.128571,15930.44286,2386.928571,782.2571429,2820.085714,12811.32857,607.9428571,274.7714286,3854.014286,10316.47143,1641.642857,448.4,1379.157143,7810.057143,886.3,174.0428571,5179.457143,6410.271429,1311.542857,694.0714286,3202.285714,490.9571429,194.4857143,70,12.17994197,7.488224311,0.788683311,0.933333333,0.583333333,0.447367297
+574,29424.63441,833.0860215,484.311828,1093.387097,25571.54839,701.2258065,1250.387097,1556.397849,14686.43011,592.7311828,2717.903226,1791.913978,20173.02151,1285.494624,6030.150538,2409.397849,7396.451613,1311.204301,506.344086,3660.494624,13582.7957,864.9569892,1322.946237,2012.935484,16208.29032,426.9032258,420.1075269,2616.935484,13396.27957,2145.236559,753.6451613,2820.096774,10812.32258,589.7526882,281.172043,3288.44086,8790.946237,2385.215054,449.7419355,1435.204301,6469.892473,931.2580645,170.0430108,3928.236559,5476.322581,1303.408602,283.2043011,3231.387097,524.4623656,192.9892473,93,13.98864096,8.707484952,0.782645047,0.939393939,0.794871795,1.492302018
+575,20552.98765,746.9691358,460.7098765,1084.141975,17343.64198,601.117284,399.4382716,1536.950617,10191.30247,498.0987654,342.9938272,1757.876543,14264.91358,1162.703704,3599.524691,2675.111111,5279.339506,1139.475309,380.7222222,2465.888889,9127.166667,2588.759259,1321.117284,446.3580247,11193.14198,375.5679012,110.8765432,4012.166667,9427.117284,1302.524691,886.1728395,2794.092593,7627.141975,534.5617284,246.1234568,7008.54321,6115.771605,747.4938272,382.0123457,1330.308642,4423.82716,999.7345679,151.808642,3074.969136,3730.703704,1184.240741,196.5987654,3135.5,753.5432099,197.8765432,162,15.30569858,14.03277031,0.399270784,0.947368421,0.5625,0.762470072
+576,34622.44118,902.4831933,589.0588235,1119.298319,30888.29832,726.3613445,866.1848739,1682.655462,16346.28151,603.7436975,1033.109244,1814.546218,23508.61345,1333.693277,6785.142857,4397.092437,8588.315126,1367.57563,417.0210084,2535.47479,16680.80252,401.2058824,232.7647059,1208.609244,19903.23109,487.5630252,479.7268908,4933.415966,15828.76891,1787.752101,1135.991597,2821.315126,13286.03782,629.0882353,309.6512605,2708.5,10011.09244,1130.306723,467.9411765,1319.130252,8403.243697,682.3151261,181.4453782,5392.319328,6114.907563,1354.382353,263.7773109,3306.268908,288.1638655,199.7563025,238,20.40185247,15.58057501,0.645589843,0.894736842,0.666666667,-0.046762277
+577,14348.15152,843.1212121,590.5454545,1074.969697,13363.5303,713.469697,844.6363636,1527.848485,6856.712121,563.1363636,1254.80303,1833.227273,9464.651515,1245.242424,9902.060606,5932.212121,3900.318182,1271.454545,405.4393939,2448.060606,6958.69697,368.0151515,2899.469697,840.7272727,8120.242424,974.3484848,218.9393939,4400.69697,6336.439394,1825.272727,1029.272727,2796.424242,5492.924242,616.8484848,276.6818182,3513.19697,4199.136364,983.530303,414.1515152,1344.712121,3612.287879,1275.878788,178.5454545,7816.030303,2557.515152,1255.651515,650.1666667,3307.969697,303.1818182,194.9393939,66,11.76372868,8.01114896,0.732279484,0.88,0.6,1.292997252
+578,23806.21667,741.6666667,472.5833333,1117.116667,21629.625,607.5666667,424.6,1700.591667,11816.88333,511.0416667,380.275,1802.966667,17069.99167,1190.4,4700.641667,3041.516667,6006.308333,1189.116667,362.9916667,2531.016667,11105.225,3286.733333,165.8166667,428.7916667,13321.425,388.5333333,116.8833333,5202.891667,11206.88333,1295.241667,841.25,2771.508333,8940.416667,568.925,264.8916667,17697.19167,7352.475,775.525,385.55,1308.616667,5573.908333,716.6333333,153.9083333,4098.833333,4652.25,1212.758333,138.725,3427.266667,687.4083333,196.4083333,120,14.05502779,11.18573369,0.605490105,0.923076923,0.659340659,-0.283801154
+579,23657.45022,756.2424242,520.0952381,1088.709957,20029.54113,607.7316017,903.952381,1678.632035,11244.08225,499.038961,961.7012987,1852.545455,15948.03463,1174.965368,5874.922078,3751.718615,5865.597403,1146.536797,368.2207792,3947.580087,10192.19048,605.95671,554.3030303,557.7922078,12563.86147,387.8268398,111.2554113,6020.831169,10647.25974,1614.688312,901.5064935,2805.458874,8532.380952,554.3073593,267.2510823,20002.52814,6783.52381,812.5714286,394.9393939,1359.800866,4949.281385,855.8311688,157.7619048,4492.437229,4159.593074,1186.082251,188.5627706,3236.337662,800.030303,197.9090909,231,19.95351761,15.38130911,0.637008207,0.93902439,0.715170279,-1.117464838
+580,16793.71717,693.8787879,479.7777778,1067.414141,14740.28283,584.9191919,772.9191919,1602.191919,7964.666667,468.0707071,1246.939394,1850.424242,11562.13131,1173.626263,7188.575758,4083.767677,4243.222222,1114.454545,370.9090909,5422.878788,7641.787879,901.2121212,729.1212121,681.0707071,9108.979798,389.9393939,110.6060606,5146.676768,7661.69697,1839.686869,732.4646465,2793.080808,6225.080808,563.2828283,255.6868687,14208.43434,4990.060606,1332.40404,386.2727273,1342.939394,3636.393939,926.3636364,156.4141414,5519.636364,3109.262626,1130.494949,264.9494949,3180.616162,829.1919192,195.6060606,99,12.43950963,10.43326063,0.544563514,0.916666667,0.692307692,0.166792826
+581,17854.52941,723.8382353,537.5,1075.595588,15778.05882,585.0588235,969.0588235,1633.360294,8305.617647,476.4411765,2485.904412,1848.786765,12739.90441,1156.977941,7683.772059,4096.764706,4681.455882,1134.933824,359.5735294,8160.058824,8111.691176,545.6617647,125.8014706,1199.720588,10312.11029,413.1323529,117.8602941,6766.580882,8554.727941,2117.455882,884.4264706,2805.066176,6802.007353,537,273.0882353,25194.58824,5587.419118,1256.352941,391.3602941,1418.882353,3559.441176,735.8235294,158.75,7510.514706,3409.088235,1146.727941,335.4338235,3194.014706,942.7132353,198.2573529,136,15.77648697,11.24162289,0.701615728,0.937931034,0.571428571,0.327297237
+582,40026.01429,875.4571429,579.7714286,1134.842857,36047.84286,701.2714286,741,1670.285714,19345.41429,585.9428571,591.2571429,1764.571429,27586.64286,1289.328571,5418.814286,3654.842857,9675.028571,1360.685714,410.5571429,2594.685714,19178.14286,424.0428571,196.8,524.5142857,22792.67143,420.2428571,189.0571429,4382.514286,18387.94286,1604.442857,933.8571429,2819.6,15280.11429,593.7,292.7428571,1842.542857,10585,861.6714286,455.3,1303.114286,8739.971429,650.5571429,180.2714286,3803.057143,6717.157143,1318.971429,154.7142857,3264.071429,269.2857143,196.5142857,70,11.89938697,8.257173629,0.720056071,0.909090909,0.583333333,1.177405335
+583,23035.49306,759.2638889,478.1597222,1103.493056,19666.52778,609.1666667,441.4652778,1632.215278,11501.11806,508.5138889,358.0902778,1794.256944,16211.3125,1180.694444,3346.861111,2587.923611,5779.875,1183.6875,386.0555556,2442.430556,10333.34028,1474.159722,456.9930556,428.8402778,12164.16667,381.2222222,113.1111111,3247.979167,10650.68056,1317.4375,765.5902778,2789.9375,8739.965278,562.3680556,256.0138889,8766.972222,6894.805556,939.4375,385.7708333,1327.736111,5136.458333,766.3055556,152.7291667,3150.659722,4350.104167,1203.111111,148.0833333,3148.180556,723.9236111,199.0208333,144,16.31303563,12.22047934,0.662430291,0.862275449,0.533333333,-0.347817528
+584,18819.1383,716.8829787,499.7234043,1054.648936,16469.37234,576.6808511,567.893617,1600.797872,8849.851064,469.2446809,453.5,1812.5,12786.28723,1126.489362,6559.93617,3422.085106,4785.670213,1129.989362,389.606383,3141.478723,8355.021277,522.4042553,1130.93617,487.0638298,10406.7234,402.8085106,119.2553191,8319.595745,8700.946809,1469.531915,937.6808511,2806.43617,7192.234043,522.212766,251.712766,10617.73404,5696.06383,874.5212766,389.6276596,1346.159574,3915.638298,845.9787234,148.7340426,3601.095745,3431.510638,1160.659574,217.8510638,3218.56383,896.287234,196.8085106,94,12.15348473,10.15637835,0.549222388,0.878504673,0.602564103,-0.771436108
+585,18910.5748,794.4488189,501.9055118,1105.275591,16339.33858,639.6771654,660.7480315,1624.181102,7598.685039,489.4330709,951.8031496,1770.19685,12455.48819,1206.086614,4740.795276,3340.629921,4579.527559,1206.897638,447.0629921,5526.188976,8081.984252,616.2677165,893.3464567,993.5669291,9884.708661,408.0708661,120.3622047,4504,8120.448819,1806.456693,798.5511811,2842.519685,6705.307087,562.7559055,272.1023622,10844.73228,5016.700787,1095.07874,404.8740157,1362.370079,2945,887.1811024,163.7795276,4877.637795,2848.007874,1190.19685,278.4409449,3176.708661,1009.80315,197.1181102,127,14.66813418,11.42187948,0.627413089,0.933823529,0.604761905,-0.774129628
+586,28053.13433,1105.164179,577.9104478,1098.880597,24694.10448,759.7761194,866.0298507,1593.029851,13306.62687,677.8656716,1603.253731,1779.850746,18485.50746,1369.731343,4571.432836,4310.61194,6462.492537,1376.61194,405.9253731,2539.208955,12922.89552,566.1940299,1367.313433,1447.41791,14760.07463,501.2238806,168.1492537,4551.089552,12169.76119,2284.776119,767.5671642,2820.656716,9809.895522,685.6567164,282.3134328,1673.985075,7804.970149,1740.656716,450.2537313,1337.059701,6097.298507,923.8955224,175.4776119,5348.283582,4736.313433,1283.925373,447.6268657,3237.716418,329.2835821,196.0746269,67,9.916017903,8.802886531,0.460337254,0.957142857,0.676767677,-1.531583849
+587,49410.95349,907.2790698,513.5813953,1114.918605,44259.67442,750,869.6511628,1646.534884,24302.90698,627.0116279,1431.813953,1784.744186,33915.03488,1415,4780.186047,4076.046512,12490.52326,1421.732558,435.4651163,2821.348837,22868.90698,432.3255814,350.7790698,897.1162791,27353.53488,483.6511628,197.4651163,3310.406977,22360.26744,2067.744186,932.6976744,2840.593023,18098.47674,641.0930233,317.1511628,1817.360465,14411.06977,1205.802326,474.0348837,1312.5,11022.60465,701.8604651,176.2906977,2453.906977,9137,1418.55814,217.5116279,3233.895349,398.0116279,196.6627907,86,15.99674163,7.380296645,0.887211726,0.86,0.488636364,-1.075640249
+588,25149.01471,735.8897059,440.3308824,1057.220588,22131.29412,609.8602941,1040.095588,1557.308824,12365.22059,536.8235294,1964.911765,1820.485294,17341.77206,1196.764706,6073.132353,3810.808824,6312.176471,1216.367647,385.6102941,9440.816176,11671.41912,1266.757353,482.2573529,1112.779412,14061.38235,390.2647059,114.3382353,3080.036765,11767.04412,1916.323529,761.0220588,2814.992647,9633.492647,610.0882353,266.9338235,4800.433824,7711.485294,1569.757353,421.5514706,1380.911765,5738.227941,730.9411765,164.2426471,3728.669118,4846.529412,1198.786765,261.1176471,3142.264706,559.9705882,200.2279412,136,16.09350068,11.28408396,0.713006102,0.912751678,0.571428571,0.174074542
+589,18112.97794,777.0661765,790.0441176,1134.558824,15275.80147,603.5,724.6470588,1681.294118,8819.801471,501.625,423.1397059,1809.198529,13230.41176,1185.977941,3835.058824,2562.647059,4822.507353,1210.911765,358.625,2587.904412,8236.154412,5561.691176,203.3088235,442.2794118,10047.08088,454.9558824,110.0514706,4526.897059,8514.264706,1328.154412,928.6176471,2799.404412,6879.566176,630.1838235,258.5661765,12544.53676,5716.139706,767.8823529,393.4558824,1316.235294,4163.514706,712.0441176,148.3088235,4555.213235,3494.286765,1197.404412,130.3308824,3228.022059,698.6617647,199.3970588,136,15.53344986,11.34512826,0.68305431,0.944444444,0.708333333,0.343260515
+590,26479.43689,733.7184466,416.8932039,1046.31068,21596.95146,619.1359223,1197.990291,1498.203883,13137.83495,495.7475728,1497.834951,1738.019417,18607.45631,1160.242718,6117.893204,2969.407767,6647.165049,1197.990291,441.2621359,6321.446602,11999.59223,634.2718447,1558.660194,928.6504854,14620.86408,379.631068,115.1553398,2528.097087,12553.21359,1722.834951,667.7864078,2809.563107,10187.04854,708.8834951,251.5436893,4773.864078,7933.262136,1320.669903,399.9514563,1403.427184,5658.271845,1037.097087,156.0873786,3148.31068,5027.485437,1173.514563,225.2038835,3145.864078,839.407767,198.8446602,103,15.54934304,9.175029681,0.807360134,0.837398374,0.624242424,0.412361182
+591,24619.47059,756.745098,561.3529412,1084.039216,21837.69608,610.7745098,1621.529412,1591.54902,11897.87255,495.1470588,1854.676471,1823.176471,17349.7549,1165.980392,5687.254902,3801.362745,6116.470588,1181.892157,382.872549,5926.029412,11480.60784,857.7156863,338.4607843,666.7058824,13747.14706,391.0392157,115.6764706,4855.607843,11987.34314,2072.058824,754.127451,2831.656863,9631.480392,558.5,262.745098,15777.42157,7392.068627,1223.156863,398.6568627,1381.5,5457.813725,712.254902,155.0392157,4147.22549,4686.794118,1195.411765,228.4215686,3167.637255,860.0294118,197.127451,102,13.22918035,10.17924394,0.638702396,0.927272727,0.708333333,-0.765144513
+592,21584.92381,772.1714286,523.2952381,1103.971429,17619.88571,611.6,528.8571429,1665.866667,9050.942857,479.847619,713.552381,1809.304762,14082.06667,1155.638095,4791.228571,3125.6,5203.666667,1155.857143,390.8190476,5120.857143,9062.219048,614.9904762,921.6571429,720.952381,11331.34286,408.047619,116.952381,6655.914286,9388.895238,1482.72381,772.6666667,2813.72381,7547.809524,536.952381,265.7714286,17025.51429,5777.114286,810.2285714,394.9619048,1368.47619,3415.790476,853.2857143,173.5142857,6064.771429,3269.257143,1142.095238,260.4571429,3220.809524,996.7428571,197.6190476,105,12.01596843,11.2820285,0.344136526,0.945945946,0.673076923,1.456499946
+593,32332.88991,1234.477064,598.1559633,1222.110092,28997.44037,954.733945,730.9174312,1958.055046,15121.78899,757.0642202,514.733945,1753.87156,21665.95413,1689.816514,5080.376147,3175.055046,7509.972477,1601.743119,513.0091743,2453.495413,11311.11927,365.2110092,285.6605505,416.1009174,12929.92661,354.1834862,118.412844,2957.706422,10952.38532,4211.899083,894.4036697,2813.53211,9047.174312,646.4862385,275.1743119,2150.513761,7373.926606,893,430.2844037,1315.954128,5765.302752,929.706422,165.8715596,3165.522936,4695.201835,1272.183486,185.7247706,3208.284404,430.6972477,199.0091743,109,14.26378001,10.09285296,0.706627103,0.915966387,0.644970414,-0.506796865
+594,46650.2406,903.4360902,531.1578947,1127.330827,41505.64662,740.2105263,730.1879699,1679,23928.22556,634.8496241,618.7218045,1789.879699,32597.4812,1410.864662,6059.526316,5129.218045,11843.93985,1421.932331,439.9699248,2622.954887,22189.61654,459.7669173,150.1428571,800.8571429,26658.93985,542.0075188,138.2406015,3438.654135,21779.63158,1569.661654,959.1203008,2829.37594,17647.33835,694.1353383,315.8345865,4341.661654,14292.64662,1018.962406,479.5413534,1319.774436,10459.66917,658.8120301,179.2330827,2751.75188,8507.511278,1428.676692,425.4210526,3249.819549,482.0977444,200.2330827,133,15.13570083,12.18996403,0.592761248,0.852564103,0.59375,-0.229175428
+595,27060.5,792.9876543,475.1851852,1099.388889,24416.35185,650.8765432,794.2469136,1589.345679,13360.65432,547.0493827,1098.654321,1811.185185,18474.5,1244.246914,5904.024691,3231.901235,6857.709877,1261.82716,470.1728395,4343.62963,12517.51235,5913.358025,1037.753086,765.8518519,14840.75309,509.4444444,123.8703704,4250.67284,12210.25926,1831.901235,1005.962963,2811.364198,9812.111111,579.9135802,261.1234568,4275.925926,7946.67284,1176.728395,427.2901235,1334.981481,6031.611111,867.4814815,165.382716,4286.253086,4892.635802,1241.030864,232.4938272,3210.530864,545.2222222,200.9320988,162,16.16177215,13.94725137,0.505241756,0.9,0.560553633,1.507758603
+596,21533.76159,734.7748344,546.9072848,1100.675497,17672.6755,581.6953642,632.3576159,1631.993377,10134.54305,475.9403974,778.9337748,1814.331126,14539.93377,1155.536424,6324.165563,3994.715232,5260.97351,1144.675497,368.9801325,4351.384106,9236.615894,1131.569536,213.3443709,595.218543,11134.76821,405.8741722,114.2913907,7594.834437,9673.655629,1736,1061.781457,2811.231788,7813.735099,544.6821192,268.7880795,20849.39735,5974.496689,987.0066225,388.6887417,1306.039735,4229.311258,686.5165563,150.7682119,4568.675497,3631.84106,1143.781457,159.9470199,3189.145695,868.7218543,202.0331126,151,17.08021909,12.36921531,0.68960717,0.926380368,0.674107143,-0.541991934
+597,21776.8125,715.09375,484.1919643,1078.075893,18983.875,579.1741071,630.2142857,1595.946429,10255.88393,476.6875,704.6205357,1812.924107,14679.90625,1120.227679,5393.415179,4070.178571,5423.754464,1129.575893,353.8035714,4034.049107,9544.09375,1537.540179,119.1830357,645.15625,11619.0625,398.3839286,117.15625,7050.732143,9985.486607,1563.294643,944.7455357,2790.285714,8059.21875,529.0892857,254.4910714,13350.45089,6176.870536,950.7410714,390.9732143,1312.370536,4425.267857,628.4866071,151.84375,3524.660714,3757.107143,1137.491071,178.7232143,3176.178571,882.1160714,202.4419643,224,20.81883707,15.40939417,0.672424254,0.842105263,0.666666667,0.015860743
+598,12095.024,700.44,497.992,1082.816,10764.376,557.552,389.048,1558.536,5979.44,462.808,384.672,1773.88,8377.552,1071.96,3886.848,2512.448,3235.392,1089.168,330.096,2509.848,5930.416,425.008,181.32,468.512,6776.176,334.496,108.848,4954.848,5848.136,1261.136,874.488,2815.44,4778.552,509.176,251.424,30017.672,3957.568,706.24,364.856,1346.656,2980.256,948.376,147.136,4354.032,2482.888,1118.04,173.112,3136.6,616.512,199.544,125,13.46094284,12.66245386,0.339292146,0.932835821,0.595238095,-0.060381244
+599,17470.19608,692.872549,475.9509804,1067.460784,14796.12745,547.6862745,776.1764706,1520.245098,8345.254902,452.8333333,480.745098,1752.294118,11985.44118,1084.813725,3367.990196,2333.843137,4306.696078,1104.107843,342.4313725,2746.931373,7645.480392,1147.039216,121,475.0686275,9336,382.9411765,110.1372549,4363,7851.901961,1407.068627,811.1176471,2780.196078,6309.176471,673.3137255,261.0882353,20315.18627,5146.813725,765.4411765,381.2058824,1323.617647,3741.215686,712.2058824,146.3235294,3836.578431,3179.754902,1137.970588,136.6372549,3134.990196,817.1078431,199.1764706,102,12.62351637,10.64773436,0.537154266,0.927272727,0.708333333,-0.911229729
+600,36562.74775,906.6846847,681.6756757,1158.90991,32086.91892,709.2432432,527.009009,1717.855856,16464.89189,606.1801802,434.7567568,1811.693694,23170.30631,1271.126126,7887.18018,5391.90991,8293.675676,1338.486486,411.3783784,2397.459459,16094.69369,372.7657658,154.5135135,455.8468468,18956.86486,416.3963964,136.5585586,8314.54955,14798.00901,1447.198198,825.9369369,2915.036036,11937.18919,586.4954955,295.1441441,2731,7861.009009,814.5765766,432.9189189,1289.927928,6865.990991,644,172.8288288,2722.594595,5076.018018,1251.063063,167.0540541,3186.963964,247.2162162,201.2072072,111,12.91142752,11.22756827,0.493785385,0.925,0.656804734,-0.919224703
+601,41878.48872,1089.729323,595.3233083,1141.864662,37273.43609,695.7969925,690.1654135,1638.172932,20734.27068,603.0451128,852.7744361,1811.849624,29190.99248,1367.969925,4231.406015,3573.834586,10762.16541,1404.593985,453.7443609,2646.714286,18749.27068,409.2406015,459.6541353,563.2481203,23137.00752,420.0526316,132.6390977,4450.278195,19054.16541,1756.293233,984.8796992,2817.849624,15705.14286,635.5263158,301.481203,1837.06015,12685.78195,992.9473684,460.2330827,1325.398496,9622.203008,1086.067669,172.037594,2775.142857,8058.616541,1733.451128,218.1804511,3230.857143,405.1052632,202.1278195,133,16.79267165,10.83175363,0.764158422,0.869281046,0.59375,-1.243404333
+602,24821.78733,733.520362,447.5791855,1073.488688,21835.26244,592.4524887,530.0452489,1632.696833,11911.42081,477.9230769,385.9502262,1795.366516,16948.85973,1144.167421,4377.927602,3633.945701,6158.60181,1197.135747,382.9049774,2493.352941,10889.02262,2050.307692,732.0090498,433.2352941,13599.61086,403.1131222,117.800905,5273.923077,11307.41629,1326.9819,901.0904977,2796.19457,9232.266968,552.4841629,256.158371,8762.701357,7106.570136,778.1266968,392.0045249,1313.760181,4863.343891,825.9457014,152.8778281,2939.800905,4213.552036,1146.760181,150.4932127,3225.542986,907.5248869,206.9728507,221,23.81304659,12.37255046,0.854427738,0.91322314,0.565217391,0.452419189
+603,34524.95238,837.1904762,470.4857143,1091.485714,31514.77143,690.9047619,691.2095238,1600.580952,17105.38095,584.152381,764.7333333,1771.390476,24309.71429,1318.666667,3234.885714,3002.028571,8975.609524,1406.361905,409.7238095,2572.733333,17361.0381,410.447619,528.6285714,902.9142857,20276.11429,402.8761905,128.9809524,2145.780952,16692.08571,1826.961905,902.6095238,2876.066667,13924.3619,740.0666667,297.5428571,1702.885714,11102.2,1020.933333,481.7142857,1359.857143,8952.095238,779.4761905,185.0857143,4583.409524,7022.07619,1386.904762,148.2380952,3250.790476,357.0952381,200.9619048,105,13.83322373,9.853075674,0.701899318,0.921052632,0.681818182,1.405554455
+604,23063.2638,730.2116564,505.1257669,1061.082822,19904.57975,593.1993865,592.3374233,1580.460123,11412.17485,510.0460123,865.2638037,1804.889571,15483.92025,1153.165644,5368.527607,3807.319018,5827.484663,1158.98773,340.6840491,3957.328221,10457.34049,1588.116564,133.1656442,822.2822086,12477.60429,452.9631902,110.9294479,5867.58589,10479.63497,1491.352761,888.7822086,2801.242331,8618.760736,548.8803681,252.5674847,9495.407975,6908.245399,921.1349693,395.7730061,1315.47546,5106.122699,690.3773006,156.8220859,3070.113497,4273.825153,1165.398773,207.107362,3140.079755,587.3619632,209.6533742,326,28.57460103,15.45192063,0.841178741,0.903047091,0.56993007,0.517655635
+605,19543.8449,699.3755102,467.0897959,1062.783673,16741.76327,576.2897959,457.4408163,1581.55102,9608.734694,486.522449,483.6163265,1795.310204,13152.52245,1118.906122,4258.387755,3468.367347,4909.869388,1124.269388,353.7306122,2868.836735,8720.657143,1754.62449,504.3183673,511.922449,10258.76735,398.8122449,109.8489796,5871.391837,8813.204082,1338.636735,981.7306122,2824.714286,7282.661224,535.9102041,248.044898,13045.34694,5862.55102,770.2489796,374.5714286,1321.073469,4253.534694,829.4244898,144.6326531,3476.404082,3612.253061,1140.995918,169.5469388,3151.612245,601.5061224,203.4530612,245,19.33635781,17.48737231,0.426732743,0.890909091,0.583333333,1.566172702
+606,19038.33548,716.1870968,502.2774194,1072.819355,16516.66452,584.6064516,543.116129,1677.987097,9414.703226,489.1870968,457.8580645,1838.354839,13395.61935,1128.077419,5872.858065,3369.864516,4800.451613,1138.348387,355.1419355,2917.329032,8848.96129,1900.683871,159.6645161,456.3677419,10464.05161,375.8709677,107.1225806,9295.587097,8877.032258,1325.032258,942.9870968,2791.193548,7228.23871,553.5870968,254.1483871,19581.03871,5906.916129,808.5548387,381.7483871,1316.735484,4385.16129,681.716129,171.116129,5154.941935,3763.23871,1161.845161,143.8451613,3205.574194,667.3483871,202.5354839,155,15.05693548,13.17466252,0.484141646,0.945121951,0.738095238,-0.547969527
+607,23413.56931,952.8663366,602.7475248,1097.430693,19884.77723,739.1089109,631.8069307,1561.737624,11221.23762,579.460396,713.4059406,1759.282178,15864.80693,1464.341584,5179.742574,2510.935644,5636.405941,1319.579208,641.4851485,4436.039604,9851.950495,586.3019802,2128.20297,628.2376238,11790.52475,403.9653465,132.4356436,5121.950495,9773.356436,1808.90099,946.9554455,2799.752475,7743.361386,583.1237624,291.6683168,8568.158416,5972.064356,1001.772277,451.2475248,1381.356436,4286.762376,1253.539604,177,4274.09901,3508.19802,1404.381188,237.9108911,3213.019802,775.0445545,202.9405941,202,17.47944243,15.37532659,0.475670761,0.914027149,0.660130719,0.977611013
+608,24895.05405,1170.027027,700.7837838,1086.108108,21009.43243,839.5135135,1368.72973,1596.405405,11628.97297,704,2342.891892,1821.945946,14825.45946,1345.594595,7327.702703,6027.648649,5803.513514,1354.675676,393.5675676,2499.081081,10049.97297,392.6486486,268.3243243,2328.918919,11270.72973,1400.702703,304.3243243,4954.189189,9164.108108,2359.756757,784.9189189,2795,7782.486486,608.1891892,257.3513514,1907.513514,5530.27027,1247.621622,421.027027,1312.594595,4450.810811,643.2972973,155.5135135,7135.567568,3124.567568,1177.108108,321.4594595,3538.810811,297.2972973,201.8378378,37,8.819935952,5.913409202,0.741946196,0.822222222,0.587301587,-0.093612847
+609,38928.41284,856.7706422,529.8256881,1102.642202,35067.04587,712.733945,749.9266055,1618.183486,19578.08257,605.1376147,500.8073394,1741.87156,26936.29358,1352.889908,5088.926606,4549.091743,10096.19266,1368.33945,418.5412844,2489.33945,18288.33028,442.5137615,341.2477064,460.266055,22399.86239,717.2201835,135.8623853,3637.220183,17732.26606,1484.559633,902.8899083,2817.53211,14481.97248,643.7247706,295.6788991,3195.990826,11743.55963,908.1284404,470.4770642,1325.715596,8731,732.5045872,180.0458716,3752.284404,7070.018349,1373.87156,278.1651376,3249.201835,468.146789,201.9816514,109,14.84501148,10.15342351,0.729517651,0.893442623,0.598901099,0.61416271
+610,29090.11321,885.9622642,660.2735849,1131.801887,25751.62264,718.7264151,1020.716981,1683,14271.5,596.6603774,828.9433962,1824.867925,19962.12264,1350.301887,4036.150943,2094.198113,7098.301887,1378.150943,432.6603774,2822.735849,13546.49057,563.2735849,615.9056604,785.3018868,15790.78302,451.5943396,136.2075472,3426.509434,13185.95283,1650.933962,753.5849057,2838.726415,10631.69811,631.4056604,297.2358491,6632.962264,8664.783019,1436.245283,460.1792453,1360.792453,6384.95283,745.2358491,172.1603774,3579.226415,5441.198113,1331.943396,236.4622642,3276.971698,522.0943396,201.254717,106,15.67755086,8.866725062,0.824701492,0.938053097,0.736111111,1.489669321
+611,35883.70732,896.5609756,528.1341463,1093.634146,31811.76829,736.7317073,795.597561,1571.45122,17223.76829,609.8292683,924.804878,1752.097561,24567.04878,1362.304878,3286.719512,3903.231707,8672.707317,1397.682927,423.1097561,2565.573171,17276.59756,426.8658537,1128.865854,858.5121951,20394.92683,475.8536585,138.1219512,3170.439024,16537.41463,1993.292683,883.1341463,2812.512195,13685.62195,768.8902439,316.5,1696.231707,10924.46341,1038.426829,497.7804878,1347.792683,8775.231707,919.2317073,189.6097561,5754,6997.02439,1407.817073,268.8292683,3220.426829,340.1219512,202.097561,82,11.77856384,9.191569298,0.625325314,0.931818182,0.759259259,1.359457362
+612,14687.72603,694.7671233,485.3013699,1079.876712,13322.0274,562.9452055,415.369863,1607.356164,7309.493151,482.8356164,400.9315068,1802.753425,10041.60274,1084.684932,5998.547945,3479.835616,3577.958904,1104.164384,353.6575342,2577.287671,7033.383562,1564.575342,403.2739726,434.630137,7984.520548,368.4794521,114.5753425,7287.794521,6857.219178,1277.479452,1020.136986,2821.575342,5627.493151,532.260274,244.3013699,18242.72603,4446.753425,717.7671233,358.890411,1308.09589,3379.273973,700.8630137,141.6438356,6033.534247,2886.520548,1108.479452,150.6027397,3132.616438,644.3287671,201.8630137,73,11.57108111,8.16094239,0.708921091,0.924050633,0.737373737,1.520917602
+613,18503.52551,726.1071429,516.1887755,1099.214286,16247.13776,580.8418367,506.3979592,1569.979592,9131.397959,486.9336735,374.5714286,1754.372449,13251.36735,1130.846939,4446.147959,3265.280612,4747.306122,1117.362245,367.5663265,2460.622449,8483.397959,1779.295918,576.3163265,425.2193878,10098.93878,387.2295918,110.3571429,5349.714286,8658.137755,1262.841837,1107.831633,2806.862245,7008.25,545.8877551,256.4183673,18733.57143,5716.47449,750.5816327,382.4030612,1331.586735,4297.704082,813.8163265,153.6938776,4847.841837,3567.984694,1163.596939,170.0612245,3169.821429,716.6377551,208.25,196,23.47531445,11.08473247,0.881498538,0.903225806,0.515789474,0.765426974
+614,51674.08824,1041.264706,548.7647059,1162.558824,43794.82353,830.3529412,1823.735294,1817.529412,24337.32353,724,2444.588235,1782.617647,34755.97059,1515.147059,5652.823529,2646.029412,11905.73529,1662.294118,446.2941176,2477.794118,23981.32353,457.7941176,514.7647059,1857.735294,29736.97059,810.2647059,1033.823529,1982.441176,23827.08824,2269.411765,767.4411765,2824.205882,19783.44118,677.4411765,352.7352941,1778.205882,15180.47059,1144.941176,524.7352941,1308.088235,12255.67647,790.9705882,203.4411765,3832.088235,9547.205882,1522.352941,418.2941176,3414.205882,303.4411765,201.8235294,34,7.309217671,5.893011639,0.591583374,0.971428571,0.80952381,-0.483491976
+615,38362.28947,965.3684211,490.9473684,1081.644737,31490.27632,741.3421053,623.8815789,1525.736842,18163.25,623.0921053,495.3421053,1722.342105,24733.63158,1348.210526,3467.815789,2155.644737,9224.447368,1446.223684,422.5526316,2443.263158,16826.28947,412.9473684,1347.671053,451.8026316,21001.32895,418.4342105,136.75,3531.026316,17012.57895,1554.736842,774.6447368,2824.355263,13965.48684,606.3947368,312.3684211,1663.907895,10707.28947,885.5,453.1052632,1301.657895,8268.802632,935.0526316,175.3421053,3238.25,6645.263158,1339.184211,374.2894737,3262.592105,319.1315789,204.2763158,76,12.23376966,8.347357072,0.731052769,0.938271605,0.633333333,0.329213979
+616,35913.46226,888.8490566,474.5660377,1088.320755,32438.10377,703.1886792,666.4716981,1563.877358,17296.20755,580.8301887,590.7641509,1724.924528,24591.29245,1338.896226,2495.566038,2065.311321,8426.45283,1394.471698,413.5283019,2492.641509,16671.10377,423.9150943,390.7735849,558.509434,19118.85849,466.9622642,135.6037736,2148.981132,15665.54717,1660.915094,829.7358491,2856.811321,12579.4434,1034.018868,299.0471698,1697.754717,10103.16038,972.1509434,463.1320755,1334.037736,7964.216981,718.3773585,175.7169811,3417.40566,6385.59434,1369.811321,660,3242.396226,387.2264151,204.5660377,106,13.11358581,10.53531809,0.595453773,0.981481481,0.741258741,-0.134260794
+617,49508.35514,953.0093458,494.3364486,1129.831776,42963.6729,780.5140187,671.2336449,1621.88785,23980.33645,645.5046729,454.4018692,1738.411215,33469.90654,1467.373832,3195.700935,3599.728972,12006.57944,1484.635514,447.3457944,2446.429907,21989.96262,445.682243,345.1121495,459.1962617,26254.76636,447.0093458,143.2149533,3120.457944,21336.8972,1824.168224,971.7850467,2809.785047,17405.25234,635.4953271,317.2336449,1995.401869,13988.07477,919.7943925,501.1495327,1327.663551,10291.53271,760.1588785,186.9345794,3222.82243,8505.560748,1445.841121,140.4859813,3271.056075,441.4579439,203.8504673,107,13.83633181,10.58926244,0.643646459,0.938596491,0.633136095,0.825934229
+618,45398.1129,860.2903226,482.9032258,1089.467742,39672.20968,692.6451613,1025.096774,1581.548387,22669.37097,619.3064516,1299.822581,1747.983871,31922.83871,1338.354839,5301.967742,4476,11186.14516,1364.870968,418.3064516,3696.741935,21510.53226,434.2096774,154.3548387,1396.548387,25464.72581,657.6935484,141.3709677,2646.193548,21226.59677,1928.580645,855.5,2823.483871,17244.03226,636.7096774,302.7258065,6405.225806,13872.51613,2450.790323,473.4193548,1331.370968,10184.46774,664.0967742,171.5806452,3139.370968,8507.177419,1363.064516,469.5483871,3159,496.4354839,203.8064516,62,9.580945227,8.669049477,0.425790149,0.953846154,0.688888889,-1.156248885
+619,25675.22143,758.1071429,460.4785714,1060.014286,22886.90714,624.3928571,1083.842857,1545.157143,12845.85,540.9785714,1203.485714,1817.964286,18114.03571,1205.128571,6491.964286,3304.764286,6444.707143,1199.057143,360.5785714,5848.935714,12222.69286,1624.642857,195.4357143,811.8,14106.20714,390.2857143,118.1928571,3770.007143,12290.67857,1783.814286,827.2071429,2808.214286,10153.42143,624.9571429,274.4071429,5254.564286,8000.378571,1114.121429,424.1428571,1329.357143,5943.7,669.05,163.3857143,3166.192857,5075.592857,1218.207143,232.7928571,3162.514286,573.1071429,206.0571429,140,14.41939979,12.62036302,0.483697983,0.945945946,0.622222222,0.605140776
+620,16234.80882,695.9779412,477.1139706,1062.169118,14162.4375,567.7977941,442.0183824,1585.863971,8029.522059,477.7242647,398.6801471,1804.580882,11003.04779,1092.702206,4365.694853,3061.558824,4131.904412,1119.544118,345.9816176,2561.933824,7541.503676,1175.444853,562.7941176,452.9007353,8693.5625,356.1176471,106.7977941,5186.4375,7451.345588,1293.613971,904.9264706,2790.194853,6147.569853,540.2463235,246.8713235,20657.08824,4979.886029,711.3455882,361.8345588,1353.735294,3659.6875,988.4080882,146.2132353,3749.099265,3105.080882,1130.367647,160.6433824,3133.113971,627.0183824,208.4595588,272,20.24249871,17.90261962,0.466715335,0.922033898,0.650717703,-1.526385309
+621,19775.70476,709.9238095,434.7904762,1080.409524,17788.31429,586.8952381,414.952381,1662.761905,9770.142857,499.3904762,360.9238095,1860.238095,13918.47619,1143.638095,4378.371429,4187.914286,4963.657143,1125.8,351.6857143,2519.942857,9206.752381,1282.6,123.3238095,438.6952381,10736.67619,374.9333333,112.1428571,4449.961905,9291.057143,1258.209524,948.1142857,2797.314286,7500.457143,529.152381,246.3904762,8125.47619,6125.628571,775.4,376.5904762,1310.180952,4521.104762,641.4571429,145.7047619,3131.2,3818.085714,1167.990476,134.4666667,3289.619048,678.7714286,205.4761905,105,13.82311611,10.01904357,0.688955601,0.921052632,0.576923077,-0.792390826
+622,19299.96591,714.0568182,444.6022727,1074.795455,16366.68182,577.25,422.9204545,1555.261364,9545.727273,485.3522727,365.5568182,1812.806818,13677.64773,1138.011364,3574.931818,2806.477273,4976.125,1121.136364,357.0568182,2422.318182,8585.420455,3037.193182,343.875,415.9659091,10494.64773,385.5340909,111.4886364,3974.170455,8804.465909,1244.545455,770.3636364,2790.818182,7170.420455,536.7159091,244.6818182,13006.44318,5831.170455,767.3181818,379.2727273,1311.306818,4324.625,740.3295455,143.125,3508.5,3673.431818,1163.227273,193.6477273,3164.647727,732.4545455,204.5,88,11.1650458,10.11028117,0.424282765,0.977777778,0.727272727,-0.63663608
+623,16236.37302,712.484127,512.031746,1062.595238,14625.84921,570.2936508,640.8650794,1550.261905,7431.674603,451.984127,685.9047619,1774.095238,11139.56349,1129.293651,5798.309524,4230.015873,4046.666667,1123,345.8809524,3860.357143,7102.277778,2584.563492,120.2619048,518.0396825,9029.468254,402.0238095,117.2460317,7620.230159,7254.031746,1521.873016,912.2063492,2790.119048,5890.873016,531.0714286,255.5634921,17696.21429,4641.388889,844.8650794,375.6269841,1333.547619,3041.404762,730.9761905,148.8968254,5150.285714,2797.357143,1133.111111,217.3571429,3158.277778,932.4206349,206.1984127,126,15.98995427,10.42144773,0.758434138,0.893617021,0.646153846,-1.186533566
+624,23052.01667,916.7833333,986.875,1207.108333,20213.09167,690.275,874.6416667,1855.075,9987.416667,521.8416667,556.7083333,1858.408333,15806.93333,1282.808333,5484.25,2794.45,5748.533333,1324.858333,388.1833333,2768.766667,10331.14167,562.7083333,138.7583333,500.1416667,13049.53333,496.2416667,125.7666667,5107.408333,10787.94167,1495.025,780.05,2878.575,8789.391667,616.9833333,294.15,17038.175,6808.783333,1096.866667,432.6,1335.391667,4282.091667,618.4916667,162.525,5101.1,4022.725,1275.866667,204.9166667,3375.883333,986.725,206.0083333,120,15.44462696,10.11858292,0.75549683,0.923076923,0.727272727,-0.005606647
+625,24877.97015,756.6641791,501.5597015,1096.156716,21041.85821,612.6343284,709.1791045,1641.69403,10361.76866,482.0223881,1505.074627,1792.007463,16882.34328,1172.761194,5050.5,3397.537313,6221.208955,1178.992537,365.4029851,7482.179104,11140.88806,628.9029851,114.8731343,1111.679104,13497.11194,607.8880597,118.5149254,4833.723881,11378.03731,1692.029851,790.2089552,2948.283582,9412.126866,562.7089552,266.8432836,15968.41045,6899.597015,1168.783582,400.3358209,1362.007463,4040.843284,656.858209,154.0149254,5770.753731,3943.037313,1149.932836,365.0074627,3140.619403,1018.283582,204.7238806,134,15.97091885,10.89320823,0.731291351,0.924137931,0.697916667,-1.416480905
+626,30702.61111,822.4777778,556.0444444,1108.211111,27297.23333,657.6666667,790.9,1583.588889,14709.44444,576.3222222,909.8333333,1843.866667,21368.48889,1235.077778,6752.488889,3869.066667,7751.955556,1277.144444,395.0444444,2586.377778,15614.72222,430.9333333,486.5777778,1122.6,18012.16667,1138.333333,129.0777778,4958.688889,14287.08889,1844.633333,822.6666667,2820.677778,11759.41111,578.9111111,284.5111111,2065.833333,8451.144444,951.3444444,438.8444444,1321.711111,7179.422222,649.7555556,175.6222222,4448.366667,5450.977778,1272.044444,168.5111111,3242.633333,269.8666667,203.8666667,90,15.66782385,8.578744164,0.836780183,0.891089109,0.529411765,1.520653257
+627,22023.12563,944.9447236,523.2914573,1074.361809,19317.92462,692.6432161,671.9246231,1480.447236,10423.8392,584.080402,687.5075377,1739.899497,13961.31658,1264.984925,4632.919598,3110.41206,5529.311558,1280.155779,393.9648241,2508.075377,9645.708543,372.4221106,764.718593,529.4723618,11672.43216,547.6130653,132.7939698,3115.708543,9165.79397,1513.547739,809.0050251,2859.648241,7660.376884,721.0100503,269.7135678,2384.01005,5997.924623,893.4673367,424.9899497,1340.98995,4806.688442,753.1055276,167.6130653,4031.246231,3571.979899,1242.98995,441.2311558,3334.085427,312.3819095,211.1155779,199,23.55342439,11.62717943,0.869659909,0.888392857,0.452272727,0.718960067
+628,28323.125,1074.71875,542.3958333,1101.333333,25016.9375,774.46875,902.3958333,1560.760417,13672.69792,655.84375,1164.572917,1766.0625,19170.66667,1387.114583,4754.4375,2677.833333,6935.583333,1365.510417,406.25,2674.46875,13185.52083,1593.770833,1095.9375,929.25,15722.48958,517.2083333,544.96875,3745.09375,12828.5625,2214.052083,749.1145833,2852.114583,10554.57292,802.9166667,286.0416667,1543.385417,8406.645833,1175.583333,456.5625,1331.760417,6577.46875,870.1770833,172.875,4057.729167,5168.53125,1312.989583,887.0833333,3265.583333,329.1666667,205.15625,96,12.4156994,10.27206596,0.561694192,0.914285714,0.727272727,1.270309919
+629,47458.89189,963.7927928,549.6216216,1124.918919,41920.62162,778.2162162,721.5765766,1634.585586,23344.18018,660.7837838,671.2522523,1756.18018,32520.61261,1474.486486,3822.891892,3979.009009,11540.16216,1430.045045,436.5405405,2471.882883,21167.6036,457.1171171,216.2162162,602.2162162,25848.82883,440.7297297,245.6396396,3740.288288,20563.31532,1674.189189,874.5495495,2818.846847,16874.68468,670.2432432,315.8288288,4102.873874,13547.3964,948.2252252,480.9099099,1338.756757,10114.81081,731.018018,183.6576577,3226.486486,8134.981982,1404,368.036036,3282.468468,460.2072072,206.7567568,111,13.58195549,10.66380191,0.619312217,0.956896552,0.60989011,0.636311976
+630,27744.9551,790.3591837,449.6367347,1104.334694,24368.89796,627.1346939,592.5795918,1622.930612,14169.46122,515.6122449,1014.563265,1791.138776,19941.36327,1221.77551,4316.461224,2927.702041,7129.130612,1204.502041,388.9346939,4455.493878,12737.20816,2280.395918,406.7510204,533.7469388,15618.30204,395.8816327,117.9632653,4198.167347,12987.30612,1425.102041,727.0285714,2803.587755,10584.97551,568.8285714,278.1959184,10029.25714,8568.579592,945.122449,405.8530612,1374.804082,6292.746939,756.7510204,155.9591837,3437.465306,5320.477551,1261.126531,218.2163265,3181.665306,747.7959184,210.7836735,245,22.83380439,14.85199734,0.759558478,0.862676056,0.586124402,0.538177264
+631,19836.01538,709.9692308,464.5538462,1077.553846,16485.8,563.6153846,675.8307692,1564.784615,9327.784615,469.8153846,570.9846154,1817.415385,13493.46154,1121.830769,3942.492308,3705.861538,4892.092308,1108.784615,351.6307692,3326.353846,8490.6,804.8923077,120.9076923,470.3692308,10212.93846,387.9538462,113.5230769,4576.015385,8619.246154,1497.753846,927.8615385,2808.338462,7091.661538,814.4615385,236.2153846,7584.246154,5597.646154,819.3384615,371.5384615,1317.261538,4044.323077,651.0923077,150.1692308,3432.630769,3415.261538,1115.892308,129.1538462,3175.292308,824.7538462,204.6153846,65,9.888177408,8.988621057,0.416737044,0.915492958,0.541666667,1.441112858
+632,29580.90588,821.0823529,563.0823529,1100.317647,25981.88235,637.7764706,591.4705882,1573.894118,13953.05882,567.6941176,667.1058824,1812.6,20000.27059,1218.870588,5815.129412,4701.764706,7416.541176,1289.552941,396.7411765,2858.211765,14996.85882,435.8588235,815.3058824,849.8941176,17045.21176,466.0117647,125.3411765,4114.411765,13525.42353,1710.423529,815.9882353,2888.682353,11180.42353,601.2823529,279.8235294,2303.8,7804.882353,891.7764706,427.7411765,1304.482353,6617.470588,625.3529412,164.6352941,3182.152941,5130.823529,1252.211765,186.2588235,3206.694118,260.1764706,206.6235294,85,13.30792734,8.51801901,0.768315724,0.923913043,0.544871795,0.794761475
+633,40183.36364,912.8545455,495.9454545,1086.545455,35468.36364,735.6545455,839.7818182,1611.636364,19115.94545,621.5272727,935.6545455,1792.290909,27797.70909,1367.218182,2844.4,3118.836364,9955.527273,1409.672727,415.4181818,2523.163636,19064.38182,421.1272727,219.1090909,651.7454545,22516.61818,432.8363636,137.8909091,2401.2,18555.85455,1970.127273,867.0727273,2831.327273,15294.30909,711.0545455,325.0909091,1878.036364,12217.61818,1054,483.5454545,1328.290909,9712.327273,715.3636364,183.4363636,3912.472727,7788.6,1427.290909,182.6363636,3282.418182,348.2545455,206,55,9.796881425,7.825532926,0.601625944,0.901639344,0.55,-0.634200961
+634,27694.96875,805.3125,519.046875,1104.703125,24782.65625,671.84375,964.5,1560.34375,14004.625,569.671875,939.953125,1779,18933.92188,1263.28125,6625.984375,5325.953125,7656.84375,1299.140625,387.65625,2962.390625,13507.90625,418.203125,130.78125,846.34375,15275.5,474.953125,123.921875,3121.09375,12821.82813,1601.1875,1010.484375,2828.6875,10550.70313,783.421875,274.0625,6119.625,8473.9375,1651.390625,430.8125,1339.53125,6331.046875,643.09375,173.515625,3943.3125,4976.390625,1298.328125,886.234375,3178.6875,487.453125,207.171875,64,13.90613676,6.808931478,0.871927493,0.831168831,0.484848485,-0.775832496
+635,20574.39286,744.3392857,494.5714286,1105.803571,17529.875,601.1785714,418.5357143,1661.232143,8721.5,471.5178571,438.2321429,1822.142857,14025.875,1144.410714,4656.232143,2838.410714,5154.303571,1167.785714,402,2751.428571,9003.964286,883.25,1130.732143,486.8392857,11229.51786,437.3035714,120.6785714,6118.732143,9235.982143,1399.464286,823.6964286,2833.892857,7583.196429,542.0714286,255,13963.89286,5845.892857,776.875,391.3214286,1304.678571,3494.928571,921.3035714,151.2321429,5082.821429,3319.214286,1149.375,246.6964286,3205.357143,1003.982143,205.9107143,56,10.23170882,7.073657081,0.722523274,1,0.622222222,0.723625946
+636,18181.69388,696.244898,440.8367347,1060.755102,15011.89796,559.6122449,587.6530612,1509.102041,8727.020408,453.6122449,495.4693878,1796.387755,12580.04082,1085.591837,6675.979592,3827.959184,4678.020408,1116.55102,357.3877551,3600.326531,7950.714286,444.2857143,250,539.0408163,9702.653061,377.4489796,109.3265306,6515.632653,8185.510204,1393.693878,828.9183673,2781.857143,6821.142857,541.5306122,247.9387755,9213.632653,5346.265306,866.3061224,365.4081633,1306.77551,3838.183673,723.7346939,148.8571429,3005.306122,3316.040816,1088.387755,135.3673469,3177.77551,833.7346939,205.7142857,49,10.74830318,6.755256885,0.777813469,0.875,0.556818182,-1.329250104
+637,24333.17054,753.379845,463.3875969,1076.139535,21416.75969,614.6434109,777.2790698,1596.317829,11876.08527,486.0852713,1498.891473,1763.139535,16497.72093,1174.488372,6137.914729,4516.387597,6177.48062,1175.395349,370.5813953,6051.372093,10889.47287,750.9147287,312.1472868,1060.263566,13308.5969,400.744186,116.1317829,4928.790698,11541.2093,1625.170543,681.3643411,2798.713178,9539.007752,550.3875969,262.5813953,13502.17054,7284.728682,1444.612403,400.8527132,1366.116279,5044.527132,708.6744186,157.7906977,3352.255814,4441.108527,1191.248062,226.1860465,3201.341085,893.5581395,207.9224806,129,13.5266449,12.99656317,0.277200722,0.895833333,0.763313609,0.814478905
+638,21168.17308,750.5448718,524.4487179,1088.724359,19010.49359,592.1282051,661.1858974,1609.397436,9555.173077,479.724359,526.4294872,1756.788462,14386.27564,1148.397436,5457.474359,2965.480769,5237.429487,1154.525641,358.7564103,2695.269231,9193.961538,2981.602564,142.9551282,501.2564103,11266.50641,426.3269231,122.1153846,6206.371795,9559.762821,1426.724359,1077.884615,2793.153846,7527.794872,575.5064103,262.0320513,19141.8141,5947.025641,938.7564103,396.4935897,1319.878205,3819.519231,693.2692308,151.6730769,5213.634615,3538.871795,1146.525641,203.4615385,3194.615385,952.025641,208.1538462,156,19.33881917,10.64968203,0.834710264,0.917647059,0.666666667,-1.182322095
+639,19706.5969,733.2868217,488.7131783,1087.604651,17045.4031,596.1317829,507.9224806,1595.96124,8450.868217,461.8682171,410.0232558,1782.968992,13811.87597,1134.418605,3372.131783,1918.976744,4994.023256,1158.131783,359.0077519,2508.55814,8855.410853,438.1550388,169.3333333,468.9379845,10913.88372,402.4496124,118.7209302,4657.426357,8990.333333,1326.465116,736.5116279,2912.744186,7346.054264,530.4108527,260.8604651,18067.60465,5744.364341,770.9612403,388.7054264,1321.348837,3507.968992,625.5891473,149.4651163,4813.627907,3243.294574,1151.348837,292.1007752,3200.062016,996.4263566,211.0852713,129,15.70231457,11.22400956,0.699329254,0.843137255,0.583710407,0.223711107
+640,28279.88517,852.6172249,589.3253589,1146.30622,23720.99043,665,1057.679426,1835.244019,10881.13876,516.0956938,1352.454545,1836.732057,18277.42584,1244.641148,6128.062201,3827.684211,6601.497608,1242.181818,385.1674641,4409.717703,11966.55502,1046.717703,272.7703349,860.8899522,14303.08134,460.4641148,132.8660287,6457.244019,11874.97608,1694.92823,882.2583732,2807.095694,9530.444976,589.5645933,267.0669856,11368.27273,6869.258373,1505.392344,413.4114833,1324.033493,3814.277512,676.507177,178.7177033,5794.043062,3760.526316,1186.315789,322.3732057,3259.167464,1037.942584,209.6602871,209,18.30411809,15.60204068,0.52292497,0.893162393,0.683006536,0.804801697
+641,25642.09174,1103.211009,536.6513761,1091.155963,21954.82569,749.293578,721.8440367,1507.944954,12127.30275,642.1376147,483.1559633,1721.605505,16593.77982,1340.357798,3982.834862,1927.302752,6022.357798,1327.486239,393.5963303,2439.311927,10551.6422,2905.669725,457.440367,440.6605505,12343.62385,418.9908257,118.7431193,3630.036697,10368.14679,1496.385321,867.6972477,2792.229358,8558.541284,607.559633,271.8256881,1664.981651,6799.761468,815.6238532,421.8440367,1297.972477,5259.302752,725.1192661,170.8073394,4001.944954,4291.458716,1244.990826,156.1743119,3439.330275,372.4220183,208.6422018,109,12.51707056,11.2764793,0.434051517,0.923728814,0.698717949,0.999610538
+642,33993.54545,838.6363636,541.3863636,1114.636364,29161.77273,684.1022727,1099.090909,1618.102273,15908.94318,585.3522727,2071.829545,1856.181818,22724.92045,1300.988636,6568.363636,5029.215909,8089.079545,1302.363636,409.0795455,5737.227273,15167.71591,2970.602273,245.25,879.6931818,17698.13636,446.6704545,129.7954545,2770.068182,14625.78409,2020.147727,808.4431818,2820.215909,11952.60227,649.5113636,289.3863636,6553.715909,9634.375,1688.159091,452.6590909,1352.511364,7093.238636,655.9659091,173.4204545,3638.704545,5959.579545,1301.397727,523.9886364,3312.636364,513.5113636,209.8636364,88,13.74297176,8.285488648,0.797824959,0.946236559,0.651851852,-0.081827025
+643,20764.0625,799.46875,492.375,1093.166667,18485.03125,647.1041667,1224.166667,1572.6875,10017.71875,553.3541667,1589.65625,1806.333333,13876.85417,1242.8125,6685.270833,3046.8125,5034.3125,1254.520833,409.6770833,3507.53125,9367.552083,3312.489583,1453.802083,944.6979167,10932.64583,772.1145833,176.25,3321.197917,9059.552083,1864.09375,826.1458333,2797.322917,7280.979167,678.6354167,267.8854167,5215.46875,5843.291667,2849.885417,425.0833333,1407.510417,4391.9375,939.8229167,171.1354167,5726.583333,3682.28125,1236.385417,413.7604167,3263.333333,533.5416667,208.7395833,96,12.78660157,9.655221721,0.655604329,0.941176471,0.615384615,0.553452827
+644,22864.9726,728.1164384,471.5616438,1092.082192,20376.61644,582.2465753,538.1027397,1713.452055,11413.24658,506.4520548,365.6780822,1833.109589,16630.65753,1162.952055,4718.342466,3692.363014,5998.363014,1160.780822,356.6438356,2463.308219,10869.04795,2834.164384,224.4383562,432.7876712,12988.55479,382.9726027,113.6643836,5184.472603,11054.61644,1280.410959,912.6369863,2791.90411,8922.561644,534.869863,252.4931507,10454.58904,7261.465753,757.2328767,384.869863,1306.253425,5465.157534,694.1986301,152.9452055,3540.554795,4590.520548,1192.356164,138.0136986,3228.863014,687.8150685,210.8835616,146,16.80883839,11.91235957,0.705513801,0.9125,0.608333333,-0.741307689
+645,27755.97222,815.8611111,497.6666667,1109.055556,24024.18519,649.3518519,670.4907407,1630.537037,13537.32407,521.3611111,1861.703704,1796.833333,19349.75,1284.638889,4168.814815,2995.333333,6918.685185,1222.472222,407.3796296,10279.38889,12375.98148,605.4907407,801.8425926,1140.796296,15045.12963,409.3425926,120.287037,2077.898148,12843.07407,1714.518519,676.2777778,2807.824074,10312.38889,568.9351852,276.1018519,13273.58333,8234.138889,1569.592593,426.6203704,1419.601852,5896.324074,904.8518519,164.6944444,5692.574074,5004.722222,1297.611111,494.3888889,3220.305556,785.4166667,210.0185185,108,16.05320712,8.782989581,0.837055857,0.923076923,0.654545455,-0.292815049
+646,26461.77778,840.4102564,549.957265,1123.512821,21729.35897,668.8205128,821.8034188,1806.82906,9348.324786,509.0769231,920.7521368,1818.188034,15681.79487,1195.470085,4899.615385,2608.811966,5706.623932,1193.940171,452.6923077,3031.384615,10152.33333,857.965812,618.4102564,682.1880342,12079.80342,466.0598291,479.4786325,6394.222222,9803.495726,1847.102564,809.3247863,2797.666667,7786.025641,609.2307692,264.965812,13111.35043,5579.213675,891.4188034,397.5470085,1323.076923,2939.777778,814.7863248,150.8547009,5213.042735,2918.965812,1129.299145,345.7094017,3140.905983,1050.307692,209.4786325,117,14.80253405,10.37973776,0.71295128,0.975,0.709090909,-0.356283494
+647,40065.12281,870.7368421,532.0526316,1119.491228,34948.45614,708.754386,946.0175439,1687.912281,19274.36842,592.3859649,804.4736842,1883.736842,26955.89474,1308.157895,7868.964912,4264.245614,9861.350877,1372.175439,410.0526316,2477.631579,18460.98246,390.2807018,190.8245614,1002.140351,22626.36842,477.2631579,135.6315789,3740.298246,18135.36842,1937.929825,871.3157895,2829.368421,15121,610.245614,307.1578947,1840.736842,10833.19298,1031.824561,460.0350877,1305.491228,8984.491228,661.2982456,174.0701754,3883.298246,6835.210526,1346.824561,156.8947368,3301,278.5789474,208.3157895,57,9.047182877,8.35383292,0.383928346,0.982758621,0.57,1.198017375
+648,24174.1746,876.4126984,549.3809524,1076.349206,22503.80952,672.4761905,623.5079365,1462.031746,11671.60317,532.4603175,929.984127,1737.31746,16051.79365,1233.666667,5561.428571,5014.428571,6457,1264.603175,387.2857143,2612.952381,10689.46032,374.8095238,666.4761905,586.952381,12116.42857,1402.746032,127.7460317,4894.587302,10216.60317,1501.15873,1067.222222,2806.777778,8554.555556,613.2222222,263.1587302,2364.285714,6885.095238,1160.365079,417,1315.571429,5419.095238,773.015873,170.9206349,6943.269841,4266.793651,1265.936508,390.031746,3178.285714,395.1111111,209.4603175,63,9.872091677,8.788612786,0.455475546,0.913043478,0.572727273,-1.304347961
+649,36533.89394,824.9848485,523.5454545,1078.333333,31411.22727,674.5,958.1818182,1568.863636,17607.10606,593.6666667,949.8181818,1776.19697,25405.83333,1284.166667,6337.439394,3784.666667,9084,1330.348485,397.9848485,3366.166667,16720.5,811.1212121,125.2727273,898.9848485,19976.66667,465.8787879,155.9545455,3597.590909,16288.43939,1956.924242,930.6060606,2821.666667,13373.12121,762.0606061,293.3636364,10547.36364,10855.60606,1282.878788,449.9393939,1334.560606,8028.545455,659.8787879,174.9545455,3291.060606,6755.181818,1311.439394,539.1060606,3303.106061,505.7272727,208.3030303,66,12.15283668,7.966644334,0.755162325,0.904109589,0.611111111,0.304791342
+650,17219.68627,724.5,488.1078431,1057.833333,15775.92157,621.6960784,1223.313725,1537.764706,8870.764706,527.4313725,1804.156863,1880.921569,12185.64706,1188.294118,7563.882353,3751.294118,4436.362745,1184.441176,361.2058824,5605.04902,8413.803922,4944.745098,923.3235294,1215.431373,9540.764706,403.7254902,115.7647059,5457.284314,8227.156863,2304.568627,875.5882353,2812.401961,6822.990196,616.9313725,257,7729.892157,5379.77451,1257.098039,420.1960784,1310.637255,3997.088235,835.3921569,164.5490196,5134.637255,3402.431373,1170.058824,236.6764706,3203.833333,553.1764706,210.3137255,102,12.92294877,10.17604035,0.616391946,0.962264151,0.653846154,0.487282835
+651,34945.91935,866.1129032,503.6021505,1093.032258,31156.63441,699.483871,786.9408602,1564.44086,16626.16129,584.016129,475.3602151,1753.806452,23710.48925,1328.032258,3628.591398,4352.053763,8312.473118,1337.817204,412.5806452,2452.876344,16176.80645,412.0645161,1150.172043,486.3494624,18659.90323,422.7043011,129.2634409,3362.908602,15089.16667,1725.182796,1191.112903,2828.064516,12444.84409,645.5322581,286.4247312,2443.419355,9966.698925,909.7473118,452.5967742,1337.66129,7487.370968,959.4516129,179.9462366,5282.05914,6008.994624,1362.521505,338.172043,3236.112903,434.5698925,212.5537634,186,18.59233829,13.19850557,0.704313077,0.93,0.652631579,1.413555685
+652,22498.82258,851.5241935,567.25,1098.612903,18591.8871,658.1290323,628.9032258,1706.379032,10987.12097,524.5483871,752.5322581,1891.354839,15700.81452,1232.822581,3280.322581,3375.653226,5655.967742,1209.185484,452.8951613,5148.072581,9739.959677,1659.556452,2116.830645,784.233871,12076.49194,405.2741935,119.7177419,4726.209677,10237.20161,1680.862903,914.2822581,2805.806452,8242.258065,621.8709677,277.2096774,16831.29032,6683.153226,1043.459677,416.0241935,1395.104839,4786.137097,1495.556452,167.0564516,5497.048387,4125.459677,1279.5,253.8145161,3238.572581,794.9193548,212.0483871,124,14.28750427,11.64459833,0.579433161,0.925373134,0.681318681,-0.589810551
+653,31113.91579,848.4210526,627.9894737,1121.610526,27410.32632,661.9473684,540.2947368,1610.189474,14289.83158,572.7684211,449.3789474,1785.536842,20275.84211,1241.294737,6238.684211,4627.831579,7333.463158,1308.336842,403.2210526,2423.115789,14225.52632,369.8947368,166.8631579,471.1473684,16810.23158,404.8947368,127,4569.831579,13032.45263,1446.357895,883.7368421,2820.610526,10674.41053,599.7684211,294.8947368,3583.726316,7417.221053,793.8631579,437.6631579,1320.210526,6353.326316,619.8947368,170.1052632,3007.263158,4726.747368,1238,220.8736842,3204.557895,251.0315789,211.2105263,95,13.66301948,9.234201959,0.737035825,0.931372549,0.616883117,-1.203858596
+654,47261.71667,971.7833333,523.2,1135.183333,42804.88333,751.35,685.3666667,1645.4,23935.01667,629.3833333,504.4166667,1791,33866.78333,1465.316667,6110.3,3592.75,11819.36667,1478.233333,443,2478.9,19049.93333,423.8833333,755.45,447.4333333,24038.25,418.8,134.15,4356.4,19640.86667,1574.283333,1201.183333,2819.433333,16302.96667,982.9833333,307.15,1883.6,13191.18333,967.8333333,470.65,1323.516667,9654.4,853.85,176.9166667,3726.4,8246.65,1468.383333,326.1666667,3207.75,411.6666667,210.3666667,60,10.93229574,7.286244181,0.745515737,0.9375,0.606060606,-0.514155689
+655,23262.5,777.1833333,517.5333333,1072.566667,20567.73333,635.6166667,774.8,1549.483333,10978.36667,525.8166667,790.65,1813.55,15500.23333,1205.316667,6361.8,2688.05,5831.6,1223.85,371.6333333,3061.416667,10327.75,3908.566667,213.6666667,477.0166667,12315.25,443.0666667,120.35,5092.65,9883.766667,1549.716667,936.2,2790.616667,7977.75,740.5,255.8,8371.6,6559.616667,1163.916667,425.6833333,1317.533333,4933.616667,656.9,166.3,3421.483333,4043.133333,1220.616667,241.35,3258.233333,522.5833333,209.9833333,60,9.491941991,8.385750713,0.468506665,0.952380952,0.666666667,-0.976068679
+656,14003.23762,700.7524752,541.1782178,1092.455446,12764.0495,566.2376238,403.4158416,1658.544554,7042.277228,477.1881188,434.8415842,1828.643564,9848.346535,1086.831683,5346.346535,2912.643564,3517.207921,1108.009901,360.5841584,2774.861386,6804.871287,2797.386139,367.7128713,444.1980198,7647.910891,372.9306931,105.2772277,6793.722772,6636.564356,1300.267327,983.1683168,2776.366337,5506.475248,650.970297,257.5940594,28754.74257,4368,748.3960396,369.4653465,1369.059406,3342.871287,782.1584158,153.0594059,5295.059406,2847.465347,1128.70297,156.6336634,3161.19802,641.4059406,211.7623762,101,14.66082882,9.551074475,0.758675314,0.943925234,0.601190476,-0.645320142
+657,23034.3,756.7,584.54,1106.62,19893.1,616.28,557.6,1762.96,11688.24,496.82,390.2,1825.2,17179.9,1223.62,5491.28,2682.88,6102.26,1170,382.54,2458.18,10762.2,4712.88,128.08,444.16,13199.22,416.42,114.14,5935.6,10962.6,1306.28,1020.56,2781.1,8854.46,559,270.56,17384.38,7205.98,789.54,405.04,1318.14,5359.12,697.2,158.46,4714.54,4596.48,1217.58,173.04,3245.16,697.6,210.08,50,9.254193669,7.463075743,0.591297683,0.862068966,0.617283951,1.281300476
+658,30534.28409,822.9545455,539.7954545,1117.818182,25643.93182,664.0681818,1159.079545,1741.113636,13451.25,504.2272727,2154.147727,1778.670455,21082.23864,1224.568182,7102.159091,3928.011364,7463.363636,1282.261364,383.2386364,8644.284091,13582.85227,490.375,142.875,923.125,16920.14773,456.1022727,148.3522727,5986.784091,14451.61364,1965.681818,810.0909091,2868.090909,11695.32955,562.1704545,288.1931818,19924.55682,9047.238636,1521.625,424.0909091,1393.159091,5750.613636,633.3522727,166.8863636,6234.272727,5408.079545,1242.806818,309.8409091,3270.886364,978.0909091,211.4090909,88,12.72792206,9.21999265,0.689389314,0.916666667,0.615384615,0.785398163
+659,38411.70175,892.8421053,615.9239766,1147.964912,31531.43275,669.9824561,620.3040936,1666.97076,16141.65497,574.8538012,437.0350877,1765.842105,22661.91228,1206.134503,5301.22807,3094.426901,8031.555556,1263.339181,391.4619883,2391.982456,15864.61404,343.2105263,123.005848,423.1812865,18287.84211,365.7134503,124.6842105,5924.526316,14240.29825,1393.426901,653.1111111,2824.894737,11463.04678,554.8538012,283.1637427,2291.087719,7016.210526,750.4619883,416.7719298,1296.666667,6337.918129,600.4152047,160.2923977,1799.362573,4582.549708,1168.011696,159.1403509,3154.321637,228.6842105,214.1169591,171,16.78582857,13.60170268,0.586003272,0.886010363,0.66796875,-0.986758442
+660,42737.64646,934.4141414,621.5656566,1165,37062.53535,726.989899,606.2525253,1719,19654.78788,609.4646465,460.959596,1780.090909,27601.30303,1334.212121,5857.979798,4602.282828,9959.737374,1403.020202,429.7272727,2399.333333,19380.55556,385.8282828,169.1515152,438.7272727,22791.48485,418.7878788,130.6060606,6064.717172,17931.07071,1504.030303,842.2828283,2813.979798,14548.55556,592.969697,295,3127.909091,9533.363636,814.7878788,455.4848485,1308,8199.888889,645.3030303,170.989899,2547.222222,6147.030303,1293.060606,173.8080808,3239.232323,240.4646465,213.7878788,99,16.05038486,8.328408803,0.854840089,0.891891892,0.61875,-0.129571106
+661,43823.22951,967.8196721,561.4754098,1147.901639,37706.08197,792.2622951,907.6721311,1720.180328,21048.63934,675.2295082,812.9016393,1830.42623,29241.22951,1437.983607,6027.786885,4101.95082,10604.03279,1475.04918,432.0491803,2487.819672,20410.85246,430.7704918,247,583.9016393,25310.2623,692.0327869,143.1311475,5236.868852,20144.65574,1600.655738,870.7704918,2838.180328,16969.93443,635.6721311,321.9836066,2051.409836,12836.93443,1121.885246,483.4590164,1327.393443,10304.32787,726.2131148,191.3770492,5345.459016,8097.983607,1450.04918,245.9836066,3433.180328,299.1967213,210.7377049,61,10.9518049,7.209531607,0.752758996,0.953125,0.616161616,0.966545854
+662,20096.31915,1005,478.1702128,1017.510638,18864.80851,686.2978723,444.6808511,1332,10021.78723,607.5744681,398.4893617,1694.276596,12445.80851,1326.680851,2775.191489,1472.170213,5531.212766,1535.723404,391.5744681,2388.531915,9226.978723,370.0638298,162.0425532,420.7446809,9899.574468,348,119.6595745,1678.191489,8207.170213,1410.851064,763.212766,2808.06383,7105.425532,613.4042553,251.0212766,1327.489362,5717.382979,782.4042553,422.8510638,1320.12766,4703.829787,617,186.0851064,3525.87234,3433.87234,1277.021277,126.9361702,3121.851064,355.4468085,209.9787234,47,10.58597323,6.534000999,0.786781233,0.886792453,0.580246914,-0.678181506
+663,33031.36667,866.9,543.9333333,1114.7,31004.6,654.2333333,564.3666667,1567.4,16182.76667,550.9,476.0666667,1757.5,22919.43333,1292.433333,8614.433333,5580.966667,8259.933333,1311.766667,407.4333333,2419.2,17454.5,418.3,627.2,434.2333333,18478.46667,419.9333333,129.2,7883.9,14694.76667,1462.3,1218.133333,2808.366667,12358.43333,692,281.9,2597.6,9782.066667,851.6666667,445.7333333,1337.633333,7533.4,761.5666667,170.7333333,5409.8,6060.2,1329.433333,172.6,3301.733333,404.1,210.2333333,30,6.880080684,5.991664655,0.491511157,0.882352941,0.612244898,-0.816510594
+664,23002.48421,772.7157895,548.3263158,1117.715789,19989.07368,615,683.7368421,1679.515789,11573.47368,510.4631579,524.8842105,1805.673684,16723.30526,1176.294737,4899.547368,3149.789474,5913.673684,1188.610526,378.4210526,2700.073684,10575.49474,4611.715789,158.8947368,480.9473684,12814.74737,399.4736842,114.6105263,6143.305263,11009.89474,1426.747368,1118,2796.421053,8786.221053,541.8105263,269.5789474,21303.6,7090.010526,805.4842105,399.2526316,1335.042105,5354.6,682.1578947,154.8631579,4345.747368,4503.536842,1213.863158,181.6210526,3205.926316,708.8105263,213.6421053,95,15.11319216,8.291988518,0.836046248,0.940594059,0.56547619,0.611409228
+665,27395.21212,865.8585859,531.0606061,1106.535354,23772.10101,677,823.2424242,1609.474747,13393.79798,544.8484848,415.020202,1731.222222,19520.10101,1318.636364,3122.555556,1705.525253,6943.757576,1281.919192,499.6363636,2939.727273,12407.29293,4357.878788,785.7171717,557.2525253,15263.89899,463.6666667,124.8989899,1640.959596,12742.14141,1444.939394,688.030303,2823.474747,10196.50505,623.1616162,281.8989899,9671.535354,8217.717172,1107.343434,423.7878788,1338.20202,5979.464646,839.959596,169.7171717,5551.515152,4969.909091,1353.808081,923.8383838,3210.10101,772.040404,213.5656566,99,16.452863,8.231261232,0.865855856,0.9,0.507692308,0.883791472
+666,19709.37662,1173.285714,515.9090909,1058.571429,17287.27273,750.5454545,718.6363636,1414.467532,8868.337662,658.6103896,700.3896104,1749.285714,12537.8961,1311.922078,1862.74026,2828.987013,4468.116883,1329.805195,379.3506494,2473.623377,8733.480519,367.7662338,362.038961,641.9350649,10132.93506,416.9090909,123.0779221,1713.142857,8150.74026,1556.87013,767.7402597,2805.493506,6781.155844,704.0649351,267.1038961,1726.454545,5511.675325,846.3506494,421.3506494,1303.883117,4520.74026,650.2727273,167.1948052,3442.064935,3539.597403,1236.454545,303.0649351,3493.766234,338.5454545,211.974026,77,10.76822861,9.419589863,0.484560763,0.9625,0.7,-0.61878682
+667,39145.46154,854.2527473,489.8571429,1127.208791,34845.7033,693.6373626,892.956044,1587.417582,19690.83516,601.6703297,1009.714286,1810.813187,27727.89011,1325.89011,5538.373626,4237.010989,9877.791209,1366.681319,419.2417582,3028.747253,19008.38462,485.9230769,133.1648352,1252.527473,21930.41758,454.8571429,322.7252747,2908.593407,18228.28571,1779.923077,892.4285714,2826.043956,15041.0989,714.4065934,300.989011,5633.615385,12058.1978,1291.241758,462.3626374,1320.10989,8953.901099,668.7692308,178.5274725,3319.461538,7355.901099,1351.703297,927.0659341,3262.681319,499.6263736,213.1978022,91,15.05506314,8.094348815,0.843168369,0.91,0.606666667,1.053917564
+668,18089.86603,701.5598086,472.6555024,1053.875598,16032.92823,573.7272727,438.6650718,1539.138756,9086.660287,477.3588517,432.0526316,1770.464115,12823.43062,1107.564593,4426.344498,3189.851675,4654.698565,1129.473684,344.2583732,2755.784689,8349.569378,791.5215311,842.4066986,454.2200957,9691.861244,370.9138756,107.9665072,4883.497608,8423.947368,1341.004785,882.7129187,2789.564593,6996.129187,533.5837321,246.6698565,14502.62201,5578.803828,778.9330144,372.4258373,1328.856459,4052.052632,936.84689,143.4545455,3570.090909,3558.990431,1143.124402,174.2440191,3133.574163,609.1626794,216.4162679,209,18.15115349,15.18907997,0.547492288,0.937219731,0.683006536,-1.023646439
+669,28374.52778,776.6458333,516.4583333,1107.125,24073.39583,630.2847222,723.5833333,1636.298611,13848.53472,511.1666667,984.6875,1798.881944,19428.80556,1204.493056,5214.215278,3666.993056,7072.833333,1195.034722,369.5902778,4636.611111,12517.22222,1185.743056,192.5,856.625,15215.88194,405.2291667,117.9027778,4613.5625,12913.19444,1565.736111,877.5625,2803.069444,10543.63194,904.3819444,273.3333333,14996.68056,8189.618056,1071.027778,412.6041667,1357.5,5903.513889,740.2916667,160.4305556,4717.347222,5099.625,1212.784722,197.1875,3188.659722,819.3125,214.5972222,144,16.24446909,11.50184239,0.706165632,0.929032258,0.642857143,-1.057073598
+670,16940.96853,692.0594406,446.8916084,1059.604895,14370.8042,574.1923077,509.1083916,1540.153846,7993.982517,459.0874126,620.2342657,1781.248252,11463.94056,1097.63986,4476.867133,2921.087413,4274.660839,1116.912587,377.958042,3589.534965,7538.86014,821.1048951,611.2377622,551.4020979,9031.636364,383.7027972,114.2447552,4498.171329,7831.559441,1423.496503,768.7797203,2810.318182,6415.318182,545.6748252,253.3881119,14838.26923,4995.304196,919.7377622,375.6153846,1332.870629,3503.853147,851.9475524,149.0769231,3133.562937,3084.461538,1135.101399,162.1363636,3145.062937,871.4370629,216.6643357,286,24.10252766,15.80649901,0.754932461,0.916666667,0.684210526,1.099555122
+671,43734.32308,904.9,446.3538462,1057.853846,37791.10769,720.3307692,524.5153846,1489.961538,21362.13077,615.3,408.4384615,1709.161538,30717.63846,1417.715385,2703.076923,2334.415385,10787.46923,1480.807692,435.3307692,2432.269231,19659.97692,417.6769231,261.9230769,403.8461538,24270.93077,395.6307692,133.2153846,1546.630769,19947.68462,1540.076923,936.5,2844.761538,16682.12308,700.6769231,314.6384615,1558.561538,13543.71538,882.7230769,480.1769231,1318.261538,10486.64615,697.7923077,183.7230769,2235.769231,8854.176923,1466.830769,1156.715385,3199.353846,360.0923077,217.6076923,130,17.69876513,9.444630763,0.845716671,0.948905109,0.695187166,-0.253089359
+672,19901.46212,1085.106061,531.5227273,1053.575758,17716.60606,693.3257576,889.7045455,1412.219697,9709.128788,610.3712121,595.1818182,1753.977273,13663.22727,1268.848485,3510.30303,1806.568182,4982.272727,1269.136364,366.9469697,2538.772727,9331.295455,4284.613636,292.0151515,487.25,11115.91667,436.5,116.9621212,3633.113636,9069.780303,1627.75,801.6969697,2805.333333,7471.848485,689.9621212,251.8863636,1569.174242,6187.522727,830.3106061,431.8712121,1337.545455,4773.121212,649.5681818,163.5984848,2892.416667,3910.969697,1206.530303,258.8409091,3347.227273,381.6818182,217.1818182,132,14.94462026,11.57690444,0.632385755,0.916666667,0.554621849,0.110324716
+673,25366.1875,871.5625,479.7767857,1058.553571,22568.6875,709.125,662.5446429,1499.5,11982.42857,571.9375,534.4196429,1734.232143,17337.30357,1335.857143,3238.6875,2803.098214,6205.178571,1326.107143,400.9464286,2459.714286,11402.96429,393.4017857,347.5714286,518.1071429,13403.03571,450.4107143,121.0535714,2936.401786,11060.63393,1526.696429,901.625,2818.964286,9107.232143,918.0178571,284.0535714,2155.133929,7394.080357,872.9642857,453.8392857,1298.669643,5590.008929,712.5446429,174.9553571,4253.758929,4667.008929,1366.3125,936.0357143,3135.553571,419.2142857,214.8928571,112,13.95444888,10.47776505,0.660467301,0.941176471,0.666666667,-0.462494375
+674,21207.03252,779.5121951,573.1626016,1117.081301,18846.72358,635.6504065,623.3170732,1658.349593,10568.27642,513.495935,532.1788618,1802.658537,14796.62602,1209.829268,5963.00813,3897.01626,5334.178862,1170.162602,369.5853659,2902.349593,9666.528455,2983.292683,129.7398374,461.1869919,11657.26016,405.8861789,112.2439024,6225.739837,9700.886179,1373.292683,983,2795.691057,7976.130081,554.9837398,264.0325203,12825.93496,6415.121951,1116.178862,400.7235772,1334.162602,4829.284553,686.6666667,161.4227642,5969.089431,4032.674797,1233.186992,197.4715447,3207.113821,737.0406504,215.4634146,123,13.35634297,12.01621886,0.436583289,0.917910448,0.675824176,0.778150942
+675,22135.29268,796.6829268,493.2520325,1079.926829,19956.99187,641.7398374,825.8455285,1556.260163,11056.64228,517.6585366,551.8292683,1746.097561,15908.43089,1231.96748,3287.97561,2178.146341,5767.869919,1212.853659,392.2926829,3094.130081,10146.12195,822.3495935,618.2682927,936.2520325,12342.71545,400.9349593,117.398374,1860.406504,10382.65854,1428.829268,692.0650407,2818.813008,8366.674797,577.2601626,266.5528455,12518.46341,6805.723577,1046.918699,413.8780488,1362.764228,5107.390244,872.3821138,165.8211382,5697.861789,4350.056911,1274.471545,247.7642276,3186.284553,763.3252033,216.8780488,123,14.74540487,11.21377091,0.649346629,0.92481203,0.546666667,0.562267565
+676,16976.24096,662.8554217,427.6987952,1024.590361,14289.88554,551.2409639,482.3373494,1462.10241,8335.457831,442.1385542,368.9036145,1773.5,11713.93976,1078.921687,4569.174699,2852.891566,4428.740964,1086.993976,359.7771084,2584.560241,7503.144578,3921.373494,458.1987952,451.8795181,9153.728916,379.5903614,110.7710843,5099.746988,7748.253012,1269.53012,889.873494,2775.722892,6446.638554,577.4698795,233.5421687,6687.572289,5044.89759,716.4036145,369.7650602,1292.668675,3605.246988,720.3253012,148.6807229,3072.662651,3139.560241,1092.487952,127.873494,3113.138554,833.7289157,215.2349398,166,18.40543033,11.90324427,0.762723615,0.873684211,0.658730159,-1.028932789
+677,36418.86364,808.3484848,478.5757576,1117.469697,29894.95455,650.6060606,908.4242424,1672.30303,16572.62121,512.030303,1635.212121,1734.212121,24047.45455,1233.939394,4941.969697,2918.621212,8737.424242,1266.954545,393.8030303,5335.030303,15681.19697,1323.454545,129.1363636,1377.772727,19216.89394,415.8939394,327.3787879,3069.590909,16940.31818,1932.363636,717.6363636,2827.606061,13543.56061,566.9545455,293.4242424,14410.72727,10461.01515,2174.106061,409.4242424,1354.227273,6477.257576,669.5151515,163.2727273,5648.909091,6162.5,1234.5,274.2121212,3209.878788,958.7575758,214.0606061,66,12.28964445,7.217116434,0.809404266,0.929577465,0.5,-0.917215376
+678,16815.79231,1010.607692,657.0384615,1074.292308,14581.54615,713.1615385,833.3615385,1468.238462,7620.307692,602.1923077,1095.138462,1806.184615,9953.769231,1191.338462,8183.4,4656.830769,3903.984615,1216.484615,361.7307692,2676.876923,7165.046154,859.6692308,200.2923077,1294.538462,7793.884615,601.4,114.4230769,6421.061538,6215.969231,1900.292308,738.9846154,2810.253846,5166.130769,568.1230769,239.7538462,2564.430769,3656.430769,850.4692308,382.3230769,1320.446154,3041.707692,585.1923077,157.6461538,4214.038462,2271.8,1105.869231,277.2076923,3444.784615,262.1,217.5153846,130,15.55072604,13.39272112,0.508218736,0.828025478,0.477941176,-0.659162689
+679,39280.54369,863.6990291,562.9417476,1117.728155,35037.05825,685.4951456,784.1553398,1621.116505,18941.05825,588.5631068,853.6116505,1807.679612,26419.79612,1299.68932,6171.834951,4206.786408,9411.514563,1348.504854,405.9126214,2622.106796,18279.42718,578.6893204,299.4368932,778.7864078,22778.50485,1204.961165,133.815534,4818.825243,17918.96117,1644.407767,892.0970874,2809.951456,14676.23301,601.7475728,292.3300971,1745.048544,10616.41748,946.038835,463.9223301,1321.572816,8727.427184,677.1262136,176.4563107,3350.281553,6721.504854,1317.631068,211.7961165,3344.048544,272.1262136,216.6893204,103,15.04345249,9.009820398,0.800809069,0.944954128,0.624242424,-0.377265533
+680,50051.7381,925.0952381,530.3333333,1135.595238,43404.95238,760.6904762,903.7857143,1717.071429,24156.52381,652.1904762,589.6190476,1750.833333,33507.33333,1376.642857,5438.571429,3446.119048,12065.16667,1492.952381,446.047619,2547.452381,23052.21429,418.5,221.0238095,594.2619048,28445.57143,468.7619048,139.5,3251.285714,23243.07143,1668.190476,1054.452381,2812.642857,19342.30952,644.9047619,325.7619048,1821.547619,14201.47619,1153.642857,486.6904762,1305.428571,11436.30952,687.3571429,195.4047619,3112.309524,9094,1441.785714,164.952381,3384.809524,285.5952381,212.8809524,42,7.578701464,7.296507458,0.270340199,0.933333333,0.75,0.183431782
+681,26154.84084,752.3933934,475.6876877,1075.216216,23606.24625,618.5795796,711.2282282,1605.693694,13183.14114,522.9099099,675.1681682,1817.543544,18252.49249,1181.804805,4472.201201,2820.069069,6576.228228,1219.294294,383.6816817,3374.546547,12450.7988,3253.018018,574.5075075,552.3753754,14205.02402,403.3513514,120.9009009,4365.054054,11974.54354,1552.54955,802.7927928,2811.588589,9902.972973,620.7147147,261.9279279,5034.561562,7940.405405,1011.591592,425.8768769,1325.555556,5850.459459,767.966967,162.7177177,2885.930931,4943.147147,1207.213213,181.5795796,3188.456456,563.5285285,221.8498498,333,25.80289211,17.07040062,0.749884054,0.885638298,0.640384615,-0.359080475
+682,37831.74648,921.943662,536.4788732,1159.816901,32420.25352,738.2394366,1244.56338,1799.704225,16207.11268,545,1532.816901,1757.422535,24554.05634,1314.211268,5421.056338,3540.901408,8762.788732,1301.366197,421.5070423,7549.225352,16483.08451,829.8732394,577.6056338,980.3380282,19060.28169,453.7887324,127.8309859,3351.788732,16338.90141,1976.380282,772.5633803,2838.43662,13280.08451,590.2253521,287.3239437,10636.30986,9738.43662,1363.084507,445.1971831,1371.056338,5632.577465,754.3380282,163.2112676,5880.887324,5364.887324,1277.661972,450.7887324,3301.056338,1010.56338,214.2394366,71,10.20099179,8.989848175,0.472609465,0.959459459,0.788888889,-1.516613811
+683,28008.05848,864.9415205,651.7251462,1161.087719,23603.66082,715.1578947,757.8304094,1888.391813,11567.4152,510.4210526,1034.292398,1887.74269,18691.43275,1245.292398,5318.128655,3419.871345,6907.538012,1269.730994,383.9239766,4977.175439,12220.39181,1095.263158,129.2748538,706.8304094,14548.2924,459.380117,127.3684211,5345.02924,12404.83041,1670.877193,994.8596491,2823.122807,10033.61988,579.2690058,279.5146199,14860.1462,7430.596491,1017.988304,420.1052632,1331.122807,4331.660819,660.3684211,160.8947368,8082.567251,4128.94152,1227.847953,305.7076023,3314.649123,1023.163743,216.3625731,171,15.27158305,14.69656784,0.271822612,0.944751381,0.7125,-0.658881009
+684,37619.77143,874.8,499.3142857,1109.828571,33742.08571,702.9714286,937.2,1635.542857,18407.71429,618.1428571,1217.971429,1766.057143,25408.25714,1325.6,5384.571429,4286.4,9433.257143,1374.742857,407.9142857,2744.228571,17890.88571,457.7428571,254,744.6,22151.37143,501.0285714,136.2285714,3293.971429,17579.31429,1601.4,917.6857143,2806.628571,14696.65714,649.9714286,307.2857143,1846.828571,11033.2,1869.542857,480.8285714,1325.285714,9216.028571,685.9714286,182.6285714,3837.457143,6954.2,1354.942857,318.5714286,3374.457143,292.7142857,213.8571429,35,7.828756337,5.946733173,0.650389058,1,0.729166667,1.213750977
+685,46110.33766,1002.116883,511.4545455,1113.779221,41049.07792,770.1948052,763.974026,1622.558442,22340.62338,652.0519481,499.974026,1726.584416,32486.16883,1431.142857,4271.246753,2995.441558,11045.27273,1474.701299,429.4025974,2422.155844,22540.06494,442.9090909,165.3636364,462.9350649,27405.94805,466.4155844,139.5324675,4317.220779,22363.97403,1636.532468,843.7012987,2815.467532,18812.98701,651.8701299,330.0779221,1867.779221,15063.71429,947.5324675,492.1948052,1308.584416,11903.31169,700.3246753,194.3116883,3225.246753,9866.350649,1492.246753,164.012987,3322.077922,346.2077922,215.5714286,77,13.39582745,7.544679563,0.826313007,0.927710843,0.636363636,-0.751299507
+686,41076.265,886.245,562.255,1115.855,37097.515,732.2,635.9,1630.115,20618.87,620.675,478.725,1782.415,28657.2,1384.7,6514.4,5429.535,10474.895,1393.09,423.215,2457.775,19542.01,438.305,414.645,468.01,23232.695,438.215,133.02,3709.01,18753.185,1524.125,1060.775,2813.915,15446.94,651.935,303.065,3496.175,12478.83,918.25,473.155,1329.025,9330.7,732.485,178.55,3526.74,7387.47,1397.35,297.53,3252.05,476.455,217.645,200,20.66029214,13.01013177,0.776824839,0.884955752,0.606060606,-1.570269897
+687,46945.125,888.7291667,469.9375,1144.1875,41382.70833,732.5,713.6666667,1630.75,23542.04167,622.5208333,575.7083333,1778.979167,32984.04167,1400.1875,3048.229167,2478.0625,11455.08333,1431.354167,423.8125,2695.291667,22263.66667,444.6875,135.9166667,507.8541667,26113.83333,426.3333333,128.5416667,1756.791667,21693.125,1557.854167,906.2708333,2839.5,17698.25,644.1875,309.6666667,3564.041667,14161.97917,1080.895833,474.3333333,1345.333333,10385.39583,659.1666667,177.6458333,2610.208333,8675.9375,1427,288.9583333,3318.916667,489.75,214.2291667,48,9.111174695,6.793100758,0.666417223,0.96,0.685714286,1.378479419
+688,19406.48515,713.990099,454.019802,1091.079208,17760.47525,597.8019802,658.4257426,1502.069307,9500.623762,497.6930693,758.4851485,1775.306931,13438.73267,1127.80198,4057.910891,1841.405941,4928.70297,1166.693069,348.960396,3023.49505,9185.594059,7285.514851,281.0990099,499.3564356,10620.08911,425.3762376,115.7623762,3268.623762,8991.683168,1522.386139,872.6237624,2772.475248,7381.554455,641.5643564,245.9306931,4986.861386,5925.049505,1129.49505,411.7920792,1316.178218,4359.861386,663.6138614,156.4752475,2604.19802,3611.871287,1167.881188,221.980198,3179.910891,528.1584158,217.7425743,101,11.94215502,11.04815504,0.379628199,0.971153846,0.647435897,-0.265773042
+689,21866.89831,757.1864407,540.6525424,1093.194915,19130.94068,621.5932203,413.4237288,1679.389831,10934.61864,510.0254237,399.3474576,1822.398305,15114,1187.474576,5172.364407,3336.423729,5478.457627,1180.415254,383.9915254,2481.542373,10268.36441,3242.067797,1445.677966,437.7966102,11970.20339,386.6949153,114.3898305,6041.627119,10062.72034,1384.533898,1126.059322,2794.025424,8302.415254,615.0338983,263.5932203,20239.10169,6656.5,816.4067797,393.0847458,1332.101695,4952.838983,987.9322034,149.5762712,4052.313559,4231.076271,1197.228814,160.5169492,3145.957627,647.1864407,218.0762712,118,15.91475002,9.813703747,0.787243677,0.959349593,0.602040816,-0.773988247
+690,15769.40758,721.521327,550.3175355,1096.919431,13755.5545,577.3838863,478.4170616,1668.777251,7210.791469,455.7440758,464.5876777,1807.526066,10718.29858,1128.014218,5406.454976,3578.848341,3924.066351,1114.369668,356.943128,2845.080569,6802.848341,3417.739336,443.0853081,454.8104265,8462.876777,412.3838863,115.3696682,6890.061611,6846.516588,1381.308057,977.3933649,2796.810427,5553.270142,558.1800948,260.4170616,23085.57346,4388.834123,786.4312796,382.8151659,1329.265403,2804.061611,830.943128,153.563981,7136.867299,2594.184834,1120.14218,199.9763033,3171.459716,939.8293839,222.7345972,211,25.6319481,10.82335702,0.906474568,0.933628319,0.799242424,0.084745763
+691,19129.38835,760.1165049,591.7669903,1098.067961,16879.32039,600.1941748,691.8640777,1697.38835,8173.456311,470.3009709,1224.359223,1838.242718,12752.38835,1182.398058,8053.135922,5293.592233,4767.883495,1163.407767,354.2427184,5585.485437,8194.359223,580.592233,165.3495146,648.9126214,10051.84466,421.1165049,116.8252427,8597.990291,8597.359223,1756.854369,1144.417476,2798.660194,6966.796117,531.0194175,276.4368932,23372.99029,5459.165049,1210.650485,391.0776699,1367.796117,3466.776699,660.4271845,159.5436893,8910.650485,3201.097087,1160.174757,302.2038835,3201.009709,970.5728155,217.9223301,103,15.32923264,8.847042699,0.816648479,0.919642857,0.64375,0.222992002
+692,15804.30337,846.6067416,568.6404494,1146.988764,14406.1573,676.3033708,1050.662921,1653.775281,7852,560.9101124,760.3370787,1848.05618,11053.83146,1319.011236,7403.865169,2617.674157,4074.05618,1264.730337,386.3033708,2971.483146,7594.966292,2264.617978,671.1011236,549.3595506,8778.752809,739.0898876,122.7078652,3855.325843,7425.348315,1628.325843,884.258427,2825.011236,6080.932584,696.7977528,274.3370787,5272,4850.988764,1049.606742,436.8876404,1340.258427,3717.842697,782.8988764,168.2921348,4458.696629,3169.460674,1263.146067,236.2359551,3269.539326,540.0224719,217.8539326,89,12.60266145,9.207525718,0.682803906,0.956989247,0.570512821,-0.683768682
+693,22811.04902,738.7843137,491.2156863,1112.794118,20807.77451,608.4705882,651.5,1672.852941,11423.02941,500.7941176,570.254902,1819.470588,16724.12745,1223.019608,5912.578431,3214.588235,5818.637255,1173.882353,389.9803922,2648.127451,10855.33333,3685.235294,606.0588235,466.3235294,13074.53922,396.3921569,114.5,6070.441176,11109.32353,1376.666667,868.1764706,2806.558824,8929.705882,534.372549,264.4313725,16749.54902,7176.284314,810.372549,388.4509804,1337.862745,5479.970588,858.4607843,152.0294118,4452.019608,4562.941176,1213.254902,205.9803922,3197.931373,700.2058824,218.7843137,102,11.76548766,11.43411587,0.235661218,0.918918919,0.653846154,-0.759080348
+694,25078.06818,755.5454545,425.0454545,1117.545455,21894.125,605.3181818,396.1477273,1661.965909,12070.67045,478.8977273,474.9545455,1817.272727,17088.29545,1158.409091,3204.170455,2354.852273,6391.431818,1178.5,366.9090909,2988.363636,11058.32955,2069.511364,135.0227273,535.0795455,13810.23864,408.4204545,117.8295455,3870.568182,11592.76136,1339.420455,685.8636364,2843.306818,9457.636364,541.0568182,268.8863636,10606.69318,7268.340909,831.2272727,409.1022727,1312.784091,5098.136364,716.5681818,150.1022727,2432.647727,4371.5,1191.454545,139.4772727,3211.795455,898.4545455,217.25,88,12.91670569,9.052283591,0.713338317,0.907216495,0.628571429,-1.480355868
+695,45799.92667,1005.786667,541.4133333,1133.366667,41661.99333,783.26,782.7333333,1647.74,22812.66,671.72,640.9,1776.54,31540.04,1448.586667,6592.513333,3722.24,11127.06667,1435.62,437.8933333,2515.54,20243.20667,425.0333333,337.68,505.9866667,23506.33333,467.8733333,134.2733333,3646.626667,19655.08,1658.593333,1021.54,2821.593333,16154.11333,726.08,300.7866667,1807.38,13053.65333,969.28,472.9333333,1326.506667,9821.893333,692.62,177.9533333,3120.853333,8137.746667,1386.326667,175.0333333,3283.413333,402.92,218.4,150,18.80737455,10.26029218,0.838080734,0.931677019,0.657894737,1.40287712
+696,17832.18605,675.8139535,413.5174419,1037.703488,15624.90116,558.5930233,426.9127907,1510.238372,8654.668605,451.2209302,401.5697674,1805.180233,12223.59884,1090.47093,4045.290698,2616.72093,4521.360465,1098.255814,391.6162791,2710.122093,8009,2498.436047,494.6860465,468.2093023,9573.639535,375.25,114.8197674,4457.744186,8205.337209,1339.563953,826.4476744,2787.965116,6760.005814,583.4244186,236.2616279,5577.953488,5287.674419,768.5406977,369.0639535,1300.77907,3740.674419,723.4069767,147.8662791,2209.854651,3220.866279,1104.55814,130.8546512,3156.273256,846.6802326,220.2034884,172,18.88114669,12.24912116,0.761002629,0.89119171,0.603508772,-1.23940926
+697,14476.63433,692.7537313,513.9104478,1106.126866,12697.54478,563.8731343,445.0373134,1647.80597,6798.671642,456.0373134,421.2761194,1783.708955,9908.268657,1095.395522,5110.820896,2608.134328,3736.208955,1105.052239,346.1119403,2610.335821,6460.052239,4029.604478,124.880597,437.6119403,8065.813433,390.8208955,111.2910448,6646,6563.783582,1271.291045,862.1567164,2795.61194,5456.626866,528.6492537,274.6268657,27512.06716,4214.440299,709.0522388,377.0373134,1303.283582,2721.08209,771.6865672,144.0597015,5781.701493,2503.037313,1117.350746,197.0447761,3192.246269,928.4328358,218.4626866,134,14.02883508,12.56358236,0.444952415,0.971014493,0.683673469,0.784757842
+698,17276.92523,1068.570093,669.4299065,1064.542056,15471.29907,703.2990654,584.3457944,1438.682243,8023.747664,620.635514,791.0186916,1782.971963,10082.56075,1219.934579,8408.429907,4246.401869,4094.102804,1215.457944,361.8878505,2464.392523,6985.990654,337.7850467,237.9813084,624.5046729,7864.196262,384.9719626,121.9345794,6108.280374,6481.102804,1561.476636,967.3271028,2800.897196,5421.915888,529.2336449,236.9626168,2194.64486,3980.775701,1021.785047,382.8130841,1299.168224,3309.943925,584,155.9065421,4610.224299,2386.514019,1111.196262,170.4299065,3517.224299,281.682243,220.9439252,107,13.58812359,11.12779924,0.573885312,0.849206349,0.514423077,0.051963316
+699,36933.95028,1008.834254,604.038674,1131.209945,32822.23204,744.0497238,824.6132597,1625.491713,18457.52486,627.9447514,864.8066298,1763.116022,25567.09392,1365.497238,5176.78453,3251.519337,9541.20442,1421.635359,419.1933702,2448.110497,18686.19337,416.480663,299.9171271,560.4751381,22363.94475,754.9116022,136.5635359,4059.828729,18140.73481,1572.077348,813.0607735,2829.060773,15174.8011,656.121547,303.8839779,2099.624309,11891.37569,1501.40884,479.0828729,1314.436464,9438.39779,723.8342541,186.9060773,3910.773481,7468.502762,1407.79558,227.2154696,3350.535912,306.8674033,222.2486188,181,17.54965968,14.49400465,0.563838268,0.909547739,0.628472222,1.200151464
+700,37188.85204,896.4795918,442.7193878,1074.765306,32148.66837,706.75,668.4030612,1491.183673,18302.14796,607.4132653,629.5204082,1714.892857,25809.57143,1380.739796,2716.647959,2090.954082,9493.688776,1415.688776,422.2142857,2521.760204,15857.17857,495.1887755,561.1836735,521.0459184,19577.71939,656.122449,130.25,1523.428571,16121.82143,1546.683673,921.8979592,2824.428571,13465.2398,676.4489796,296.0255102,1589.403061,10991.14796,959.5408163,467.2959184,1309.959184,8420.443878,772.994898,181.4489796,2892.719388,7172.72449,1427.178571,270.4183673,3180.428571,370.6836735,223.6632653,196,20.46109952,12.59614452,0.788047645,0.903225806,0.653333333,0.263938058
+701,33404.63636,794.6969697,511.3636364,1099.939394,28895.90909,647.0909091,926.6666667,1564.151515,15924.75758,571.9090909,2702.212121,1842.545455,22817.72727,1262.545455,6744.393939,3798.121212,8161.939394,1274.909091,423.5757576,6006.545455,15345.24242,950.2121212,705.5757576,1059.606061,18010.84848,394.1818182,127,3222.484848,15041.12121,2161.333333,804.6969697,2821.636364,12403.84848,610.6363636,268.4848485,6958.757576,9929.878788,1298.757576,419.969697,1365.424242,7288.757576,783.7878788,165.7272727,3826.393939,6277.424242,1250.757576,433.1515152,3193.787879,519.030303,217.1212121,33,8.212734953,5.454884015,0.747556494,0.942857143,0.589285714,0.898622292
+702,23234.57764,747.515528,470.136646,1081.180124,20619.92547,632.9689441,890.9192547,1647.329193,11111.40373,490.9565217,1394.956522,1825.012422,15527.71429,1166.217391,5993.534161,3597.47205,5786.73913,1166.099379,363.515528,4832.838509,10161.68944,750.2111801,292,883.2670807,12367.81988,394.0745342,118.8695652,4728.031056,10448.10559,1887.850932,832.3540373,2811.621118,8504.385093,528.9751553,264.4658385,11179.04969,6478.950311,1038.701863,392.2484472,1349.68323,4589.198758,751.3229814,153.0807453,3840.813665,3958.614907,1168.677019,227.2857143,3187.68323,887.6273292,222.9254658,161,17.57437651,11.89124455,0.736328726,0.930635838,0.651821862,0.177928417
+703,28353.33043,779.6521739,464.2347826,1070,24975.18261,634.1304348,810.0434783,1604.782609,14159.22609,536.7826087,1298.330435,1826.765217,19810.76522,1228.234783,6707.391304,3826.208696,7252.243478,1227.73913,360.7913043,5239.895652,13363.28696,1951.713043,111.2869565,690.4,15631.93043,397.1391304,117.6086957,4229.286957,13181,1882.026087,847.7478261,2802.886957,11052.50435,614.7826087,268.9391304,4656.704348,8785.321739,1172.33913,430.1130435,1317.73913,6450.53913,665.2173913,167.2695652,2977.043478,5551.469565,1246.426087,282.9565217,3188.808696,576.9043478,223.0521739,115,16.54535422,9.273173425,0.828174779,0.905511811,0.580808081,-0.208612319
+704,20083.12752,741.3154362,488.0201342,1123.832215,17016.51678,594.3087248,520.4362416,1639.90604,8913.85906,466.2751678,568.1610738,1803.66443,14072.11409,1158.040268,5028.275168,2363.436242,5219.724832,1165.208054,356.5637584,3329.624161,8871.154362,504.8389262,138.3758389,576.9261745,11135.01342,398.7852349,117.8120805,7328.718121,9517.375839,1423.798658,884.6778523,2863.630872,7706.120805,536.1946309,262.8322148,16343.25503,6086.255034,858.8187919,389.6778523,1339.241611,3893.503356,659.1610738,155.8456376,5251.04698,3608.563758,1166.355705,230.5704698,3209.651007,963.8053691,225.261745,149,18.78952349,10.52911581,0.828241295,0.881656805,0.573076923,0.371332839
+705,24401,856.1525424,606.5932203,1172.991525,19894.69492,682.5084746,939.3559322,1808.084746,10623.02542,511.5762712,1546.474576,1882.508475,16565.11017,1260.745763,6333.720339,4306.830508,6130.330508,1256.79661,375.3813559,3341.245763,10714.48305,507.6949153,146.6779661,1183.79661,13405.65254,447.9661017,537.2627119,6807.29661,11254.74576,1759.313559,922.3898305,2850.830508,9277.932203,572.7542373,318.0423729,33738.92373,7092.516949,1033.567797,423.7372881,1360.542373,4433.79661,655.2288136,159.1949153,7913.974576,4167.872881,1264.152542,447.6949153,3303.118644,988.3559322,220.8898305,118,14.76450747,10.39515775,0.710136554,0.921875,0.648351648,0.438437222
+706,23492.75862,781.045977,558.862069,1109.505747,21343.83908,618.0574713,514.0689655,1540.83908,10864.63218,537.2988506,451.4022989,1774.436782,15669.82759,1162.448276,4794.057471,5147.436782,5886.965517,1218.678161,369.2183908,2383.678161,11499.41379,332.6781609,113.9195402,438.5632184,13204.52874,388.3793103,121.2183908,3484.344828,10447.36782,1357.011494,858.0229885,2802.241379,8595.862069,554.5632184,264.3563218,4066.942529,6122.54023,755.1724138,422.091954,1309.183908,5306.448276,614.7241379,164.1609195,3629.563218,3827.632184,1197.988506,190.2873563,3183.609195,247.0574713,223.4597701,87,13.45326737,8.535917608,0.772933878,0.896907216,0.621428571,0.303533976
+707,20298.55696,1050.417722,584.4810127,1062.012658,17663.67089,717.2658228,748.6708861,1481.088608,9730.974684,616.5063291,616.7468354,1765.35443,13479.48101,1230.898734,4768.987342,3902.594937,5240,1295.493671,398.4177215,2602.848101,9534.35443,386.9493671,269.2151899,498.8734177,11356.13924,432.7088608,123.4936709,3910.607595,9187.101266,1456.594937,919.2151899,2800.848101,7756.873418,603.1012658,260.5063291,2001.025316,5834.35443,1245.202532,425.4556962,1319.025316,4825.898734,637.835443,161.9746835,3929.64557,3675.506329,1188.708861,186.5822785,3431.151899,294.3924051,220.2025316,79,15.10845493,7.402147801,0.871759453,0.840425532,0.526666667,-1.111659198
+708,17904.05,845.9333333,442.9,1038.866667,17119.16667,651.5333333,509.3,1325.183333,9227.966667,550.3,398.1,1684.616667,12397.35,1367.066667,1932.816667,1678.433333,5298.683333,1685.75,412.4666667,2455.883333,9300.2,385.1166667,319.0833333,413.0666667,10084.11667,364.8833333,126.8166667,1680.966667,8429.65,1397.783333,817.4833333,2814.5,7421.7,629.1166667,270.2833333,1402.566667,5911.266667,823.2,452.7166667,1305.916667,4822.083333,696.6333333,193.4833333,3131.033333,3649.3,1404.366667,561.6,2995.083333,350.0833333,221.15,60,12.81874676,6.240348849,0.873505504,0.923076923,0.545454545,-0.758728419
+709,20010.71831,757.1760563,554.5140845,1106.943662,18486.42254,608.6338028,711.2746479,1696.204225,9017.507042,473.3028169,537.3521127,1791.957746,13794.87324,1151.929577,7444.830986,3708.366197,5074.661972,1152.190141,356.6971831,2880.788732,8798.584507,2960.394366,142.5211268,545.4647887,10953.05634,462.1408451,124.6197183,10291.69014,9143.901408,1410.633803,981.1901408,2788.795775,7377.077465,612.9788732,266.3450704,18875.01408,5852.105634,903.9507042,387.6267606,1335.591549,3818.866197,698.7535211,158.8732394,6134.288732,3458.021127,1145.823944,212.3873239,3217,951.6760563,222.9788732,142,19.5184809,11.23834847,0.817604756,0.759358289,0.525925926,0.700970066
+710,25257.07407,911.4444444,856.7962963,1219.268519,21967.7037,707.6944444,782.0648148,1920.787037,11094.78704,529.1203704,556.3518519,1837.175926,17151.23148,1279.481481,3186.62037,2019.092593,6173.518519,1292,389.5925926,2680.694444,11239.90741,657.8703704,199.537037,494.7962963,13369.75,502.8518519,125.7314815,2740.009259,11280.44444,1528.157407,708.7962963,2842.703704,9174.138889,582.5462963,309.4351852,29481.78704,6947.37963,1126.231481,442.0185185,1372.324074,4199.916667,718.3333333,168.8611111,7002.814815,3951.527778,1289.018519,324.2962963,3344.611111,1001.175926,222.8425926,108,13.91137248,10.32565351,0.67012807,0.947368421,0.771428571,-0.058105304
+711,28665.41146,877.9166667,598.2135417,1167.083333,23293.88021,690.0364583,612.3333333,1838.046875,11241.45833,526.890625,520.9375,1814.317708,18422.89063,1256.546875,2885.151042,1713.572917,6786.864583,1323.739583,392.375,2524.505208,12229.74479,871.5625,201.9479167,537.2708333,14613.45833,468.9479167,131.75,3496.8125,12513.58333,1457.625,738.34375,2891.953125,10137.45833,578.8854167,282.671875,12195.8125,7536.541667,911.4375,419.1041667,1335.598958,4287.557292,688.2552083,162.171875,4331.734375,4179.463542,1262.442708,283.59375,3248.78125,1034.333333,225.2916667,192,18.33225271,13.63046668,0.668709443,0.945812808,0.6,0.025703782
+712,37542.44118,887.7941176,578.8235294,1127.411765,32871.69118,709.8088235,707.4117647,1698.705882,17434.33824,584.7647059,597.3235294,1804.544118,24829.61765,1284.882353,4992.926471,3391.529412,9140.411765,1363.529412,414.6176471,2452.352941,17407.33824,507.7205882,288.0147059,727.7058824,20588.01471,423.1470588,135.4264706,3743.132353,16268.33824,1533.661765,816,2802.338235,13256.76471,616.6911765,296.1617647,2925.088235,9469.352941,837.7794118,457.4852941,1294.514706,7878.558824,683.8970588,183.3235294,3080.176471,5959.191176,1325.147059,203.9705882,3336.75,254.5441176,222.75,68,14.16585897,7.368670014,0.854062093,0.772727273,0.472222222,0.561027814
+713,30309.07547,1106.330189,587.8490566,1094.358491,26561.56604,730.6132075,997.3773585,1523.858491,14492.16038,637.8018868,1707.04717,1758.575472,20335.57547,1351.273585,5444.216981,4170.632075,7158.981132,1329.745283,399.5,3496.04717,14029.60377,433.4528302,386.4716981,804.3018868,16453.65094,528.4339623,121.490566,2863.584906,13701.81132,2069.830189,812.0849057,2855.433962,11223.99057,644.4245283,289.3018868,1737,9047.066038,1347.028302,452.9433962,1341.066038,6914.103774,703.9245283,177.1320755,4386.858491,5856.641509,1339.141509,583.2735849,3350.669811,391.490566,223.4339623,106,12.32266597,12.02848608,0.217200876,0.905982906,0.582417582,0.204429595
+714,27855.19118,866.75,661.6617647,1084.029412,24710.42647,680.6323529,639.3823529,1529.632353,13171.92647,562.7941176,464.8676471,1766.294118,19551.08824,1328.926471,4227.985294,3386.411765,6626.647059,1302.720588,404.9852941,2500.5,13114.32353,409.3970588,1027.029412,466.9117647,15615.48529,429.8235294,129.6323529,3216.411765,12697.45588,1545.647059,962.9705882,2807.970588,10378.36765,682.2205882,282.7647059,2125.205882,8465.411765,852.3676471,445.4117647,1309.426471,6373.132353,870.8235294,168.8970588,4866.132353,5330.014706,1381.5,2408.470588,3181.25,425.2352941,221.8088235,68,10.48611744,8.505025499,0.584942463,0.957746479,0.561983471,-0.778270243
+715,32165.33333,833.4380952,541.9238095,1097.780952,27808.06667,678.4761905,865.5428571,1596.495238,15648.88571,577.9428571,797.7619048,1820.019048,22342.98095,1303.295238,6680.904762,5411.761905,8278.52381,1335.752381,398.4952381,2700.67619,15162.49524,431.4380952,122.0190476,679.1809524,17439.48571,835.2,131.5904762,3716.752381,14451.70476,1494.438095,1310.771429,2820.219048,11945.30476,622.847619,286.7904762,6025.761905,9561.057143,1199.104762,449.0857143,1326.87619,7154.533333,645.2190476,187.7238095,5052.752381,5779.742857,1327.161905,679.847619,3264.447619,497.5428571,221.3047619,105,17.43348332,8.260410695,0.880619321,0.875,0.614035088,1.530909568
+716,18023.75472,722.0471698,546.4433962,1078.386792,15032.38679,577.2264151,558.4811321,1634.773585,8986.915094,470.6886792,389.754717,1829.141509,12932.48113,1151.066038,4930.311321,5582.103774,4741.679245,1120.113208,344.2641509,2522.301887,8317.990566,1642.198113,148.4528302,432.5,10068.68868,389.5943396,111.3584906,9256.45283,8652.028302,1283.679245,1448.5,2794.424528,7102.584906,534.8773585,248,13248.40566,5860.018868,837.3962264,379.4150943,1321.207547,4310.207547,653.8584906,149.754717,4512.349057,3664.075472,1178.566038,183.9433962,3196.45283,725.990566,222.3773585,106,13.2178925,10.61451272,0.595923464,0.883333333,0.627218935,1.198169614
+717,18683.96825,716.9047619,462.9444444,1137.396825,16186.54762,575.3730159,429.3571429,1638.603175,9040.190476,468.5873016,389.9603175,1781.722222,13356.19048,1123.031746,4502.84127,2865.190476,4870.912698,1125.730159,352.6984127,2468.857143,8563.095238,1685.087302,127.4206349,440.8968254,10878.37302,423.2142857,115.2301587,6083.325397,8747.857143,1304.31746,850.547619,2788.460317,7213.222222,538.9761905,254.2460317,14580.30952,5709.492063,763.5555556,387.5396825,1316.404762,3765.206349,690.7222222,146.1428571,3713.563492,3398.119048,1146.492063,164.5634921,3255.634921,920.3968254,224.4285714,126,18.90882934,8.953908319,0.880777395,0.913043478,0.494117647,0.650379853
+718,33720.71324,1099.338235,524.9779412,1097.433824,29852.71324,766.0514706,706.5808824,1559.227941,16271.52206,648.1617647,513.9411765,1721.227941,23603.69853,1429.933824,2044.985294,2196.198529,8224.397059,1661.161765,427.5,2416.852941,15843.52206,419.0514706,654.8529412,508.5588235,18856.22794,424.2720588,133.9411765,1573.551471,15466.57353,1602.566176,841.2058824,2846.257353,12972.75,729.3235294,298.2647059,1659.933824,10474.05882,973.9338235,473.5808824,1321.742647,8272.294118,814.2352941,186.3088235,3539.551471,6823.941176,1412.919118,393.6102941,3275.522059,338.2941176,224.8529412,136,15.75351604,11.08162944,0.710756146,0.944444444,0.693877551,0.717236536
+719,39390.26012,840.2890173,504.6936416,1085.872832,33961.47399,692.5606936,861.5144509,1525.433526,19090.64162,594.9595376,1524.919075,1813.057803,26617.90173,1319.901734,7237.190751,3818.439306,9694.572254,1348.959538,429.5144509,3851.67052,18097.13873,647.0809249,1035.549133,807.8150289,21361.39884,488.0520231,127.0520231,3342.924855,17640.67052,1925.069364,825.3815029,2830.069364,14680.53179,631.0289017,288.1907514,5428.566474,11639.01734,1151.069364,452.5433526,1383.283237,8505.075145,841.3930636,171.1734104,3080.763006,7250.404624,1310.150289,436.6878613,3220.393064,517.4682081,227.265896,173,16.34317754,14.38313432,0.474844643,0.873737374,0.600694444,0.31432048
+720,17678.08511,717.2180851,415.4734043,1072.595745,15991.60638,585.0531915,651.5106383,1471.553191,8681.244681,484.2074468,499.3989362,1748.925532,12094.04255,1129.085106,3067.797872,1491.691489,4472.81383,1169.739362,357.6223404,2661.946809,8263.468085,4442.255319,522.8510638,432.7925532,9442.18617,414.9255319,112.037234,3429.728723,7885.808511,1397.675532,818.0106383,2799.026596,6445.510638,1111.069149,247.2021277,6048.840426,5132.441489,791.7393617,394.0106383,1324.111702,3868.670213,706.2340426,154.2553191,2861.734043,3216.361702,1147.840426,138.6968085,3138.468085,547.7606383,226.6329787,188,18.58599608,13.33366581,0.696657494,0.949494949,0.706766917,-0.158760224
+721,15208.1393,684.8756219,477.6069652,1066.024876,13564.36318,577.3482587,491.2537313,1555.880597,7602.621891,479.2885572,410.6616915,1792.034826,10750.29353,1097.890547,5159.437811,2564.293532,3951.20398,1123.711443,364.2935323,2600.78607,7343.766169,5542.925373,831.4378109,432.2288557,8559.472637,381.2288557,109.4477612,5887.104478,7219.706468,1310.671642,826.4527363,2785.616915,6109.587065,637.6069652,257.7363184,22547.91045,4993.199005,723.5273632,365.0646766,1356.940299,3718.079602,1005.149254,148.8258706,4076.502488,3220.283582,1132.567164,147.5074627,3148.890547,632.1542289,225.2985075,201,18.68625513,14.3357975,0.64142699,0.922018349,0.587719298,0.862200897
+722,24299.39394,793.0606061,545.7272727,1090.439394,20822.11364,632.8787879,927.5984848,1730.818182,12387.85606,527.2348485,766.780303,1866.537879,17392.96212,1214.44697,5660.378788,5915.484848,6141.977273,1228.80303,374.7121212,4441.856061,11082.68939,1147.015152,134.8712121,697.6136364,13228.74242,405.1666667,117.1363636,5540.795455,11650.44697,1659.75,1535.931818,2802.530303,9359.265152,563.0833333,265.1060606,12481.68182,7563,990.9545455,403.1818182,1333.227273,5589.507576,636.030303,173.9242424,4273.121212,4826.659091,1254.530303,248.9393939,3264.795455,717.3181818,227.7424242,132,20.32391253,9.761532835,0.877105417,0.771929825,0.534412955,0.210551027
+723,23749.36471,828.8235294,650.8588235,1167.823529,20985.55294,657.8941176,748.4588235,1912.6,10294.56471,505.9176471,1096.129412,1888.6,16021.63529,1227.811765,6580.729412,4301.294118,5772.047059,1225.152941,361.9058824,3263.917647,10129.97647,1092.329412,162.0588235,874.9764706,12326.85882,425.4235294,182.3529412,8758.211765,10217.77647,1577.152941,984.0823529,2840.305882,8136.811765,550,305.4588235,37994.94118,6220.388235,908.7058824,412.8941176,1328.352941,4008.941176,681.5411765,158.4470588,9601.047059,3547.6,1205.235294,340.9294118,3265.188235,979.2588235,223.5176471,85,12.03836555,9.560999061,0.607642428,0.87628866,0.643939394,0.323207335
+724,31032.5119,845.6547619,677.3214286,1151.75,27838.2381,642.5238095,573.4761905,1694.809524,14032.89286,564.7619048,415.5,1761.142857,19998.40476,1169.857143,7171.857143,5158.011905,7267.892857,1247.285714,387.7380952,2361.511905,14508.11905,340.547619,171.8452381,409.3571429,16769.04762,379.6428571,122.0595238,8736.678571,12917.27381,1365.666667,704.6547619,2816.154762,10520.96429,553.75,271.797619,3061.202381,6530.797619,743.3571429,410.5714286,1292.75,5967.27381,613.2380952,166.5,2603.321429,4265.940476,1181.178571,163.0952381,3148.952381,224.5952381,224.6785714,84,14.74587501,8.059246888,0.83743139,0.770642202,0.509090909,1.170931067
+725,44749.92727,986.3636364,609.8181818,1181.709091,39552.07273,764.3818182,538.9272727,1781.381818,20577.63636,648.4909091,460.1818182,1772.381818,29524.32727,1388.363636,6704.072727,4158.327273,10635.49091,1469.145455,468.6,2421.945455,20850.83636,407.3272727,154.3272727,437.5272727,24833.54545,439.3090909,137.6545455,5559.636364,19765.29091,1522.872727,787.1272727,2820.654545,15931.78182,608.9454545,315.2363636,3061.690909,10466.38182,857.0363636,497.7272727,1319.345455,9124.4,663.8909091,190.9090909,1911.763636,6899.018182,1365.909091,148.4909091,3276.454545,235.4363636,223.0909091,55,9.369775887,7.858481379,0.544585436,0.948275862,0.555555556,1.516858596
+726,27363.37705,1063.180328,575.8852459,1094.557377,24230.02459,769.9344262,609.4180328,1565.508197,12984.04918,645.1639344,475.942623,1746.491803,18408.36066,1449.959016,4251.459016,3273.811475,6943.032787,1437.401639,429.1967213,2440.139344,13459.33607,428.4180328,231.3934426,455.0819672,15523.41803,457.6065574,128.8114754,3446.016393,12806.04098,1543.491803,857.057377,2820.639344,10548.5082,785.4836066,299.0737705,2249.204918,8497.327869,901.4180328,476.2540984,1321.762295,6865.467213,684.9508197,190.1065574,3690.07377,5453.188525,1435,380.5819672,3396.434426,321.557377,226.1065574,122,14.63533368,11.09418133,0.652207032,0.924242424,0.677777778,-0.408465316
+727,29223.21296,881.8333333,626.3333333,1097.953704,25487.46296,730.2222222,623.9351852,1576.777778,13307.43519,581.1388889,505.9166667,1747.824074,19185.87037,1322.777778,5595.083333,5610.703704,6883.490741,1316.222222,398.287037,2454.435185,12801.42593,403.6296296,1595.194444,500.8981481,14801.34259,408.0277778,128.0185185,4651.759259,12039.89815,1568.666667,1109.898148,2798.777778,9772.064815,635.7407407,287.7314815,2482.851852,7961.824074,892.1111111,455.4722222,1353.481481,5918.046296,1038.861111,177.8796296,6776.75,4851.055556,1347.462963,1416.148148,3202.175926,432.7407407,225.6759259,108,17.85667576,7.832385582,0.898670157,0.931034483,0.48,-0.760962159
+728,31688.30435,837.4782609,510.1449275,1077.376812,27251.14493,675.3043478,986.3913043,1585.376812,14953.26087,578.1884058,1275.217391,1772.608696,21301.01449,1273.26087,6375.115942,5120.304348,8016.695652,1321.362319,395.9565217,3117.768116,14451.56522,1013.42029,131.0289855,711.9855072,16814.08696,1274.043478,124.6811594,2891.478261,13679.04348,1697.666667,866.8985507,2819.028986,11302.89855,639.7681159,276.1594203,6766.289855,9112.623188,1924,437.0869565,1319.478261,6962.507246,636.1449275,174.2753623,3904.492754,5530.304348,1295.231884,1191.231884,3241.231884,507.6086957,224.5797101,69,13.09887982,6.866086585,0.851611455,0.945205479,0.575,-0.612018659
+729,15052.87558,706.4147465,472.3041475,1122.327189,13723.32258,578.3041475,382.6820276,1790.465438,7659.147465,477.7465438,412.0092166,1931.663594,10869.03687,1136.940092,4415.294931,2360.986175,3981.912442,1153.165899,358.2764977,2545.248848,7571.119816,497.8479263,291.9631336,466.9354839,8680.571429,361.281106,108.8248848,5290,7534.880184,1256.714286,813.2949309,2837.423963,6252.857143,527.3087558,251.8248848,18006.05069,5116.797235,715.4147465,372.2857143,1321.792627,3823.258065,746.8571429,147.921659,3848.327189,3256.75576,1155.341014,150.4239631,3105.580645,671.3041475,227.562212,217,22.65392598,12.79128877,0.825338032,0.875,0.601108033,0.621832843
+730,28990.88462,798.8461538,503.9711538,1112.673077,25216.89423,634.0576923,807.5865385,1843.548077,12707.36538,510.1442308,591.1826923,1874.144231,20260.95192,1190.057692,4781.798077,3396.798077,7264.423077,1221.798077,369.7403846,3219.182692,13052.125,3177.298077,284.9423077,513.8461538,15599.5,460.0961538,126.0576923,5108.048077,13127.83654,1511.288462,894.2596154,2813.423077,10524.69231,551.0384615,262.2307692,10340.13462,8035.538462,941.2692308,408.4038462,1319.365385,4779.538462,712.8173077,155,4535.423077,4498.596154,1212.923077,269.5288462,3256.019231,1011.596154,223.9615385,104,12.19107407,11.29220118,0.376865607,0.945454545,0.859504132,-0.870322824
+731,26872.14414,1089.288288,717.6756757,1208.774775,23749.13514,895.2432432,785.6846847,1704.783784,12085.77477,676.6036036,597.7297297,1762.711712,17173.61261,1626.189189,2866.720721,4217.774775,6097.774775,1508.162162,530.1261261,2635.918919,9538.396396,473.2972973,4277.585586,523.2972973,10976.78378,469.4054054,143.0990991,3528.432432,8951.666667,1872.765766,1038.378378,2821.171171,7283.099099,677.8198198,319.8378378,2244.36036,5862.432432,993.1891892,492.1441441,1445.828829,4545.189189,1905.441441,196.2162162,5501.963964,3559.135135,1450.612613,337.8108108,3226.927928,450.7387387,227,111,15.77229034,9.171952908,0.813529813,0.917355372,0.74,0.21878865
+732,35001.79452,921.7945205,930.6027397,1175.794521,29581.0411,721.9178082,1030.246575,1794.561644,17354.57534,557.0821918,487.7534247,1801.876712,24220.21918,1341.054795,3766.39726,2279.753425,8622.712329,1329.958904,399.109589,2744.671233,15391.12329,1839.027397,134.0136986,487.9452055,18894.36986,478.9589041,133.9178082,5053.835616,15809.50685,1504.616438,686.9589041,2816.589041,12942.24658,597.4520548,278.2191781,5774.054795,10035.9726,840.6986301,445.7808219,1341.520548,7222.986301,666.9452055,159.3150685,2601.273973,6367.39726,1343.136986,108.5616438,3319.493151,825.109589,224.5890411,73,12.13943262,7.978573325,0.753677573,0.879518072,0.561538462,1.321580978
+733,23686.48837,931.0697674,564.3565891,2009.217054,21049.03876,675.0232558,927.3100775,3211.232558,11475.29457,514.4418605,494.5116279,1916.751938,16547.96899,1272.077519,3363.147287,2201.945736,6010.496124,1321.410853,390.6124031,2663.372093,10833.4031,675,264.5116279,495.8992248,13407.90698,507.3875969,125.0697674,3350.55814,10968.00775,1515.108527,907.620155,2809.534884,9038,595.2248062,278.7674419,7783.542636,6932.131783,965.5581395,425.2093023,1320.79845,4788.713178,753.9612403,158.8604651,3641.976744,4197.674419,1256.271318,137.6821705,3341.062016,912.0310078,227.7364341,129,17.03451559,10.36021632,0.793791744,0.902097902,0.573333333,0.694968619
+734,47495.13761,963.5321101,567.266055,1160.697248,41525.99083,791.3669725,700.4495413,1679.293578,22545.79817,638.5321101,504.853211,1776,31362.49541,1450.495413,5413.266055,4709.137615,10985.01835,1437.486239,441.0642202,2465.587156,19346.76147,439.3394495,1074.495413,465.8348624,23062.6055,424.3119266,140.0733945,3918.568807,18467.77982,1595.146789,1144.247706,2817.183486,14960.53211,633.6422018,308.9541284,2328.458716,12166.89908,935.7431193,480.7155963,1344,9218.449541,947.8256881,174.9908257,3640.486239,7109.908257,1399.40367,154.1834862,3302.944954,461.3027523,225.8807339,109,13.86765277,10.77090627,0.629879569,0.908333333,0.648809524,-1.209018601
+735,45126.63333,890.6777778,523.1555556,1127.011111,41318.17778,760.1333333,727.3666667,1613.044444,22527.98889,621.5888889,534.1888889,1774.477778,31952.81111,1382.7,5610.644444,4685.711111,11053.06667,1411.755556,424.8777778,2478.044444,21790.81111,444.9,901.3555556,474.8111111,25179.52222,420.1888889,141.1777778,3782.833333,20819.2,1620.766667,996.8111111,2828.8,17204.76667,633.5222222,311.6,3708.122222,14005.31111,940.8777778,479.2666667,1330.833333,10300.01111,878.1111111,184.0222222,2918.222222,8263.8,1409.277778,537.4,3282.3,485.0222222,226.1444444,90,12.50231418,9.687068728,0.632179395,0.927835052,0.576923077,-0.883981218
+736,19954.22989,758.3793103,540.9770115,1078.942529,17982.96552,647.4367816,848.5977011,1674.091954,10049.22989,519.9770115,1809.770115,1847.126437,14517.67816,1177.988506,7053.666667,4618.333333,5258.195402,1180.022989,376.2758621,4867.114943,9233.712644,529.3908046,112.7471264,2015.471264,11176.02299,393.2528736,114.6436782,4801.402299,9592.275862,1916.298851,1249.942529,2791.37931,7717.643678,553.1034483,267.045977,20009.14943,6294.045977,991.4137931,391.2183908,1339.126437,4779.804598,633.2413793,158.6436782,5297.528736,4056.011494,1212.448276,299.4827586,3187.528736,709.0114943,226.4367816,87,12.69988466,8.927728823,0.711212427,0.966666667,0.604166667,0.65729681
+737,21133.99355,777.0064516,537.8774194,1122.974194,19418.22581,628.9354839,546.316129,1715.864516,10109.5871,498.7870968,421.6967742,1853.632258,14806.4129,1185.4,3839.43871,2701.206452,5396.941935,1189.922581,399,2692.380645,9529.251613,7156.954839,564.1612903,482.9032258,11682.52903,468.5806452,119.1032258,4522.574194,9607.83871,1397.606452,814.3677419,2784.941935,7764.625806,619.0322581,260.116129,10902.25806,6109.03871,790.5548387,397.0064516,1325.63871,4667.270968,881.1806452,161.7741935,3913.903226,3849.206452,1217.187097,143.2387097,3202.851613,814.6322581,228.916129,155,17.55844462,11.48261876,0.756524286,0.906432749,0.701357466,0.229862428
+738,17565.6729,719.4018692,460.6915888,1054.35514,14922.28037,600.7383178,999.2523364,1588.457944,8313.82243,481.0280374,1219.88785,1839,11772.38318,1130.897196,5796.654206,3331.635514,4410.588785,1146.271028,398.8317757,5731.785047,7786.626168,557.2616822,1024.420561,695.8224299,9347.214953,382.7102804,116.5420561,3828.186916,8049.17757,1736.672897,763.3364486,2806.551402,6611.990654,596.7663551,250.5607477,13251.24299,5235.271028,1021.88785,391.6448598,1402.588785,3660.457944,1063.607477,218.9345794,4219.672897,3197.102804,1167.560748,211.3925234,3164.242991,859.6168224,226.5514019,107,11.97183217,11.57033035,0.256806679,0.946902655,0.743055556,1.432885325
+739,33164.65385,881.9807692,707.1538462,1105.038462,30148.23077,681.9230769,950.5384615,1643.269231,15957.90385,610.5192308,1425.576923,1840.384615,22238.28846,1275.25,8013.596154,5920.538462,8284.461538,1346.173077,428.4807692,2584.807692,15544.01923,403.2307692,2867.865385,1573.192308,19266.96154,578.4038462,420.2692308,5482.826923,15319.90385,2611.653846,944.0769231,2864.884615,12663.94231,599.7692308,302.0192308,1884.673077,9301.846154,985.2692308,448.4807692,1327.403846,7633.384615,1224.384615,178.9807692,4945.788462,5776.923077,1304.076923,293.9423077,3360.538462,275.3846154,227.1153846,52,10.38861354,6.489392239,0.780893697,0.945454545,0.590909091,0.380109527
+740,22442.31959,809.8969072,497.3092784,1075.556701,19103.19588,650.3298969,663.2783505,1474.783505,10381.2268,544.4226804,622.5051546,1768.216495,15148.6701,1285.969072,3867.886598,3479.474227,5719.020619,1292.721649,401.3814433,2462.340206,10159.35052,397.2061856,1409.43299,502.6597938,12300.91753,430.4639175,123.5051546,3532.113402,9707.556701,1465.298969,1003.804124,2850.494845,8017.123711,857.8350515,262.5463918,2568.958763,6649.587629,1057.391753,440.8659794,1351.43299,5049.247423,963.9278351,176.0721649,5284.43299,4080.525773,1310,736.3917526,3171.134021,441.8247423,228.6804124,97,13.46209608,10.70248812,0.606597578,0.866071429,0.532967033,0.301293395
+741,16631.25949,689.2531646,457.278481,1060.85443,14233.63924,585.3924051,422.6898734,1541.487342,8333.405063,481.4556962,413.0759494,1791.462025,11661.02532,1100.860759,4594.753165,3042.5,4325.405063,1115.936709,345.9873418,2631.177215,7770.594937,4340.481013,1528.626582,442.4240506,9171.949367,382.4936709,109.8481013,4350.35443,7704.322785,1313.816456,818.9177215,2782.474684,6489.987342,588.835443,246.6708861,16773.96835,5316.14557,746.5696203,367.5506329,1347.518987,3839.658228,1167.822785,142.6582278,4271.987342,3330.398734,1136.512658,169.443038,3119.955696,622.1075949,230.6139241,158,20.96873185,10.32487014,0.870372625,0.872928177,0.546712803,0.789004152
+742,20301.39796,894.3061224,770.6836735,1171.122449,18568.26531,707.1836735,947.0102041,1827.642857,10320.06122,564.5510204,440.5816327,1866.142857,14143.59184,1348.122449,4309.081633,2785.938776,5134.102041,1331.693878,399.7142857,2517.765306,9098.663265,595.7142857,119.3265306,468.9285714,10815.71429,463.1122449,123.244898,4790.040816,9153.479592,1422.520408,715.877551,2812.734694,7573.959184,590.3673469,289.1326531,17131.18367,6083.193878,1029.020408,418.7857143,1333.214286,4654.010204,644.1428571,164.3061224,3534.602041,3895.285714,1336.346939,161.1734694,3356.040816,740.7755102,228.2142857,98,15.09486621,8.608960073,0.821420031,0.91588785,0.544444444,-0.65245319
+743,18022.40367,742.3761468,564.8990826,1111.908257,15715.88073,595.6880734,612.6880734,1642.743119,8645.981651,475.4862385,455.1100917,1827.577982,12416.83486,1160.568807,6868.357798,3606.036697,4673.880734,1159.330275,357.412844,2603.366972,8061.715596,3382.623853,125.4862385,456.3394495,9836.752294,460.9816514,119.7522936,9920.513761,8251.376147,1380.798165,1042.055046,2820.018349,6865.100917,846.9266055,252.3211009,9653.688073,5395.541284,764.440367,395.3486239,1309.211009,3914.954128,702.8073394,150.4770642,4511.779817,3329.293578,1180.761468,142.9449541,3212.541284,830.5779817,229.5045872,109,21.21758273,8.099781266,0.924266223,0.746575342,0.409774436,-1.118547793
+744,27838.06569,785.0547445,501.3321168,1104.682482,24446.67883,643.9708029,848.9160584,1734.711679,13894.64234,533.4489051,1532.952555,1888.072993,19349.63504,1247.740876,5012.540146,3082.967153,7052.70438,1219.072993,358.8576642,5320.839416,13063.70438,1469.854015,116.040146,753.7846715,15282.83212,405.2627737,116.5948905,2716.025547,12957.33577,1742.032847,785.0145985,2804.894161,10724.87226,633.0255474,269.0729927,9292.372263,8555.569343,1306.682482,420.0145985,1321.985401,6313.153285,695.5364964,160.4781022,3984.748175,5385.313869,1237.40146,275.8175182,3245.124088,586.4817518,235.080292,274,24.77640457,15.66830407,0.774651701,0.881028939,0.541501976,0.730773093
+745,18857.60656,716.5081967,466.0273224,1056.103825,16812.80874,599.010929,1418.688525,1701.469945,9547.218579,504.989071,1545.010929,1969.464481,13390.25137,1152.710383,7061.983607,3782.218579,4965.79235,1132.306011,338.5355191,7017.174863,9012.191257,489.5737705,228.6448087,848.1420765,10632.95628,389.7814208,111.4590164,3668.251366,8991.491803,1944.344262,687.5409836,2782.10929,7413.775956,602.0327869,247.8579235,14443.08743,5991.273224,1245.448087,392.6229508,1327.530055,4510.377049,763.147541,148.2568306,4620.387978,3806.825137,1168.371585,287.9617486,3202.005464,598.3606557,229.6448087,183,16.58592599,14.99503386,0.427359445,0.92893401,0.71484375,0.21627761
+746,22831.93846,757.1,555.8076923,1081.207692,20346.73846,606.7307692,601.0538462,1640.446154,11495.42308,510.5538462,600.7,1789.446154,16522.13846,1170.415385,6239.461538,4253.953846,5880.530769,1161.184615,368.5692308,3162.423077,11001.50769,1813.330769,260.0615385,538.9615385,12912.82308,378.4769231,111.6923077,9684.169231,10958.63077,1446.269231,1114.307692,2787.484615,9087.492308,543.5307692,259.1153846,17789.33077,7291.330769,868.5230769,390.2846154,1321.492308,5480.146154,784.2153846,155.0846154,5604.630769,4687.353846,1207.092308,236.3692308,3199.084615,685.5461538,228.4769231,130,15.31652788,11.20747625,0.681600682,0.942028986,0.625,-1.277799681
+747,18443.88776,739.6785714,485.9285714,1140.377551,16132.94388,590.1581633,770.75,1721.938776,8795.964286,471.6479592,848.6581633,1796.612245,12798.16837,1126.489796,5281.428571,3737.846939,4748.091837,1151.142857,373.4438776,5026.780612,8165.387755,5267.806122,935.5918367,601.9234694,10277.58163,454.5306122,116.7959184,4840.005102,8450.030612,1728.352041,910.1938776,2928.520408,6918.69898,563.627551,258.6785714,13330.5102,5406.153061,1093.117347,391.005102,1359.673469,3747.69898,944.3061224,154.1326531,4804.459184,3236.336735,1153.137755,205.6734694,3225.25,899.2346939,230.4387755,196,17.21808926,15.6330434,0.419093702,0.899082569,0.687719298,-1.268701872
+748,26707.16759,837.4383057,561.7550645,1157.373849,22741.0663,660.9263352,856.2799263,1832.001842,9836.941068,496.7642726,1197.410681,1803.335175,17009.66114,1203.791897,4972.486188,3049.585635,6148.290976,1228.532228,367.9263352,5066.259669,11216.4291,2187.438306,310.4861878,983.106814,13401.45488,513.3001842,124.0165746,3950.59116,10989.79742,1834.279926,692.3093923,2821.117864,8838.891344,556.5082873,260.3186004,6549.335175,6333.941068,1099.876611,400.7311234,1316.375691,3439.828729,698.9097606,152.2799263,4247.766114,3437.87477,1159.488029,392.0865562,3229.460405,1061.532228,237.7569061,543,30.2237655,23.37050813,0.634102031,0.914141414,0.696153846,-0.056093608
+749,30425.81818,853.4,634.6,1095.890909,27353.43636,668.2181818,766.0363636,1602.8,14491.34545,569.1090909,798.4727273,1808.127273,20018.43636,1224.618182,6350.490909,5422.072727,7558.763636,1290.090909,411.9272727,2618.6,14261.69091,392.2909091,1446.745455,632.7090909,17240.38182,637.5636364,132.8727273,5867.490909,13419.67273,1608.254545,804.7090909,2808.036364,10993.41818,574.6545455,278.1454545,2525.327273,8102.581818,970.9454545,442.1090909,1311.309091,6751.963636,899.3818182,175.1818182,5245.145455,4991.018182,1263.018182,245.9818182,3291.127273,267.8909091,228.9636364,55,10.73744727,7.215212562,0.740580893,0.846153846,0.625,-0.042459763
+750,37310.90385,979.875,622.9230769,1135.701923,32803.11538,734.8269231,709.5384615,1694.913462,17821.55769,631.7788462,642.6153846,1813.423077,24318.81731,1352.423077,7478.259615,4556.576923,8726.567308,1387.615385,415.9711538,2518.644231,16698.22115,400.9711538,223.625,619.7019231,20469.92308,802.2596154,134.7307692,5004.942308,16451.375,1598.355769,1054.884615,2816.461538,13598.80769,601.7788462,307.4326923,2433.586538,10191.97115,965.9615385,468.7115385,1311.855769,8184.817308,706.9519231,185.6153846,7423.288462,6280.057692,1353.317308,209.9711538,3452.336538,286.9230769,231.3365385,104,14.82960072,9.978013487,0.739784051,0.818897638,0.541666667,0.017505849
+751,17518.28289,838.7631579,438.8355263,1037.092105,16968.63158,641.4671053,501.3618421,1384.677632,8901.947368,533.0986842,412.4144737,1694.848684,12480.38158,1272.019737,1361.013158,998.6907895,4841.756579,1319.986842,378.5526316,2432.328947,9583.671053,373.4736842,135.3092105,420.2302632,10399.625,391.8092105,121.7368421,819.5657895,8466.125,1375.756579,811.2105263,2830.177632,7215.289474,742.8552632,268.5526316,1527.743421,5948.782895,805.3881579,427.9671053,1317.289474,4833.434211,682.7434211,172.9671053,2822.381579,3785.032895,1440.335526,4728.914474,3087.381579,357.8289474,232.9276316,152,17.49381641,12.04569047,0.725171329,0.821621622,0.603174603,-0.112050433
+752,32141.96721,789.4754098,443.2786885,1065,28186.34426,648.4754098,911.3770492,1670.508197,16365.5082,559.6065574,982.3442623,1868.704918,21516.40984,1228.065574,5235.016393,3094.491803,7942.377049,1241.606557,369.6557377,3655.606557,15011.96721,1261.147541,632.0819672,720.9016393,17423.77049,535.9508197,114.5737705,3483.754098,14717.55738,1567.786885,719.7213115,2798.311475,11996.5082,562.1639344,268.2786885,7318.360656,9631.131148,1078.918033,408.0819672,1334.901639,7280.098361,822.3606557,154.8360656,2678.42623,5983.967213,1231.52459,244.4754098,3169.147541,609.7540984,228.557377,61,12.38189372,6.868533231,0.832034445,0.835616438,0.61,-0.970317278
+753,19239.07647,888.1705882,841.4058824,1168.3,16536.87059,697.6294118,1016.558824,1783.994118,9342.835294,528.1,514.7941176,1876.282353,13570.11765,1301.741176,3509.758824,2320.582353,4878.094118,1275.405882,517.8764706,2911.505882,8831.623529,1185.805882,1450.017647,540.2176471,10559.34118,471.3058824,127.7352941,6003.064706,9116.070588,1720.429412,779.6235294,2810.958824,7366.723529,632.7352941,280.8529412,12996.5,5950.6,1144.311765,428.0411765,1376.764706,4472.105882,1335.829412,164.3352941,5549.541176,3846.182353,1332.223529,195.3,3309.641176,800.2,229.9294118,170,16.7575682,13.26891799,0.610759139,0.923913043,0.714285714,1.50737329
+754,38618.96183,961.8167939,536.8015267,1109.374046,33939.93893,732.6259542,733.7633588,1555.824427,18513.35115,602.4656489,610.3358779,1757.717557,26251.21374,1373.572519,4814.145038,3369.473282,9333.89313,1380.419847,418.9923664,2494.366412,18108.32061,441.0916031,408.0610687,558.9847328,21385.8855,419.2977099,130.4885496,3402.908397,17693.19847,1638.854962,931.6641221,2808.320611,14523.83969,695.0610687,295.9694656,2349.618321,11790.29008,928.8320611,468.5725191,1325.938931,8789.549618,741.6717557,183.1832061,4442.251908,7342.152672,1410.916031,341.351145,3266.290076,404.1984733,231.8473282,131,14.86396666,11.53215453,0.630921877,0.949275362,0.671794872,-0.401515082
+755,41114.31527,913.2906404,543.0788177,1120.054187,36899.02956,756.1921182,725,1628.990148,20190.03448,608.817734,563.2758621,1765.334975,27598.27094,1397.916256,5213.35468,5012.364532,10169.58128,1391.980296,446.4384236,2461.581281,18796.15271,446.3596059,1435.743842,540.8275862,21588.00985,438.8078818,133.182266,3989.349754,17558.04433,1613.157635,1080.413793,2827.408867,14291.81773,628,309.2364532,2519.546798,11568.69458,913.7438424,467.3990148,1339.187192,8579.812808,1003.315271,177.6108374,4199.192118,6711.743842,1371.906404,222.8325123,3258.133005,465.5123153,233.4975369,203,28.82412346,9.702211092,0.941647588,0.835390947,0.426470588,-1.136838405
+756,22521.60766,754.1339713,522.1291866,1086.923445,19363.02392,614.7033493,884.7942584,1624.119617,10784.1866,493.9808612,1174.033493,1812.971292,15549.96172,1159.521531,5245.043062,3548.478469,5697.598086,1173.679426,394.4784689,5079.669856,10067.43062,686,1592.373206,642.9569378,12200.51675,399.6650718,116.4593301,4620.129187,10292.66986,1698.248804,733.7129187,2803.655502,8405.76555,540.4162679,270.7416268,21247.28708,6480.244019,1114.861244,397.3875598,1382.789474,4662.186603,1307.660287,162.7559809,5582.23445,4019.354067,1189.114833,250.5311005,3198.578947,875.3827751,231.8325359,209,22.62070719,12.33187832,0.838332778,0.88559322,0.663492063,1.310713632
+757,27499.99138,870.8965517,753.9310345,1158.517241,24069.11207,642.9310345,595.4482759,1700.887931,11826.84483,545.3017241,459.0517241,1767.75,16690.62931,1144.12931,6441.413793,5295.663793,5913.241379,1199.87931,369.1637931,2445.862069,11831.31897,329.25,287.4482759,434.0775862,13519.28448,369.9568966,124.9913793,8692.181034,10420.38793,1370.232759,658.9051724,2815.198276,8539.560345,535.4482759,267.4224138,5754.224138,5084.387931,717.75,403.2241379,1309.284483,4563.017241,644.637931,158.5775862,2644.991379,3350.181034,1124.801724,213.75,3172.551724,216.387931,232.1551724,116,13.08916288,11.40257176,0.491024097,0.943089431,0.686390533,-0.966892558
+758,38278.68235,904.6,578.6352941,1166.976471,33606.82353,715.5882353,602.2823529,1686.482353,17664.28235,616.8705882,463.5764706,1754.011765,24784.10588,1290.952941,4959.411765,3989.776471,9096.929412,1378.682353,420.6235294,2406.423529,17451.83529,392.9882353,144.0117647,443.0470588,20829.51765,423.4705882,128.8235294,4625.529412,16479.69412,1468.164706,778.2470588,2820.047059,13379.75294,597.0470588,284.3647059,3014.176471,8922.070588,812.4235294,440.4470588,1313.717647,7600.294118,649.8,175.2588235,2597.188235,5637.376471,1298.682353,139.6823529,3318.411765,237.7882353,230.8588235,85,13.92510015,8.593903906,0.786843927,0.867346939,0.544871795,-0.808833491
+759,41584.83117,952.0909091,658.3636364,1159.064935,36627.66234,739.7272727,664.6233766,1712.194805,19527.02597,607.8701299,596.2727273,1794.051948,27216.22078,1328.415584,5615.051948,5290.194805,9702.38961,1411.363636,431.6623377,2577.909091,19119.77922,416.1558442,920.8311688,541.3636364,22509.16883,443.038961,140.9480519,5251.142857,18125.45455,1610.025974,890.974026,2854.649351,14838.24675,606.1558442,300.6103896,3118.168831,10615.46753,901.0519481,462.4545455,1314.662338,8690.948052,839.5064935,180.1948052,3862.181818,6646.090909,1362.415584,222.0519481,3297.896104,258.5454545,230.8181818,77,14.62447586,7.452298194,0.860424991,0.836956522,0.57037037,-1.407317889
+760,32808.8,853.2,485.68,1084.94,28705.92,679.42,660.84,1551.6,16026.12,579.92,460.28,1749.12,22298.66,1261.8,3821.68,2491.34,8628,1345.06,425.22,2416.2,15917.54,372.86,154.8,451.86,19440.36,482.74,126.64,2256.18,15924.78,1596.46,847.68,2819.46,13295.96,608.7,285.36,1639.54,10058.18,975.82,459.72,1297.66,8084.76,665.9,170.72,2928.5,6391.28,1346.44,169.64,3299.66,295.02,229.24,50,9.318235973,7.082547448,0.64983671,0.943396226,0.625,-0.881374579
+761,35593.53333,882.4222222,396.9333333,1056.177778,30984.4,702.7777778,516.9111111,1445.2,17253.42222,589.8888889,387.4,1702.888889,25425.51111,1413.466667,2564.044444,1444.266667,8672.977778,1503.533333,422.7111111,2436.533333,14672.57778,371.7777778,366.1555556,396.1111111,17972.48889,374.8444444,127.3333333,1353.2,14442.22222,1436.866667,825.2444444,2795.466667,12205.82222,594.9777778,298.2444444,1425.022222,10004.88889,846.4666667,464,1291.888889,7909.066667,739.5777778,185.5555556,2679.822222,6626.577778,1387.711111,1539.422222,3036.622222,349.3777778,229.6222222,45,8.913450657,6.843093471,0.640777508,0.957446809,0.714285714,-0.232582036
+762,48635.02857,901.4285714,500,1127.742857,43740.8,753.6571429,714.2571429,1659.295238,24454.97143,639.0666667,501.6761905,1806.133333,34442.2381,1424.72381,4894.590476,4068.180952,12032.58095,1443.07619,445.247619,2539.780952,23069.26667,446.1333333,499.5904762,499.5238095,26783.2381,428.8,137.1619048,3474.714286,22189.00952,1626.914286,1018.647619,2822.07619,18378.12381,635.352381,314.2571429,2802.6,14993.33333,951.7333333,477.4857143,1311.171429,11020.2,795.5428571,184.7714286,2096.533333,9084.990476,1412.47619,375.1809524,3322.019048,495.1428571,230.2,105,17.49387437,8.144394525,0.885017932,0.875,0.648148148,-1.465120267
+763,18198.45833,738.3916667,634.5916667,1141.55,15825.04167,596.9916667,485.15,1771.341667,9134.208333,494.3583333,428.8083333,1883.191667,12542.8,1148.775,4827.283333,2752.433333,4716.458333,1148.125,354.5916667,2517.5,8597.833333,1949.533333,156.0833333,440.0083333,10009.53333,353.9833333,107.7166667,6002.15,8448.425,1293.941667,793.3583333,2799.291667,7045.891667,542.6333333,265.0666667,32375.44167,5706.725,772.6,382.0416667,1365.9,4243.908333,835.8,152.9083333,4396.375,3664.991667,1171.258333,157.7166667,3211.358333,641.9666667,233.7416667,120,15.7812905,10.19143339,0.763513267,0.930232558,0.612244898,-0.678454799
+764,20983.14976,744.8792271,509.1932367,1075.68599,18597.37198,615.5169082,697.6425121,1635.439614,10484.98551,502.3961353,1187.903382,1793.845411,15331.21739,1177.05314,6427.830918,3968.454106,5573.898551,1164.487923,366.7681159,3932.15942,9878.584541,997.0434783,137.5410628,920.0821256,12018.29952,384.0386473,112.2608696,7351.94686,10195.09179,1624.15942,833.7487923,2798.405797,8397.381643,549.6570048,262.1207729,17004.78744,6810.758454,1033.63285,391.9033816,1336.792271,5145.497585,684.9710145,155.1304348,4825.458937,4434.483092,1208.072464,317.2077295,3204.922705,698.2512077,233.7487923,207,20.10291384,13.62430185,0.735312957,0.936651584,0.657142857,-1.355131445
+765,26687.68571,897.5357143,646.4214286,1186.35,23427.04286,712.8,788.35,1959.892857,13607.67857,556.1071429,487.3,1940.878571,19201.15,1338.385714,5563.157143,2981.064286,6786.014286,1281.385714,395.9928571,3254.764286,12466.72143,512.6071429,127.4285714,496.3,14930.55714,440.1714286,123.8071429,5806.364286,12791.34286,1425.328571,756.3285714,2830.221429,10476.33571,610.95,313.1785714,27746.12143,8558.785714,1003.85,427.4785714,1337.371429,6450.292857,679.1214286,171.5357143,5737.614286,5452.514286,1344,219.2214286,3306.307143,729.9142857,233.5928571,140,14.95544544,12.55703553,0.543159312,0.91503268,0.717948718,-0.314583691
+766,26985.68844,824.1758794,598.2763819,1144.19598,23890.30653,649.040201,733.3467337,1718.532663,13741.78894,525.9296482,713.6834171,1813.452261,18898.39698,1265.301508,5274.869347,3242.190955,6820.859296,1223.81407,382.5326633,4578.502513,12427.59799,908.4673367,123.3366834,537.2211055,15013.22111,418.1155779,117.0150754,5862.140704,12653.78392,1587.497487,882.2462312,2797.497487,10384.48241,584.9095477,283.9447236,21844.04523,8567.628141,1017.638191,416.4522613,1406.758794,6298.502513,699.6532663,158,4879.949749,5449.291457,1294.311558,227.6231156,3246.60804,747.2211055,235.321608,199,21.25818744,13.53662795,0.771051785,0.892376682,0.585294118,-1.059389568
+767,38723.16667,973.6282051,562.1282051,1206.74359,34826.78205,778.8076923,949.5512821,1922.410256,19172.35897,599.2435897,971.5,1854.384615,26584.42308,1478.076923,6375.230769,3837.884615,9133.410256,1375.884615,434.3205128,5216.192308,17530,2122.25641,129.8589744,750.7692308,20836.32051,485.4358974,141.1794872,5877.384615,17776.21795,1835.564103,727.9358974,2799.423077,14621.91026,748.1538462,311.0512821,8093.641026,11066.28205,1262.038462,455.4358974,1341.910256,7935.102564,744.6153846,198.4615385,3731.794872,6680.948718,1421.602564,180.6153846,3296.525641,845.0641026,229.974359,78,14.05868656,7.780326269,0.832903852,0.838709677,0.506493506,-1.13943981
+768,42897.82075,1155.858491,598.1132075,1128.198113,36143.54717,775.4150943,711.4150943,1611.632075,20231.90566,676.4150943,592.7735849,1759.018868,28387.67925,1456.896226,4547.330189,3732.377358,10241.19811,1463.481132,431.9716981,2445.122642,19932.04717,431.5,199.5471698,530.0849057,23125.18868,437.0377358,136.2924528,3563.254717,18884.38679,1659.735849,1000.037736,2814.339623,15511.12264,625.7075472,301.0377358,2021.858491,12478.66038,958.9716981,481.4433962,1305.537736,9973.537736,677.9622642,186.0471698,3327.95283,8089.198113,1411.037736,182.6037736,3407.783019,324.7075472,234.5471698,106,19.51593663,7.740338395,0.917984487,0.821705426,0.415686275,-0.887613375
+769,22350.28125,744.84375,506.1953125,1086.804688,18911.8125,613.2734375,432.3359375,1685.585938,11324.53125,511.84375,404.359375,1851.507813,15735.78906,1179.679688,5736.171875,2631.476563,5783.945313,1185.257813,518.6484375,2499.257813,10681.76563,1766.414063,1760.773438,439.453125,12492.875,369.359375,112.1328125,5266.242188,10723.5625,1384.742188,818.4453125,2799.507813,8889.40625,574.2578125,270.015625,18280.39844,7198.3125,825.3984375,386.7421875,1350.3125,5254.15625,1103.445313,154.8125,4066.726563,4591.164063,1202.710938,187.640625,3157.953125,662.3203125,233.5234375,128,16.74455679,9.992218331,0.802431477,0.927536232,0.60952381,0.591534871
+770,24823.18902,850.5243902,601.2195122,1127.512195,22369.08537,667.4512195,727.804878,1685.091463,12599.03049,528.8719512,680.5670732,1818.45122,18002.07317,1278.22561,4986.823171,3230.286585,6567.981707,1253.231707,394.6585366,2839.213415,11564.64024,1158.207317,739.2560976,838.7560976,14181.23171,425.4268293,129.5365854,3664.378049,11889.37195,1515.432927,921.4085366,2812.256098,9583.902439,606.0853659,294.9329268,23867.0122,8011.536585,904.9939024,424.0426829,1389.115854,5979.079268,1393.195122,167.0670732,5818.72561,5135.591463,1334.493902,260.5304878,3245.292683,766.8353659,234.6707317,164,15.0106076,14.11196136,0.340808917,0.953488372,0.683333333,0.872199001
+771,31662.32584,900.5617978,569.8651685,1116.674157,27832.80899,732.6516854,738.3707865,1571.52809,14801.93258,605.0224719,770.7078652,1748.202247,21456.39326,1347.831461,4783.910112,6491.022472,7608.988764,1397.067416,421.4157303,2814.842697,14556.39326,413.5730337,1910.842697,538.7977528,16793.5618,433.8651685,136.8089888,3261.359551,13843.64045,1865.348315,1020.662921,2822.550562,11359.85393,800.7191011,291.0337079,2735.213483,9137.044944,1103.11236,461.2022472,1324.280899,6893.977528,1129.224719,187.0561798,7438.932584,5783.235955,1411.033708,704.9325843,3242.674157,394.1573034,233.6853933,89,12.42353351,9.929633201,0.600985421,0.908163265,0.741666667,0.065993222
+772,14302.48148,664.2010582,416.6613757,1047.063492,12665.74603,558.1269841,539.9100529,1449.074074,6847.333333,466.6719577,482.2592593,1783.560847,9500.888889,1089.142857,3481.05291,1664.878307,3425.259259,1108.656085,343.5132275,2651.021164,6288.296296,6585.835979,638.2962963,453.3492063,7276.201058,389.9259259,108.989418,3454.925926,5981.962963,1411.597884,860.4021164,2791.57672,4889.931217,739.7619048,229.3809524,4312.984127,3783.931217,791.4232804,376.1746032,1307.925926,2810.952381,739.0952381,148.3386243,3095.835979,2334.513228,1084.269841,174.3809524,3125.687831,536.6931217,236.1587302,189,16.65991709,14.60838713,0.480748857,0.954545455,0.694852941,0.947207458
+773,24230.45763,774.5084746,451.2033898,1125.514124,21430.71751,628.6836158,685.5762712,1732.706215,10864.54802,483.2316384,558.4350282,1804.124294,16316.0226,1167.774011,3579.141243,2048.655367,6003.564972,1165.39548,367.1920904,2804.717514,10316.18644,10040.46893,197.8135593,493.1977401,12665.85311,495.9322034,119.7288136,3881.937853,10533.03955,1548.751412,783.4463277,2807.677966,8514.118644,685.1073446,252.7231638,4332.40113,6639.146893,822.6779661,398.7740113,1302.60452,4198.858757,649.7288136,150.220339,2403.559322,3753.514124,1162.813559,158.3954802,3234.717514,953.1129944,236.6836158,177,16.62591758,13.91536578,0.547251391,0.936507937,0.743697479,0.234941435
+774,36217.06,915.1,473.44,1103.72,32370.12,709.46,706.38,1608.18,17912.3,602.6,503,1742.78,24642.46,1318.98,4452.1,2048.46,9335.36,1409.1,410.92,2466.22,17901.44,392.9,388.34,569.6,21373.34,449.3,138.6,2229.12,17370.46,1554.58,776.92,2813.02,14458.52,595.26,299.72,1665.12,11327.26,975.88,469.96,1325.66,8991.74,721.3,176.52,3484.8,7137.78,1378.76,198.44,3368.16,301.56,232.48,50,8.905550328,7.396429771,0.556956638,0.961538462,0.694444444,-1.173314462
+775,30540.51456,984.3786408,607.3203883,1116.990291,25873.04854,780.3592233,1315.68932,1541.398058,14366.90291,622.9126214,1593.398058,1823.116505,20309.09709,1315.757282,5172.252427,3397.446602,7616.805825,1382.786408,399.407767,2690.737864,14339.72816,395.4854369,770.9805825,1388.592233,16699.41748,488.2815534,396.9514563,2720.106796,13698.68932,1952.601942,785.1067961,2838.349515,11311.2233,605.0582524,283.8834951,1622.757282,8765.320388,2011.592233,450.5533981,1322.854369,6912.019417,778.3203883,177.0291262,4959.563107,5522.116505,1315.601942,352.8349515,3616.640777,309.4854369,235.0970874,103,14.06686762,10.20889093,0.687968896,0.851239669,0.613095238,-0.618702267
+776,28274.87079,903.8876404,736.3483146,1187.91573,23788.75281,708.8707865,841.5393258,2060,10859.2809,527.8370787,483.6629213,1946.910112,18565.03933,1280.674157,4737.988764,3151.752809,6664.674157,1294.157303,387.8707865,2476.376404,12372.17978,1303.140449,140.4325843,489.7078652,14875.94382,499.4719101,129.4157303,4023.921348,12316.56742,1441.707865,876.6404494,2818.949438,10004.55618,582.2808989,295.5674157,17984.84831,7230.898876,885.3146067,430.5955056,1345.668539,4166.129213,682.1516854,168.1348315,7597.882022,4077.213483,1271.320225,480.9101124,3312.735955,1043.516854,236.6910112,178,16.04947575,14.29957006,0.454066008,0.962162162,0.698039216,-1.226823325
+777,45570.15094,946.490566,641.0188679,1178.773585,40473.90566,773.5660377,558.9056604,1808.792453,21133.62264,637.9245283,460.1132075,1734.981132,29801.24528,1360.584906,6745.867925,4200.981132,10724.58491,1421.698113,423.1132075,2395.528302,21162.86792,405.8867925,168.1132075,410.9056604,25419.01887,415.6603774,133.7169811,8068.283019,19883.60377,1507.528302,727.4716981,2824.132075,16053.39623,595.6037736,319,2789.283019,10275.33962,831.9056604,465.9811321,1309.584906,9030.584906,656.7924528,169.6037736,2985.867925,6755.169811,1347.207547,177.2641509,3312.056604,227.7358491,232.6037736,53,10.43747455,6.549998898,0.778579218,0.963636364,0.883333333,-1.46230384
+778,32208.00676,870.5878378,435.7364865,1061.189189,28936.34459,704.1959459,511.8986486,1442.013514,16074.74324,576.8851351,497.1013514,1706.885135,23221.74324,1368.472973,2213.506757,2537.006757,8300.094595,1365.398649,412.1891892,2481.060811,16347.97973,413.4527027,164.7432432,488.5675676,18653.84459,658.1013514,126.9256757,1484.871622,15436.84459,1449.912162,859.1216216,2800.195946,12809.56757,683.6891892,291.1486486,1670.405405,10519.74324,952.3243243,467.222973,1294.22973,8166.040541,679.6689189,181.7162162,2913.695946,6767.040541,1571.864865,1850.006757,3104.256757,369.7162162,237.8783784,148,16.04712961,12.81013526,0.602283815,0.865497076,0.616666667,1.138154031
+779,32627.32955,786.5113636,463.4318182,1081.011364,28634.96591,645.7613636,1118.295455,1642.454545,16180.25,551.7840909,1627.659091,1825,22412.52273,1277.806818,6279.659091,3017.261364,8154.909091,1244.534091,366.7613636,3805.954545,15221.97727,1109.5,156.0340909,891.4886364,17965.43182,395.7045455,368.2045455,3974.386364,15089.40909,1758.125,763.625,2817.670455,12499.375,654.9431818,279.4090909,10470.875,9998.670455,1607.102273,438.4886364,1341.920455,7211.556818,671.3295455,178.5681818,4508.920455,6230.818182,1254.159091,278.9090909,3235.977273,570.4886364,234.8295455,88,11.33489723,9.851556355,0.49457485,1,0.8,0.475311633
+780,33784.66316,844.2526316,511.1789474,1128.705263,28650.05263,670.2105263,1079.810526,1704.357895,16125.44211,547,1807.842105,1850.684211,23039.11579,1314.421053,7691.368421,4206.715789,8490.021053,1278.263158,402.7578947,8557.873684,15385.44211,1708.652632,201.3473684,1072.378947,18747.88421,433.3473684,122.1368421,5166.115789,15745.38947,1937.273684,722.3473684,2842.031579,12940,656.4315789,294.6736842,10532.94737,10128.43158,1632.8,426.8210526,1333.978947,7237.810526,795.5368421,223.9684211,5123.126316,6092.336842,1305.768421,217.0842105,3288.831579,846.8736842,237.1789474,95,18.06986642,7.222528216,0.916645948,0.896226415,0.484693878,-0.805209043
+781,29134.52212,909.5132743,603.5044248,1162.646018,25677.77876,703.1415929,1071.539823,1858.920354,12614.73451,537.8230088,1835.663717,1840.088496,19808.90265,1296.504425,6940.309735,4106.327434,7138.672566,1306.327434,393.8141593,6195.814159,12982.0177,790.4070796,137.460177,861.0265487,15905.14159,480.380531,129.6725664,4163.814159,13079.25664,2093.831858,720.3628319,2813.185841,10588.27434,592.9911504,307.6106195,27472.23894,8101.070796,1553.132743,435.0973451,1433.867257,4932.761062,797.3982301,169.9646018,6520.132743,4604.115044,1304.469027,433.5929204,3283.256637,1000.238938,235.2212389,113,14.27914567,10.64315022,0.666658569,0.911290323,0.579487179,-1.144446336
+782,27930.59036,848.8554217,543.9096386,1130.951807,22755.21687,677.1445783,738.4578313,1777.012048,11575,514.6746988,1371.73494,1796.325301,18825.8494,1263.783133,3389.222892,2052.13253,6884.759036,1267.692771,386.9819277,2975.674699,12535.59036,485.2108434,308.0421687,716.5,15238.92169,999.0662651,120.6927711,3733.259036,13120.1747,1465.548193,773.9939759,2866.060241,10689.0241,571.8975904,294.4518072,25054.9759,7966.283133,1261.156627,426.6566265,1365.192771,4699.126506,727.746988,160.5361446,7112.216867,4594.481928,1242.066265,654.9096386,3239.415663,1027.903614,238.5542169,166,19.32284367,11.1667855,0.816103402,0.922222222,0.576388889,0.66034801
+783,31718.89524,883.9619048,635.4190476,1140.819048,28382.75238,686.352381,584.0952381,1720.066667,14841.11429,591.3428571,467.447619,1772.066667,21013.55238,1272.87619,6413.409524,5779.161905,7750.361905,1355.609524,401.9619048,2434.847619,14953.53333,379.2190476,266.1142857,443.952381,17818.13333,421.752381,124.952381,5258.057143,14176.50476,1458.371429,857,2815.057143,11512.79048,578.552381,284.7619048,3749.590476,8081.4,802.7809524,442.8380952,1307.980952,6993.380952,673.4571429,175.6857143,3403.447619,5137.647619,1298.133333,182.0952381,3277.4,242.8761905,237.2666667,105,15.27700872,8.852842664,0.814980798,0.972222222,0.621301775,-0.795650303
+784,47972.61224,966.8367347,605.9795918,1156.734694,42059.57143,766.3877551,1113.061224,1761.265306,22648.38776,651.6734694,724.2040816,1770.163265,31933.81633,1432.959184,5119.571429,3532.959184,11177.91837,1439.44898,458.0408163,2492.734694,22116.38776,432.6326531,1913.489796,638.6530612,27209.12245,534.5918367,144.877551,5164.44898,21831.36735,1769.530612,833.0204082,2832.22449,17982.40816,621.9591837,342.9795918,1913.102041,13164.71429,965.3673469,503.3877551,1342.77551,10426.4898,1109.081633,195.3469388,2990.571429,8165.673469,1425.857143,211.0408163,3431.673469,272.755102,235.3877551,49,8.586346228,7.338131199,0.519240909,0.924528302,0.680555556,-0.323493876
+785,41014.2,1012.411111,566.0222222,1129.588889,35091.84444,785.8333333,690.7222222,1657.944444,20046.08889,655,489.3888889,1725.222222,28410.02222,1462.9,4607.844444,5067.011111,10443.68889,1481.877778,454.3444444,2457.622222,17464.84444,442.8888889,730.1444444,515.4111111,21261.2,442.1,140.0555556,3353.1,17376.16667,1613.588889,986.8333333,2827.555556,14469.92222,677.9666667,321.8222222,2158.044444,11548.17778,948.3555556,490.6666667,1352.311111,8923.755556,839.6444444,189.1555556,4975.244444,7444.011111,1554.2,556.4888889,3251.477778,333.5444444,236.7111111,90,13.72404869,9.534453118,0.719274508,0.857142857,0.545454545,-1.099169604
+786,43872.5,962.26,494.57,1089.71,37521.42,747.06,703.23,1547.91,20035.81,620.81,473,1727.34,28063.78,1386.8,4319.92,3147.91,9716.67,1377.66,412.45,2439.67,18437.67,421.64,781.19,479.3,21633.77,418.5,131.71,2643.41,17665.41,1601,956.73,2816.13,14345.26,608.32,298.45,1872.58,11517.7,892.15,459.14,1308.78,8318.48,794.6,171.09,2653.12,6969.07,1349.37,291.82,3248.46,437.41,236.92,100,14.65563982,9.166254501,0.780270561,0.900900901,0.512820513,0.965997879
+787,39034.70513,861.2564103,476.2564103,1088.064103,34033.39744,802.7435897,1195.589744,1574.25641,18795.19231,599.0128205,1601.782051,1894.346154,26392.02564,1325.038462,6602.782051,3503.064103,9095.641026,1338.25641,412.5897436,3511.384615,17655.88462,419.1025641,1230.74359,1579.794872,20476.55128,436.9230769,162.0384615,2402.602564,16627.25641,2318.205128,743.3717949,2824.269231,13771.78205,581.0512821,273.5512821,4426.384615,10860.20513,1224.679487,446.2564103,1389.794872,8018.423077,940.2948718,169.1410256,3788.474359,6473.615385,1293.897436,824.3974359,3274.025641,509.2307692,235.4871795,78,11.97564678,8.377990322,0.714548777,0.951219512,0.65,1.174033946
+788,22621.49038,792.5576923,711.75,1202.451923,20506.68269,629.9615385,553.0576923,2073.75,11388.05769,521.9038462,475.0096154,2052.769231,15662.11538,1199.519231,2855.634615,1479.25,5846.75,1204.509615,362.8461538,2494.509615,10837.85577,726.2019231,170.1057692,455.8846154,12489.84615,379.3653846,113.6153846,3256.432692,10575.45192,1322.182692,651.8269231,2833.605769,8798.355769,558.3365385,274.9903846,20578.79808,7003.605769,838.8269231,387.3076923,1343.201923,5306.528846,743.0096154,150.6634615,3059.769231,4491.894231,1210.817308,130.1538462,3193.288462,653.3942308,236.9230769,104,14.7383564,9.721480444,0.751613211,0.920353982,0.619047619,0.985970695
+789,16158.83237,740.5491329,446.3410405,1105.421965,14249.63584,601.0924855,595.5028902,1610.699422,7772.895954,474.9421965,774.8034682,1824.404624,11200.07514,1154.190751,3971.069364,2366.99422,4225.606936,1144.468208,361.6878613,3989.716763,7338.780347,6907.635838,262.4624277,702.6647399,8927.745665,472.7283237,117.2080925,4299.208092,7417.445087,1448.676301,747.2774566,2829.768786,6146.121387,1068.687861,244.3468208,9619.884393,4892.433526,956.8786127,384.5202312,1358.653179,3554.705202,738.2485549,152.1387283,3515.456647,3038.034682,1166.132948,149.4393064,3198.248555,833.150289,239.8381503,173,18.09662636,12.51162855,0.72249221,0.920212766,0.678431373,-0.633373296
+790,18002.37037,1337.925926,702.8888889,1065.166667,16501.01852,797.4814815,632.3333333,1449.444444,8281.240741,684.4074074,567.4444444,1768.87037,9537.555556,1319.5,8860.222222,2681.481481,3773.074074,1254.648148,381.2407407,2427.833333,6662,335.2962963,1580.796296,537.7407407,7295.722222,432.2592593,118.4259259,5315.648148,5695.592593,1534.796296,785.5925926,2787.796296,4815.648148,522.0925926,239.5555556,1429.240741,3468.203704,775.537037,375.2592593,1317.666667,2918.925926,804.6481481,157.2962963,2550.611111,1906.018519,1071.611111,150.7777778,3617.833333,279.8333333,236.8888889,54,10.21498215,7.111098357,0.717902191,0.931034483,0.545454545,-0.246815202
+791,35780.50193,919.3320463,504.2277992,1110.791506,31622.42857,745.2586873,621.5559846,1593.23166,17351.83012,602.3590734,569.1583012,1777.965251,24279.89575,1376.185328,4235.459459,3159.204633,8612.393822,1365.440154,413.5366795,2465.899614,14152.30502,397.5173745,503.5212355,537.3783784,17021.40541,402.6023166,153.4440154,2670.911197,13972.53282,1513.590734,870.3629344,2808.501931,11307.79923,794.957529,275.7722008,1920.135135,9379.903475,853.8030888,438.5945946,1314.362934,7019.436293,743.5598456,169.4362934,3140.494208,5690.293436,1307.467181,346.3397683,3284.853282,470.9227799,245.9266409,259,27.24309184,15.09798124,0.832386969,0.775449102,0.532921811,-0.246726971
+792,19786.50394,751.015748,491.7559055,1098.80315,17825.3937,625.2362205,821.1181102,1562.275591,9579,512.7480315,1093.251969,1795.551181,13312.51181,1164.92126,6500.622047,3851.992126,4812.811024,1192.496063,381.511811,3066.566929,9114.307087,5429.370079,365.0708661,557.6771654,10521.48031,416.6220472,118.0551181,5605.23622,8630.740157,1709.858268,1107.708661,2807.385827,7131.133858,639.8188976,260.7007874,5522.165354,5722.637795,899.4724409,415.0708661,1313.787402,4273.031496,679.0866142,161.1102362,3493.165354,3593.692913,1171.732283,197.9055118,3190.307087,554.7165354,239.5669291,127,16.03688798,10.65771558,0.747221525,0.927007299,0.574660633,-0.243395025
+793,26044.06787,759.1221719,492.280543,1107.81448,21356.60633,610.4343891,478.0045249,1650.049774,12430.95928,482.9321267,546.1900452,1813.063348,17791.69231,1173.466063,4818.429864,2835.21267,6513.972851,1168.411765,364.8552036,3594.352941,11539.12217,9270.384615,366.8235294,560.3800905,13978.76923,450.9638009,118.280543,4924.606335,11890.43891,1452.271493,813.4027149,2792.99095,9594.352941,579.5067873,264.9547511,15873.04072,7532.39819,943.5475113,399.6832579,1334.176471,5348.307692,998.199095,159.0271493,3805.665158,4665.909502,1192.868778,162.4027149,3216.524887,857.5384615,241.4570136,221,17.66903325,16.39683209,0.372584529,0.940425532,0.64619883,0.160815519
+794,26270.13077,816.8923077,566.4,1151,22637.66923,645.1,747.8230769,1797.284615,10909.40769,498.1461538,1008.646154,1812.376923,17213.10769,1188.061538,4059.453846,2761.292308,6291.4,1207.869231,370.4923077,2890.853846,11327.19231,3705.815385,301.8846154,630.6538462,13557.69231,813.4538462,119.9769231,5044.384615,11464.02308,1470.492308,972.5076923,2824.676923,9083.584615,573.1461538,280.6769231,20546.60769,6775.961538,1072.723077,400.0615385,1347.007692,4056.146154,732.9846154,160.9230769,5749.2,3780.638462,1187.969231,291.2153846,3224.938462,1016.6,239.6,130,15.63917717,10.79690051,0.72345148,0.942028986,0.677083333,0.170787614
+795,34081.57273,896.6818182,644.9272727,1164.3,30459.21818,701.0454545,653.4818182,1718.754545,15984.70909,597.4,704.3545455,1771.527273,22431.18182,1286.863636,6470.790909,6283.127273,8378.190909,1371.609091,409.7818182,2902.345455,16009.88182,393.2363636,494.6545455,435.7090909,18874.07273,420.9545455,129.2272727,4887.3,14826.44545,1558.172727,1000.418182,2813.236364,12223.39091,601.8,293.0727273,2932.945455,8772.9,878.1,455.7727273,1326.909091,7436.272727,725.6818182,174.3272727,3778.618182,5389.636364,1303.881818,204.0454545,3272.245455,252.4545455,239.6454545,110,18.01941648,9.784122827,0.839747779,0.666666667,0.385964912,-0.951070107
+796,24901.21053,885.4421053,459.1789474,1083.463158,22375.14737,718.7052632,593.5473684,1501.021053,12327.95789,587.3578947,417.7368421,1717.526316,17591.22105,1368.473684,2530.294737,3953.410526,6378.515789,1358.168421,416.8842105,2424.852632,11011.01053,392.7789474,1189.821053,422.4526316,12985.65263,401.7894737,129.5578947,1721.768421,10549.86316,1469.621053,904.1263158,2862.021053,8962.410526,602.7578947,295.7684211,1751.378947,7218.568421,847.7473684,445.0105263,1317.757895,5755.442105,915.5157895,191.6842105,4452.884211,4766.631579,1440.747368,3038.705263,3086.368421,346.7157895,238.9157895,95,11.35878075,10.80027367,0.309712146,0.931372549,0.659722222,0.951754783
+797,40166.01887,1017.537736,532.7358491,1109.726415,34141.87736,781.9339623,619.1981132,1611.896226,18649.91509,640.3773585,471.8867925,1738.132075,27048.23585,1419.254717,4352.330189,2983.518868,9978.037736,1472.415094,432.3301887,2462.509434,14041.4717,389.8113208,535.0188679,429.2735849,17208.73585,403.5849057,132.0188679,2673.575472,13920.33962,1504.349057,872.8867925,2832.09434,11435.9434,693.0188679,285.990566,1821.839623,9445.981132,859.8301887,451.3301887,1339.54717,7262.339623,771.9245283,174.6603774,4784.462264,6195.066038,1384.028302,249.9716981,3218.783019,384.009434,238.8207547,106,13.7076275,10.48091662,0.644499519,0.92173913,0.588888889,-0.183609185
+798,22094.264,779.672,448.792,1042.32,20707.128,657.232,753.592,1446.128,10458.608,533.472,814.192,1765.552,15073.008,1238.152,3271.16,3696.168,5413.768,1242.8,386.248,2925.952,10211.456,366.568,954,1459.408,11958.504,397.312,135.384,2267.056,9578.424,2034.488,828.504,2912.728,7889.816,697.472,257.688,1770.44,6582.856,923.528,424.84,1327.92,5066.536,834,173.88,3159.232,4149.384,1305.328,3874.328,3144.008,428.6,241.16,125,14.61298962,11.42921407,0.623119025,0.961538462,0.555555556,0.604892564
+799,17517,717.6851852,490.2592593,1085.092593,16273.94444,586.9074074,548.7962963,1692.092593,8670.462963,491.4444444,500.1666667,1877.444444,12142.48148,1132.203704,5822.314815,3991.87037,4432.425926,1125.666667,332.2962963,2955.277778,8130.518519,2076.111111,149.8888889,518.4444444,9466.185185,425.537037,112.0185185,7504.814815,7950.388889,1347.833333,907.7962963,2774.444444,6539.092593,561.6481481,250.2037037,15384.81481,5301.888889,823.6666667,378.1481481,1294.148148,4131.259259,733.2222222,152.3148148,4065.462963,3364.666667,1134.888889,167.6296296,3140.722222,611.0185185,235.5555556,54,10.64545492,7.00984582,0.752596034,0.931034483,0.5625,-1.33837997
+800,25171.96171,799.0247748,542.0788288,1131.074324,21870.53604,638.9707207,507.6531532,1644.736486,12588.94369,508.509009,419.8648649,1796.878378,17763.31306,1218.858108,3029.331081,1791.545045,6552.184685,1223.795045,406.7927928,2628.443694,11650.61712,1843.20045,682.0135135,489.7432432,13691.27928,406.8873874,119.0045045,2545.038288,11872.42342,1362.47973,708.3558559,2834.918919,9569.572072,584.1373874,264.3941441,10494.22297,7833.873874,945.6238739,411.8513514,1349.182432,5761.779279,861.6373874,159.6959459,3561.768018,4873.297297,1270.324324,277.463964,3271.308559,787.1013514,244.6779279,444,27.66032487,20.97964373,0.651703027,0.936708861,0.657777778,0.686922917
+801,17133.07345,831.8700565,620.7231638,1166.525424,14401.58757,659.0847458,632.9096045,1829.372881,7460.039548,493.7909605,496.3559322,1832.932203,11436.64407,1212.384181,5917.090395,3630.79661,4233.949153,1210.220339,380.7288136,2509.757062,7276.067797,3582.627119,1522.672316,482.6610169,8889.327684,459.5310734,122.3446328,6391.649718,7485.00565,1500.80791,1004.728814,2788.836158,6153.59887,600.9152542,287.2372881,25240.9209,4683.468927,853.700565,407.0225989,1363.265537,2963.740113,1069.118644,162.8813559,8509.129944,2782.305085,1219.875706,315.5706215,3314.723164,979.5028249,241,177,16.33834832,14.11240381,0.503904258,0.946524064,0.650735294,1.253946365
+802,30487.27309,842.811245,513.4618474,1100.188755,28167.04819,698.1485944,708.4297189,1538.771084,15366.65462,573.7991968,1000.546185,1764.606426,21692.4257,1328.843373,6101.807229,4712.574297,7722.128514,1321.02008,405.4457831,2938.192771,14786.46586,412.3333333,346.9759036,509.9196787,17008.18072,1154.108434,129.8273092,5170.562249,13664.37751,1593.694779,963.8473896,2808.662651,11402.6747,634.4939759,282.5341365,4272.911647,9280.947791,1287.232932,452.5060241,1334.128514,7001.582329,702.5742972,176.7751004,4127.7751,5664.108434,1334.24498,644.1807229,3230.361446,495.9277108,242.5100402,249,20.63217793,17.15541695,0.55554209,0.83557047,0.655263158,0.299972293
+803,24882.56934,755.4233577,425.6715328,1067.226277,21961.63504,627.5328467,777.7518248,1458.781022,11839.05839,536.6642336,964.5182482,1792.080292,16591.29927,1217.233577,5589.919708,1972.905109,5756.021898,1222.978102,394.350365,3022.029197,11112.23358,420.5985401,1042.452555,777.4525547,12894.55474,379.5693431,116.4525547,1577.919708,10484.61314,1714.408759,711.9781022,2828.547445,8696.262774,568.7080292,255.2189781,3662.656934,6800.547445,852.0291971,408.1313869,1356.671533,5013.262774,837.1094891,156.7591241,1851.970803,4144.510949,1194.832117,718.4963504,3129.759124,523.0291971,240.3649635,137,14.00105564,12.72795388,0.416641197,0.944827586,0.702564103,0.942645149
+804,51967.53226,930.516129,544.4677419,1158.33871,44934.25806,740.8548387,917.6290323,1700.241935,24511.09677,640.9193548,1484.548387,1766.532258,33592.6129,1378.080645,3872.919355,3439.887097,12125.48387,1484.951613,450.3387097,3012.758065,23759.48387,424.2903226,1422.080645,653.3387097,28418.77419,615.8225806,142.2419355,2617.354839,22466.98387,1760.241935,765.8064516,2832.016129,18570.91935,632.6612903,338.7258065,2574.145161,13429.17742,1182.483871,488.5645161,1374.483871,10901.87097,999.4677419,184.5,3281.225806,8242.5,1420.451613,281.8709677,3354.403226,265.8225806,239.5,62,10.92707794,7.394320174,0.736261676,0.911764706,0.62,0.872656033
+805,38730.08511,956.4255319,576.0319149,1137.031915,33785.65957,751.1914894,800.9787234,1665.138298,18405.94681,621.2021277,719.8404255,1776.648936,25561.35106,1334.510638,4657.797872,4262.212766,9557.978723,1420.989362,419.5,2636.957447,17917.18085,430.2659574,218.0212766,483.6170213,21610.54255,635.5212766,131.9680851,3517.074468,17285.26596,1665.914894,918,2816.074468,14477.11702,623.7553191,304.0425532,2032.819149,11150.89362,997.0851064,478.606383,1326.702128,8774.468085,685.106383,186.4255319,4360.680851,6825.893617,1391.808511,211.4361702,3273.776596,293.6702128,241.287234,94,14.43783722,8.608464985,0.802803726,0.903846154,0.671428571,-0.082853536
+806,41672.89041,961.739726,531.3150685,1099.506849,35632.93151,759.0410959,689.2465753,1609.315068,18969.17808,630.4109589,587.0684932,1780.260274,26654.36986,1415.945205,3699.054795,4304.780822,9672.452055,1415.616438,432.260274,2510,16689.46575,410.6027397,486.739726,464.9863014,19948.91781,415.9726027,131.9041096,3806.917808,15748.0411,1556.739726,924.2739726,2804.479452,12697.75342,609.0136986,295.1917808,2112.328767,10383.76712,1011.136986,477.8356164,1325.342466,7878.191781,750.739726,184.5890411,4083.383562,6420.69863,1366.684932,376.3287671,3250.616438,447.9315068,240.3150685,73,10.51942359,9.216216677,0.482103578,0.924050633,0.603305785,-0.282603574
+807,27181.2439,765.2743902,454.2926829,1082.585366,24023.80488,634.75,546.6646341,1641.445122,13998.95122,514.0426829,409.7439024,1805.04878,18979.65854,1200.609756,4315.884146,2630.286585,6919.859756,1200.530488,367.1036585,2563.804878,12778.97561,2239.70122,130.7073171,438.6829268,15129.83537,390.7621951,113.3719512,5767.365854,12687.12195,1343.097561,870.847561,2803.030488,10534.82927,572.0304878,261.7682927,9794.817073,8465.164634,768.8536585,392.3719512,1308.164634,6270.27439,718.0914634,155.3292683,3034.804878,5354.981707,1220.481707,130.4207317,3185.378049,617.152439,242.8963415,164,16.03765078,13.36928713,0.552340206,0.953488372,0.643137255,-1.223495136
+808,18316.16828,778.9838188,604.4110032,1121.433657,16228.29126,624.6860841,559.012945,1725.919094,9207.184466,508.0032362,546.6343042,1844.508091,13125.86084,1201.245955,7079.79288,4691.81877,4768.786408,1173.961165,362.8349515,2941.10356,8685.113269,541.6343042,166.5889968,530.6375405,10197.61489,399.420712,113.3883495,8550.84466,8667.63754,1366.757282,1198.148867,2784.119741,7211.737864,543.0970874,274.7702265,26634.34951,5892.731392,819.1650485,388.1003236,1332.090615,4497.407767,840.802589,160.3851133,6148.420712,3794.475728,1229.737864,222.184466,3203.462783,686.2394822,247.3851133,309,26.19988354,15.51814088,0.805718919,0.895652174,0.650526316,0.403632262
+809,27410.12766,783.6666667,609.6524823,1137.687943,23232.68085,622.1276596,492.8723404,1731.687943,13300.93617,500.751773,395.2765957,1838.879433,18872.74468,1214.425532,5058.695035,3360.446809,6864.51773,1207.390071,375.7163121,2470.723404,12419.07092,2533.751773,247.858156,439.6950355,15088.38298,416.2695035,118.0496454,8049.368794,12673.80851,1345.631206,1025.730496,2799.716312,10375.10638,579.8156028,283.2695035,22329.14894,8222.524823,786.3049645,406.5602837,1337.319149,5896.056738,699.6312057,158.8368794,5299.375887,5137.205674,1242.368794,170.751773,3226.829787,819.1134752,241.9787234,141,16.49784096,11.4460574,0.720176178,0.87037037,0.671428571,-0.97965202
+810,29373.35227,868.2272727,539.8863636,1211.204545,25466.71591,687.5113636,653.7954545,1958.761364,14289.27273,529.875,1451.636364,1900.829545,20689.51136,1301.477273,7879.136364,4288.659091,7374.284091,1272.897727,425,6690.681818,13609.65909,616.2727273,991.7954545,833.5568182,16884.15909,442.3068182,128.3409091,4452.818182,13898.95455,1868.409091,786.1590909,2789.306818,11392,597.3522727,300.2613636,13377.93182,8856.920455,1249.659091,433.6477273,1493.318182,5939.113636,1011.602273,209.6477273,5640.795455,5308.829545,1309.238636,339.4659091,3337.943182,912.7727273,238.3181818,88,13.26527347,8.828922656,0.746338483,0.977777778,0.698412698,-1.445893926
+811,17592.55747,711.683908,456.954023,1071.724138,15226.78161,578.8505747,667.4827586,1579.804598,8189.5,464.1436782,486.5344828,1780.488506,12272.73563,1107.293103,5325.057471,3053.097701,4452.977011,1125.189655,377.6781609,3197.655172,7924.603448,1759.022989,990.5977011,472.8908046,9752.95977,409.4195402,115.6091954,6651.798851,8063.850575,1408.367816,790.9712644,2817.304598,6578.545977,538.454023,249.1896552,10553.42529,5129.511494,788.6034483,388.7011494,1370.247126,3343.321839,850.5862069,151.6896552,4143.91954,3080.91954,1128.477011,201.2873563,3221.862069,929.8218391,241.6264368,174,16.67418239,13.60404607,0.578228526,0.945652174,0.6796875,0.830347744
+812,32319.40845,902.3239437,589.1690141,1131.774648,28478.25352,662.971831,554.2887324,1654.908451,14626.22535,565.7323944,436.584507,1801.309859,20954.09155,1216.408451,5128.598592,3837.887324,7658.126761,1297.809859,392.2957746,2425.267606,14581.16901,442.0774648,156.0915493,432.7394366,17650.17606,400.7464789,125.6971831,4990.887324,13497.03521,1418.676056,755.3521127,2814.190141,11099.47183,570.6549296,275.3521127,3423.661972,7174.788732,761.9647887,426.3802817,1299.274648,6275.450704,622.9577465,166.1619718,3177.549296,4582.429577,1237.169014,215.915493,3295.852113,226.8661972,241.6408451,142,15.59763347,12.73777166,0.577136481,0.8875,0.591666667,-1.109116903
+813,22689.42038,944.1401274,1615.089172,1377.095541,19489.59873,708.2420382,1092.802548,2199.203822,10973.65605,553.2738854,530.4649682,2046.324841,15962.61783,1336.407643,3937.617834,2549.299363,5774.898089,1293.566879,430.1210191,2576.006369,10261.49045,1596.515924,758.6050955,474.8216561,12308.21019,493.5095541,128.5286624,5472.140127,10488.26752,1484.076433,869.5987261,2828.203822,8558.063694,640.0955414,292.0764331,16783.95541,6810.101911,942.6878981,437.7961783,1391.579618,5028.961783,910.9808917,166.0828025,6295.840764,4155.433121,1326.140127,209.3312102,3489.006369,804.1401274,242.4203822,157,15.65052221,13.68511974,0.485170865,0.862637363,0.61328125,-1.095333137
+814,17736.35185,1046.796296,614.462963,1071.759259,16109.27778,703.1666667,1068,1498.962963,8524.296296,612.5555556,1306.388889,1774.685185,11958.25926,1260,5615.555556,3369.444444,4792.333333,1305.851852,370.462963,2870.277778,8616.444444,403.4074074,231.7407407,829,10401.11111,479.0555556,143.462963,3843.685185,8149.851852,1841.092593,840.1296296,2788.62963,6971.518519,574.1851852,264.2037037,1924.685185,5521.333333,1057.462963,417.3888889,1314.240741,4573.037037,631.3148148,164.9444444,4902.018519,3500.648148,1214.018519,372.2777778,3395.574074,301.3703704,241.7407407,54,10.38751064,7.030076957,0.736183775,0.931034483,0.6,0.465674321
+815,43097.37879,918.4242424,500.4242424,1093.151515,38386.24242,758.8181818,1449.318182,1620.424242,21218.54545,622.9545455,2330.484848,1820.909091,29643.5,1343.19697,4893.80303,4049,10987.86364,1431.560606,422.5151515,3027.227273,21231.90909,416.2424242,194.4090909,1846.378788,24584.89394,462.9393939,168.4242424,2517.878788,20254.13636,2354.681818,785.530303,2892.560606,16916.19697,631.0909091,312.5,1690.621212,13429.60606,1421.666667,495.8787879,1312.848485,10582.07576,682.1212121,186.6212121,4748.984848,8590.575758,1404.878788,326.5606061,3378.166667,313.0454545,242.6363636,66,11.94088838,7.659005405,0.767198274,0.88,0.5,-0.974127487
+816,24064.83626,778.8947368,511.6608187,1081.923977,21356.47368,626.871345,783.9707602,1619.520468,11659.07018,532.0233918,981.0175439,1800.017544,15836.85965,1200.48538,6227.321637,3597.064327,5843.795322,1212.263158,366.4385965,3412.760234,10900.92982,4625.97076,814.7602339,562.2280702,12557.12865,448.4678363,120.1520468,6446.274854,10346.36842,1611.795322,979.005848,2801.497076,8495.292398,636.3976608,260.3450292,9407.45614,6768.081871,956.7836257,421.6081871,1344.309942,5026.087719,769.4561404,162.4853801,4644.064327,4175.22807,1208.380117,243.8947368,3231.444444,563.3040936,245.9415205,171,18.49697061,12.38374071,0.742811135,0.919354839,0.633333333,-0.398077158
+817,38604.41935,824.7096774,484.6129032,1079.564516,33813.82258,771.9193548,932.9516129,1542.580645,19377.41935,582.9193548,987.4677419,1832.209677,26958.45161,1312.145161,4758.112903,2805.629032,9871.306452,1351.596774,409.5806452,2496.241935,17655.04839,397.0483871,778.2258065,875.0806452,21653.6129,424.8064516,232.8548387,3507.774194,17703.58065,1656.548387,945.016129,2834.854839,14312.09677,593.9354839,291.2419355,2781.548387,11845.58065,903.0483871,463.7258065,1321.870968,8638.403226,811.0967742,184.9677419,6626.145161,7331.919355,1347.435484,330.5806452,3285.193548,480.0483871,242.3548387,62,10.57056079,7.536037466,0.701238326,0.96875,0.626262626,-0.959534487
+818,20323.928,771.528,554.144,1118.592,15115.808,600.048,467.376,1618.352,8408.392,497.376,429.328,1793.512,11643.032,1146.536,4783.576,3525.048,4205.856,1146.296,406.392,2608.392,8005.584,472.24,524.048,475.632,9206.664,387.776,110.384,5971.152,7880.44,1349.744,1180.904,2785.056,6647.704,546.24,259.752,21609.24,5320.448,763.04,375.576,1324.704,4066.76,939.048,155.856,5199.744,3437.528,1193.16,155.12,3195.112,672.784,245.184,125,14.41481595,11.40722969,0.611357532,0.932835821,0.686813187,0.268072847
+819,20824.83333,784.7254902,627.9117647,1109.872549,17465.02941,605.872549,487.0882353,1675.813725,9789.931373,483.254902,445.7156863,1827.539216,13992.60784,1158.156863,4423.764706,3307.215686,5118.352941,1167.176471,422.2058824,2843.205882,9029.921569,903.4803922,1935.294118,471.8627451,11156.44118,432.3333333,117.2254902,6226.5,9337.392157,1417.392157,981.1176471,2784.558824,7577.333333,546.0980392,262.4019608,16316.71569,5890.705882,928.245098,389.6372549,1371.509804,4006.5,1234.088235,157.4411765,5611.04902,3542.931373,1182.392157,179.3921569,3271.980392,900.1960784,242.4411765,102,13.57647641,9.942429995,0.680952357,0.918918919,0.68,1.346452368
+820,29202.08182,792.2909091,518.5454545,1114.863636,24399.53636,624.6636364,718.8272727,1776.627273,12546.18182,491.9909091,548.9,1818.045455,19828.4,1187.345455,5180.127273,3295.154545,7307.372727,1195.363636,365.3363636,2979.6,12889.62727,1413.4,183.3090909,493.9909091,16245.10909,434.9,123.5090909,8564.763636,13491.14545,1474.318182,851.0272727,2810.5,10807.74545,551.2909091,280.0636364,21100.71818,8278.318182,865.4636364,405.2636364,1326.972727,5085.309091,742.8545455,152.5,4379.527273,4845.845455,1191.536364,251.9454545,3275.645455,1003.781818,244.6454545,110,16.14178354,9.362251322,0.81461573,0.852713178,0.523809524,-0.698990401
+821,32289.6,881.7678571,648.9071429,1155.207143,28100.41786,683.1392857,535.1357143,1709.171429,13884.59643,567.9392857,554.8,1801.75,19775.31071,1227.328571,6614.753571,4860.342857,7176.678571,1313.603571,390.9678571,2513.167857,13799.58929,410.3821429,209.0785714,627.0571429,16302.67143,405.3107143,129.3428571,6918.292857,12203.175,1595.05,693.6071429,2801.660714,10179.58929,584.6357143,292.7785714,5334.596429,6199.171429,812.8357143,434.0857143,1300.271429,5477.039286,652.8535714,173.0035714,2890.492857,4120.214286,1242.496429,258.1892857,3256.314286,211.5464286,246.9892857,280,22.88740193,16.58791963,0.688999286,0.872274143,0.640732265,1.431676596
+822,46103.11538,993.9423077,607.4038462,1170.730769,38784.59615,765.2884615,657.0576923,1755,20779.15385,649.7307692,478.1153846,1796.5,28835,1424.115385,4679.75,4449.019231,10453.71154,1475.346154,443.4615385,2429.076923,19480.13462,418.7884615,1236.557692,459.6346154,23194.11538,510.9230769,135.0192308,4023.403846,18644.88462,1595.269231,1027.519231,2851.480769,15233.65385,600.4423077,321.4423077,2029.25,11420.26923,908.1538462,489.1923077,1312.961538,9084.788462,921.5,187.8269231,4576.769231,6573.153846,1376,176.5,3374.942308,284.0769231,243,52,9.803841012,6.868379885,0.713573371,0.945454545,0.641975309,-1.06987553
+823,38852.18653,1052.357513,538.1502591,1101.668394,34634.70984,778.3419689,774.7098446,1574.901554,18840.36788,672.3782383,979.3523316,1776.466321,26696.85492,1433.694301,4692.720207,3353.507772,9504.207254,1412.471503,422.2953368,2461.559585,17707.18135,427.2694301,380.1088083,479.6476684,21457.78756,432.2746114,216.6839378,2859.979275,17528.32642,1863.274611,871.3005181,2812.725389,14536.04145,711.9430052,298.0051813,1929.103627,11640.39896,1014.222798,469.4870466,1320.170984,8635,774.0362694,180.9740933,3317.295337,7237.751295,1371.082902,268.9119171,3453.797927,407.7979275,246.4559585,193,19.7495149,13.23865292,0.742064933,0.877272727,0.634868421,-0.900516932
+824,37969.8,839.85,588.45,1113.966667,34058.3,763.7666667,943.0833333,1647.3,18272.18333,602.8666667,1184.633333,1745.783333,25011.4,1245.966667,5959.216667,4808.05,9004.916667,1914.716667,399.5,3725.466667,17675.11667,382.2833333,505.7666667,446.2,21124.16667,422.9,132.6833333,4843.616667,16777.98333,1836.033333,908.3,2822.4,13995.01667,578.2666667,293.5333333,2614.333333,9993.183333,953.5166667,454.9,1310.166667,8306.85,716.5833333,180.65,3701.4,6141,1280.983333,308.4,3263.25,258.3166667,244.5166667,60,11.64822706,6.950533604,0.802462067,0.923076923,0.545454545,-0.674618113
+825,24201.84564,999.1879195,727.7785235,1170.302013,21195.51678,764.4161074,771.3557047,1688.657718,10977.34899,607.5167785,686.3221477,1764.275168,15107.26174,1417.630872,5484.389262,4309.281879,5658.543624,1458.657718,538.9731544,2587.100671,10451.03356,426.8657718,4296.510067,568.9194631,11863.7047,554.7785235,142.9731544,4882.463087,9453.416107,1755.006711,1065.355705,2816.61745,7902,627.9261745,326.5234899,7131.154362,5633.469799,962.0469799,460.6979866,1394.14094,4659.724832,1486.241611,189.114094,5366.758389,3365.308725,1348.42953,430.5100671,3381.234899,272.3691275,247.6174497,149,16.18937198,13.2508105,0.574523288,0.827777778,0.490131579,-1.105690875
+826,37554.04667,904.3533333,488.8866667,1112.693333,33666.53333,739.28,732.1933333,1586.94,18213.08,602.14,641.76,1738.14,26187.85333,1385.3,3147.713333,2937.253333,9845.493333,1478.866667,418.3266667,2486.773333,17629.70667,502.1533333,1306.68,481.2333333,21015.76,443.44,140.6333333,2232.006667,17140.86,1726.44,1016.926667,2851.506667,14298.00667,1060.173333,322.08,1988.773333,11581.50667,972.8866667,473.6933333,1366.1,8844.58,974.68,184.12,4669.413333,7568.42,1448.293333,847.66,3213.92,392.8933333,246.8533333,150,14.59697457,13.55096962,0.371729784,0.931677019,0.666666667,-0.328754927
+827,33925.62791,849.7848837,517.9127907,1105.732558,29372.74419,724.622093,743.8488372,1545.447674,16188.11047,577.2732558,979.1918605,1814.098837,23220.11628,1309.627907,4925.296512,3852.087209,8430.563953,1341.313953,410.5872093,3136.395349,15406.91279,413.9825581,1363.377907,910.4244186,17819.5407,411.1860465,133.5406977,3790.488372,14290.36047,1914.267442,924.9593023,2807.72093,11769.9593,589.4709302,290.3081395,4032.796512,9378.238372,1299.145349,442.3604651,1408.401163,7041.22093,949.8197674,173.3081395,4439.883721,5705.796512,1282.936047,561.6686047,3262.55814,509.1744186,248.005814,172,15.92073691,15.19779847,0.297918223,0.87755102,0.562091503,0.086544391
+828,25061.73099,789.3099415,521.0935673,1095.637427,22093.78363,670.251462,938.6783626,1635.602339,12557.67251,539.0877193,1929.701754,1851.099415,17703.15789,1247.497076,7224.105263,3887.25731,6475.660819,1220.602339,358.8538012,5862.532164,11928.97076,632.1578947,112.497076,1268.017544,14029.01754,411.9590643,115.0643275,4240.842105,11867.69591,2147.923977,790.1111111,2806.385965,9897.701754,624.625731,272.380117,13324.43275,7942.450292,1229.637427,407.502924,1345.97076,5917.385965,740.2631579,156.748538,4686.561404,5115.315789,1258.157895,318.8479532,3215.859649,601.994152,248.0292398,171,15.79241431,14.21104657,0.436167784,0.924324324,0.628676471,1.119452833
+829,19280.18182,737.2517483,500.4755245,1079.223776,17062.73427,608.9020979,585.8111888,1632.629371,9732.111888,495.8111888,417.1328671,1780.888112,13385.62238,1141.944056,4681.664336,2423.839161,5015.671329,1159.958042,355.2657343,2890.13986,9113.965035,4041.34965,112.3776224,449.5104895,10668.06294,387.2797203,117.5594406,5184.237762,8878.762238,1316.552448,781.5034965,2782.055944,7471.496503,583.6433566,266.048951,23368.23077,5984.615385,757.3846154,382.8601399,1332.006993,4529.615385,855.6503497,152.965035,4237.657343,3920.20979,1195.559441,166.2167832,3164.223776,642.2517483,246.0839161,143,16.18781079,11.77837741,0.685993359,0.910828025,0.6875,0.986755975
+830,16384.76724,766.4224138,581.5086207,1113.862069,14341.35345,614.4396552,512.2931034,1700.051724,8351.172414,503.0172414,433.0172414,1849.025862,12030.82759,1160.525862,6280.482759,4323.224138,4381.482759,1158.87069,356.0603448,2638.844828,7743.775862,674.0086207,137.1982759,461.0603448,9379.232759,390.3706897,115.9568966,7400.672414,8120.913793,1331.767241,1039.241379,2790.965517,6717.310345,545.8275862,262.5344828,23720.83621,5530.698276,756,390.0775862,1353.241379,4115.948276,780.7758621,152.9310345,6254.543103,3607.508621,1220.586207,190.9051724,3227.87931,708.5431034,246.0775862,116,16.71393265,8.988563676,0.843079677,0.913385827,0.594871795,1.019822401
+831,23115.87755,761.7619048,503.9863946,1097.272109,19813.02721,613.5442177,452.2721088,1623.170068,11069.63946,497.1156463,409.8843537,1787.639456,15904.55102,1172.013605,4483.027211,3698.761905,5767.598639,1172.190476,389.3605442,2597.918367,10253.05442,3222.741497,957.8163265,467.1632653,12395.44898,422.3129252,123.0952381,5606.102041,10495.04762,1391.782313,1006.938776,2791.687075,8486.986395,562.4965986,260.4421769,9931.986395,6492.251701,827.3333333,394.4013605,1356.653061,4631.129252,1065.904762,156.5102041,4457.428571,4019.210884,1193.659864,163.2517007,3246.666667,890.1768707,247.8843537,147,16.44380242,11.65559227,0.705395742,0.91875,0.583333333,0.296107619
+832,21269.54922,752.6321244,498.253886,1094.564767,18779.27461,615.6321244,520.6632124,1693.678756,10018.96891,481.2849741,482.3264249,1781.53886,14881.82383,1169.005181,3529.036269,2782.186528,5431.569948,1180.720207,380.6994819,2956.150259,9737.507772,5238.61658,887.2331606,477.8497409,11768.94819,474.4611399,117.3989637,3942.471503,9791.253886,1391.170984,857.4404145,2831.284974,7986.746114,557.2746114,267.9222798,17303.98446,6174.901554,838.0829016,393.134715,1353.476684,4180.740933,828.0984456,155.015544,4657.455959,3714.88601,1179.341969,167.5233161,3212.647668,916.3160622,248.4093264,193,18.03082312,15.73020465,0.488781295,0.784552846,0.507894737,1.457731412
+833,23752.45946,819.172973,766.8054054,1148.535135,20709.03784,644.1189189,733.8378378,1849.778378,10191.12432,489.7135135,618.4,1869.643243,15872.94054,1193.2,5121.708108,2395.702703,5811.416216,1241.837838,382.7405405,2663.567568,10383.02703,641.7459459,700.0972973,479.3567568,13029.75676,434.3081081,124.3837838,5036.605405,10545.15676,1495.621622,740.8486486,2833.432432,8589.875676,560.5189189,262.2054054,14702.05946,6505.783784,920.1135135,414.4648649,1357.043243,4158.52973,864.7459459,166.7675676,4359.605405,3831.491892,1210.67027,249.4432432,3247.427027,991.9081081,250.227027,185,20.2291337,12.06225764,0.802775439,0.885167464,0.616666667,-0.299312771
+834,49947.42029,958.8985507,562.0724638,1150.202899,45104.15942,783.4057971,961.2463768,1734.724638,25596.26087,650.3913043,1202.086957,1827.086957,36159.95652,1470.144928,3968.623188,4821.753623,13378.72464,1548.869565,454.2173913,2545.695652,26226.56522,455.0724638,207.2753623,1327.768116,29948.76812,486.1449275,151.7101449,3206.724638,24806.4058,2234.594203,943.1014493,2859.913043,20705.95652,677.884058,340.6376812,2129.014493,16583.52174,1311.043478,524.1449275,1310.797101,12893.53623,740.5942029,203.8405797,4342.826087,10604.71014,1519.144928,199.4492754,3381.985507,322.2608696,245.2318841,69,11.79182391,7.970285924,0.7369784,0.884615385,0.575,-1.374924005
+835,22876.1,930.1666667,784.7333333,1128.833333,22537.1,740.9333333,919.0666667,1687.466667,11860.26667,585.9666667,861.1333333,1827.433333,15830.36667,1351.2,6844.933333,7761.2,7097.6,1359.266667,407.2,2494.4,13364.96667,445.0666667,689.6,695.6666667,13679.6,512.1333333,155.7,5775.033333,10918.33333,1924.6,1223.266667,2820.033333,9405.8,875.5666667,299.3333333,2785.033333,7479.066667,1182.533333,469.8,1310.566667,6192.2,832.2,185.2666667,8704.033333,4509.266667,1402.6,242.6,3323.066667,330.3333333,244.5,30,8.945679718,4.850811266,0.840216011,0.833333333,0.535714286,-0.54583395
+836,49894.68675,981.7349398,501.4819277,1137.626506,43266.66265,787.1807229,820.5542169,1699.807229,24980.59036,654.2289157,530.2409639,1739.156627,35858.81928,1455.554217,3471.759036,3399.759036,12923.98795,1541.746988,461.4939759,2455.951807,25243.39759,463.1566265,446.7951807,531.5662651,29871.3012,516.3975904,155.060241,3117.036145,24304.93976,1744.759036,909.2289157,2843.73494,20139.81928,694.9518072,335.5783133,1807.060241,15996.50602,1020.084337,514.6987952,1342.168675,12215.73494,799.5421687,201.4216867,5119.46988,10285.87952,1546.46988,403.1807229,3192.698795,335.8915663,247.3373494,83,14.60474031,7.830649193,0.84410891,0.912087912,0.538961039,-0.454471803
+837,34637.96262,872.9065421,441.4579439,1077.345794,32246.19626,714.5700935,528.8317757,1501.523364,17141.96262,598.411215,420.1214953,1722.392523,24432.42056,1367.915888,2819.878505,2830.242991,8752.485981,1393.261682,418.3457944,2439.429907,17006.92523,416.4485981,732.953271,419.8317757,18988.29907,382.2429907,131.8691589,1882.850467,15450.8785,1491.71028,880.0934579,2818.766355,12802.04673,605.8037383,296.1775701,1598.327103,10427.50467,846.4953271,465.7570093,1301.542056,8196.775701,782.2803738,178.6448598,2625.364486,6538.056075,1434.018692,364.7102804,3114.850467,376.7850467,247.9158879,107,12.91192458,10.86449282,0.540364669,0.955357143,0.633136095,-1.000567458
+838,46644.56977,1127.918605,620.627907,1158.255814,40902.67442,857.3139535,820.3604651,1736.325581,21894.03488,705.0232558,612.6627907,1787.72093,31249.18605,1544.534884,5295.569767,4311.046512,9830.790698,1446.290698,432.255814,2441.255814,15671.46512,403.9069767,489.3139535,468.2790698,18566.72093,417.5930233,131.1046512,3708.872093,15411.77907,1501.313953,893,2812.72093,12460,614.6627907,290.9069767,1953.906977,9953.72093,864.744186,461.9418605,1325.093023,7365.569767,723.8488372,172.8604651,3061.872093,6190.023256,1316.127907,342.1976744,3368.209302,419.2325581,247.5348837,86,13.0167181,8.902900807,0.729520499,0.934782609,0.558441558,-0.393682998
+839,31942.28235,857.4352941,541.3882353,1099.470588,27455.2,712.1411765,644.4941176,1546.952941,14953.54118,581.8823529,529.3058824,1784.188235,20851.01176,1307.729412,5557.588235,5459.811765,7969.282353,1344.647059,416.3294118,2453.164706,13849.57647,403.4823529,1367.470588,469.3647059,16624.70588,446.9529412,131.2117647,3948.564706,13252.25882,1525.376471,1082.541176,2808.741176,10883.95294,626.8117647,294.1882353,2713.105882,8800.541176,895.2705882,448,1346.047059,6705.6,958.3529412,177.8705882,5502.529412,5358.082353,1334.282353,274.6235294,3213.388235,454.8705882,245.9176471,85,13.43179857,8.715690319,0.76088664,0.858585859,0.594405594,-1.144519971
+840,24876.78049,789.2520325,542.1788618,1100.642276,22301.99187,645.9593496,583.2845528,1633.154472,12322.2439,525.4308943,512.2601626,1838.682927,17242.44715,1269.96748,6396.203252,3669.479675,6107.813008,1219.349593,353.5284553,2698.219512,11567.21951,6026.333333,239.9837398,470.1138211,13432.65041,436.5447154,121.7642276,7881.308943,11369.85366,1484.276423,1154.731707,2820.95935,9418.268293,758.4390244,266.8455285,6561.560976,7395,892.6910569,416.8455285,1317.707317,5509.739837,670.5365854,167.5284553,4475.178862,4634.544715,1234.227642,151.2195122,3272.674797,575.9430894,248.3333333,123,13.87219728,11.33994411,0.575987652,0.946153846,0.727810651,-0.872708354
+841,17317.96471,671.5882353,492.4,1076,15009.44706,555.8235294,451.5529412,1505.494118,8284.858824,462.3058824,437.5882353,1726,11981.07059,1077.494118,3324.917647,2083.082353,4488.223529,1119.035294,338.7882353,3131.364706,8123.235294,2350.376471,790.5058824,463.5764706,9571.294118,352.8352941,111.3176471,3455.682353,7990.870588,1352.435294,772.2470588,2771.576471,6764.152941,540.8352941,243.9411765,13227.14118,5438.247059,816.1176471,370.7764706,1342.341176,4141.788235,912.6,147.0705882,3063.741176,3484.517647,1184.070588,186.9058824,3185.917647,654.1882353,246.1294118,85,12.70582125,9.59338886,0.655680038,0.885416667,0.594405594,-1.436086364
+842,19549.125,779.828125,582.6145833,1118.083333,17333.54167,626.3385417,551.1822917,1661.052083,9790.364583,498.6302083,464.4895833,1802.375,13875.81771,1179.364583,5566.104167,3779.854167,4986.442708,1183.489583,366.4947917,3112.557292,8993.723958,537.234375,152.734375,489.9166667,10596.58854,409.6510417,114.6145833,7296.729167,9145.666667,1350.802083,1005.71875,2785.9375,7604.760417,549.4322917,268.0729167,17781.60417,6172.0625,830.0104167,392.5,1346.390625,4704.015625,733.1510417,160.125,6907.338542,3987.307292,1231.838542,191.5989583,3219.479167,724.9166667,247.9947917,192,18.14682409,14.01777076,0.635058392,0.941176471,0.711111111,-1.343369554
+843,19496.13861,723.039604,468.8019802,1082.089109,17172.41584,587.5445545,476.8564356,1561.09901,9729.90099,478.4653465,374.6138614,1804.648515,13312.34653,1120.257426,3227.326733,2142.653465,4936.70297,1141.39604,380.450495,2582.475248,8833.693069,6874.579208,709.029703,428.7277228,10564.35149,438.6534653,109.8019802,3885.747525,8973.376238,1314.351485,987.2673267,2777.519802,7370.693069,764.2772277,244,6833.891089,6068.544554,781.5594059,389.8960396,1331.514851,4568.014851,789.019802,152.8465347,3257.366337,3860.767327,1180.049505,174.5841584,3187.217822,745.3118812,248.8762376,202,16.79565611,15.61877486,0.367738033,0.966507177,0.742647059,1.458144996
+844,35639.89474,851.0350877,502.877193,1116.175439,31540.50877,700.754386,504.8421053,1577.035088,17647,581.5964912,570.2631579,1765.561404,25144.78947,1297.684211,5112.210526,3819.526316,9052.719298,1366.894737,405.2982456,2521.596491,16615.03509,416.4912281,812.0877193,482.5438596,19773,481.0175439,133.2105263,3455.912281,16224.68421,1542.438596,933.7719298,2813.736842,13185.50877,613.754386,296.4210526,3792.947368,10874.73684,933.5789474,457.3859649,1321.175439,8091.929825,828.6315789,177.122807,4700.070175,6817.947368,1347.403509,408.4385965,3248.666667,486.6315789,248.0526316,57,10.23886973,7.276639345,0.70350758,0.982758621,0.575757576,0.513674598
+845,23526.62162,846.972973,637.3423423,1153.630631,20287.24324,735.3153153,918.4504505,1789.198198,11746.78378,533.5765766,1501.126126,1939.027027,16461.21622,1283.252252,5814.09009,3439.666667,5916.693694,1237.981982,378.8918919,4277.828829,10798.27027,4649.630631,171.3333333,1206.252252,12916.92793,446.9459459,120.7657658,3144,11012.10811,1993.441441,998.7207207,2807.045045,8947.576577,599.7117117,288.3423423,24030.44144,7389.369369,1380.18018,430.1261261,1395.576577,5494.027027,1082.315315,161.9189189,5953.738739,4740.144144,1304.882883,252.1441441,3298.09009,767.4144144,248.3333333,111,14.50811227,9.822655811,0.735940926,0.925,0.720779221,1.351867529
+846,22701.26549,846.0265487,520.2389381,1044.238938,20632.30973,681.2654867,665.1504425,1491.053097,11335.21239,551.2300885,508.9026549,1760.946903,15901.33628,1258.292035,4278.761062,3386.176991,6366.876106,1304.318584,397.9646018,2457.026549,11781.15929,393.2300885,1188.663717,593.4070796,13289.83186,422.9469027,125.9380531,2668.831858,10620.9115,1618.123894,891.6283186,2798.840708,8900.893805,859.5309735,272.0176991,1904,7247.415929,911.5840708,437.7876106,1326.168142,5797.893805,923.4513274,174.539823,7045.053097,4665.858407,1352.99115,1458.026549,3167.477876,343.9646018,250.300885,113,15.15960936,10.90956335,0.694340392,0.768707483,0.504464286,-0.664140417
+847,27674.59551,967.4831461,554.494382,1118.078652,23483.37079,733.6067416,682.247191,1820.651685,13234.8764,616.5617978,498.5393258,1888.494382,18691.91011,1351.224719,3533.033708,2036.404494,6703.438202,1383.303371,407.7977528,2438.561798,12244.50562,434.988764,349,443.3707865,14569.04494,446.7303371,127.1123596,786.8876404,11869.14607,1526.932584,752.0449438,2838.764045,9653.808989,766.9213483,289.5393258,1469.988764,7797.168539,1178.123596,456.6179775,1324.179775,6012.898876,3750.94382,169.3370787,1443.539326,4958.325843,2159,816.7191011,3297.741573,358.8764045,249.5955056,89,13.72924571,8.798272124,0.767673115,0.86407767,0.577922078,0.517174943
+848,38101.76866,971.6567164,512.5895522,1105.656716,33159.6194,748.9626866,724.2014925,1584.619403,17328.33582,622.141791,604.8880597,1762.567164,24132.65672,1371.537313,4592.11194,3340.246269,8701.350746,1357.955224,411.141791,2593.343284,16168.46269,406.8880597,491.7164179,701.1641791,18698.74627,413.761194,137.5970149,2530.753731,15054.02985,1731.283582,955.3283582,2810.895522,12302.26119,588.3432836,291.9776119,1960.067164,9937.41791,932.8208955,457.1716418,1319.873134,7549.350746,744.3731343,175.9850746,2790.246269,6074.69403,1317.365672,279.2761194,3369.477612,441.2238806,249.261194,134,17.5754686,10.23968637,0.812750123,0.893333333,0.62037037,1.339596499
+849,29401.78916,819.3855422,520.4337349,1112.385542,26178.27108,666.5662651,591.6987952,1696.337349,14742.77108,543.2650602,788.560241,1855.849398,20667.3494,1286.698795,6239.939759,3563.403614,7317.524096,1246.078313,360.4518072,3698.006024,13770.88554,3663.506024,139.8493976,641.9578313,16330.40361,430.8855422,118.9578313,6238.921687,13528.39157,1600.981928,1011.981928,2817.783133,11152.44578,678.7289157,269.8795181,7191.457831,8872.590361,1046.716867,428.8855422,1317.506024,6578.578313,658.9156627,158.8253012,3880.337349,5653.096386,1269.746988,170.1987952,3302.710843,586.8313253,253.1506024,166,19.93944116,11.01852073,0.833447084,0.887700535,0.638461538,-0.151976161
+850,21972.11429,806.0228571,549.2971429,1122.177143,19345.05143,639.2514286,598.2,1703.645714,11154.46286,525.4971429,468.5771429,1792.245714,15861.28,1210.074286,5407.177143,3715.165714,5609.365714,1192.64,370.4114286,3170.96,10244.70857,879.7828571,131.6228571,526.7885714,12156.94857,417.0914286,118.4685714,7668.182857,10405.49714,1391.885714,911.0228571,2791.885714,8535.08,557.2057143,266.4628571,18671.46857,6913.4,827.3828571,394.9314286,1351.811429,5289.6,781.4342857,158.0342857,4259.302857,4504.788571,1249.514286,171.2971429,3236.274286,704.0914286,253.3371429,175,24.08296036,10.32507626,0.903432892,0.837320574,0.484764543,0.917034194
+851,21942.25185,770.5851852,542.2740741,1113.859259,18778.81481,616.762963,710.9333333,1713.511111,9789.881481,487.1851852,1729.437037,1821.851852,14680.31111,1167.392593,7571.348148,3079.859259,5438.214815,1161.962963,395.4074074,5002.777778,9786.422222,905.3703704,1170.407407,575.0740741,11751.97037,498.162963,119.4740741,3628.548148,9862.340741,1673.859259,769.2592593,2797.214815,8053.62963,568.5777778,272.0074074,20029.81481,6240.651852,1217.681481,399.9259259,1336.074074,4073.348148,897.9481481,158.6518519,7647.044444,3712.866667,1173.718519,362.7185185,3153.851852,949.3111111,248.8888889,135,18.06328815,9.937637225,0.835061503,0.9,0.661764706,1.272258539
+852,25869.70866,1058.102362,507.8031496,1116.692913,21113.88189,739.5905512,661.6062992,1712.937008,10736.14961,560,396.8897638,1740.755906,17711.76378,1357.937008,1360.385827,612.3149606,6019.047244,1335.165354,393.5354331,2386.03937,11731.8189,733.7559055,162.023622,497.9133858,14562.7874,465.4094488,130.4645669,882.5826772,12266.33858,1454.047244,604.3543307,2807.354331,10025.13386,581.8976378,271.023622,3151.614173,7507.377953,784.8188976,437.2047244,1315.047244,4400.976378,656.2992126,167.8582677,5032.543307,4364.661417,1332.015748,1875.251969,3323.527559,1036.937008,251.6062992,127,14.88306339,11.04100027,0.670565887,0.969465649,0.661458333,0.112055706
+853,41474.33051,926.8305085,591.220339,1142.559322,36820.60169,734.8813559,564.3728814,1750.771186,19448.35593,606.8728814,463.6440678,1747.898305,26757.33051,1328.483051,5744.152542,4449.305085,9878.338983,1399.330508,430.4745763,2431.025424,18993.34746,425.8220339,1004.033898,447.3983051,22509.44915,425.9830508,130.6440678,4863.754237,17635.79661,1605.635593,892.6949153,2805.59322,14484.17797,585.6949153,318.8983051,2934.847458,10211.16102,843.4237288,461.7881356,1309.271186,8548.508475,793.7881356,180.5677966,3947.567797,6251.567797,1338.372881,191.8898305,3300.533898,244.6694915,249.0084746,118,18.22662644,8.753138691,0.877137621,0.874074074,0.631016043,1.382657822
+854,22364.42045,889.2215909,495.8977273,1139.772727,19424.67045,694.9318182,612.7386364,1714.630682,9262.142045,510.3068182,457.4602273,1744.738636,15246.1875,1328.176136,2059.914773,1076.869318,5841.755682,1326.767045,404.7329545,2544.767045,10341.69886,480.5852273,152.7613636,546.4204545,12744.25,495.3125,125.8125,1409.130682,10615.07955,1464.409091,681.1875,2825.772727,8576.920455,576.4431818,286.7443182,8771.409091,6440.164773,843.8295455,434.4375,1340.801136,3942.090909,654.3920455,170.3181818,5577.022727,3777.471591,1323.801136,3193.596591,3205.926136,1025.795455,253.9147727,176,20.72906588,11.62959414,0.827796571,0.871287129,0.544891641,0.436503269
+855,45500.79167,1129.791667,623.2638889,1145.041667,39388.625,804.9722222,731.4166667,1710.986111,21152.88889,689.0972222,552.2222222,1746.472222,27550.63889,1430.138889,4898.527778,4300.152778,10208,1461.777778,437.6111111,2626.194444,19151.04167,426.4166667,1067.694444,492.9444444,22176.45833,468.8888889,138.5833333,4296.375,17841.19444,1837.694444,935.7083333,2839.708333,14805.45833,605.3611111,322.0277778,1977.097222,11091.81944,921.7777778,474.3055556,1338.263889,8866.444444,833.4861111,184.9861111,3874.027778,6797.097222,1347.638889,167.7638889,3446.833333,286.0694444,250.5555556,72,10.76367462,9.129627525,0.529694134,0.947368421,0.545454545,-0.912815599
+856,26551.60448,925.1940299,559.5895522,1073.261194,24549.63433,686.2686567,756.5373134,1515.335821,13150.25373,590.6865672,844.7164179,1793.059701,18403.11194,1251.276119,5668.843284,4665.574627,6964.216418,1321.492537,390.7014925,2528.171642,14638.68657,432.0223881,595.9850746,746.119403,15427.36567,430.2462687,131.8432836,4151.843284,12579.44776,1635.589552,869.0298507,2795.80597,10579.17164,589.9104478,274.0970149,2337.485075,8380.977612,987.6268657,441.9776119,1301.567164,6789.425373,686.4850746,178.858209,6535.261194,5308.88806,1272.432836,190.4552239,3346.208955,312.6641791,251.8656716,134,18.11958517,10.08498487,0.830794532,0.864516129,0.572649573,1.449499572
+857,16406.0754,748.7460317,492.5833333,1088.944444,14240.78571,598.7579365,491.2301587,1592.27381,7858.738095,474.3253968,385.5396825,1763.595238,11541.96825,1147.18254,2833.912698,1994.47619,4251.178571,1160.345238,355.5396825,2434.511905,7558.440476,1138.198413,389.6785714,461.6547619,9036.06746,396.6785714,119.9722222,3198.948413,7825.02381,1284.02381,770.0277778,2834.666667,6343.892857,614.5833333,267.8650794,16565.85714,5022.920635,813.3452381,387.2460317,1345.801587,3656.472222,1163.214286,160.484127,3593.734127,3174.436508,1191.626984,181.2261905,3182,880.5396825,255.8571429,252,22.93776808,14.620569,0.770531803,0.913043478,0.6,0.690080378
+858,34786.54598,919.2068966,599.3045977,1138.454023,30973.48851,723.2241379,738.2011494,1709.183908,15906.11494,586.1321839,600.6436782,1783.37931,22452.31609,1314.609195,5996.58046,4910.132184,8144.862069,1375.626437,432.3793103,3108.95977,16018.44253,398.5689655,1892.183908,536.7988506,19016.5,424.4827586,129.7586207,5038.827586,14430.02874,1916.614943,753.8965517,2814.902299,11760.39655,577.4482759,297.6091954,3114.655172,7868.770115,906.1494253,445.3103448,1318.913793,6726.281609,1034.637931,179.6264368,3748.16092,4701.62069,1295.16092,269.6321839,3284.735632,230.5747126,255.2816092,174,18.20404341,12.46565534,0.728755508,0.920634921,0.69047619,-0.163377851
+859,42896.74627,911.6865672,642.2238806,1136.850746,37330.74627,720.3283582,747.9104478,1704.492537,20751.61194,611.4776119,610.119403,1775.179104,28414.53731,1318.731343,7369.462687,4787.149254,10409.41791,1437.820896,420.5074627,2633.776119,19951.07463,408.6865672,255.8208955,428.0895522,24169.79104,430.1791045,128.3432836,8360.19403,19240.85075,1631.746269,1113.641791,2811.731343,16260.1194,620.7462687,312.0298507,3052.537313,11840.32836,915.8208955,465.7313433,1315.343284,9642.895522,688.1044776,182.1940299,4048.208955,7573.567164,1365.731343,186.3880597,3325.507463,262.8507463,252.238806,67,12.04543618,7.167281984,0.803710491,0.943661972,0.609090909,0.716805319
+860,32275.49474,866.6736842,544.4526316,1095.768421,28415.84211,713.4526316,720.7263158,1590.063158,15389.02105,578.3052632,1088.8,1785.778947,21542.12632,1318.115789,7325.410526,3774.010526,7949.284211,1333.273684,412.0315789,2636.810526,14272.33684,427.3894737,1231.221053,736.6421053,16756.94737,393.6315789,164.1263158,3767.715789,13072.10526,1959.947368,1047.526316,2814.715789,10653.94737,600.9894737,278.6947368,6678.284211,8427.315789,1123.989474,443.4,1347.852632,6361.905263,937.8736842,166.2315789,3108.726316,5088.673684,1289.884211,744.2526316,3235.042105,520.9789474,252.3789474,95,14.23411007,8.852661291,0.783070542,0.922330097,0.527777778,-1.00046091
+861,24906.52717,841.375,966.5380435,1201.038043,21474.98913,678.8532609,894.9076087,1859.668478,12651.39674,548.5217391,523.75,1901.538043,17475.74457,1268.641304,5343.929348,3322.505435,6371.211957,1268.038043,382.9402174,2790.076087,11812.13587,2992.222826,115.7336957,490.7391304,13921.8913,445.5108696,118.4347826,7619.190217,11646.84783,1498.206522,869.5978261,2808.788043,9774.923913,678.7336957,280.4076087,15094.13043,7752.402174,871.1358696,413.5,1325.516304,5806.005435,792.5380435,156.125,4559.972826,5062.701087,1286.793478,151.3641304,3282.059783,631.2391304,254.4891304,184,18.02366655,13.91168458,0.635796752,0.888888889,0.676470588,-0.370343572
+862,13996.80723,679.1686747,448.7630522,1040.032129,12392.05622,556.3092369,428.6345382,1537.349398,6712.208835,447.2690763,478.1004016,1798.907631,9553.7751,1095.991968,5544.88755,3381.277108,3598.738956,1098.915663,384.5823293,3742.26506,6440.164659,3029.008032,1259.983936,623.5702811,7678.614458,388.8835341,112,5259.277108,6419.15261,1314.128514,841.6425703,2780.947791,5267.682731,572.7710843,233.626506,9441.53012,4179.546185,843.9036145,372.8915663,1345.285141,3030.309237,1020.658635,152.4497992,3638.578313,2602.88755,1107.582329,194.6385542,3158.638554,835.0240964,255.2329317,249,22.42983955,14.52849275,0.761869483,0.936090226,0.707386364,-1.376390702
+863,20406.06579,765.0526316,535.3947368,1101.098684,17658.77632,610.6381579,440.7302632,1675.118421,9522.888158,483.7171053,441.9605263,1801.190789,14029.44737,1166.467105,6642.039474,4003.756579,5104.453947,1154.25,361.7105263,2470.125,9187.631579,1037.078947,402.6052632,462.375,11161.34868,407.6184211,120.3355263,8283.302632,9281.664474,1352.111842,1140.638158,2818.671053,7577.256579,551.7171053,272.5263158,21134.59211,5903.434211,794.1118421,392.2565789,1338.177632,4129.980263,897.0789474,157.5,5337.434211,3612.019737,1185.611842,183.9210526,3245.513158,901.0131579,254.5986842,152,17.59962159,11.59809403,0.752145756,0.88372093,0.633333333,-0.811677543
+864,24893.66964,772.6339286,488.1160714,1094.848214,21451.57143,623.2410714,663.8125,1699.428571,10591.1875,500.4196429,621.7678571,1784.026786,17040.88393,1150.241071,4465.446429,3568.098214,6276.517857,1178.035714,362.3214286,2787.366071,10962,1306.696429,1181.125,721.8660714,13643.59821,414.6428571,120.2589286,5843.080357,11164.75,1573.232143,917.7589286,2787.303571,8906.544643,543.3571429,265.9285714,19746.86607,6821.142857,897.5267857,391.2321429,1386.241071,4215.928571,975.7232143,158.7232143,5275.8125,3958.892857,1165.232143,343.7857143,3237.723214,1007.116071,253.5089286,112,15.60283517,9.42142608,0.797114768,0.965517241,0.574358974,-0.560643827
+865,37294.28333,1039.416667,575.3833333,1124.975,32131.98333,812.8,1049.966667,1599.958333,16556.19167,642.1,1081.2,1858.875,23762.075,1424.633333,6043.983333,4034.875,8205.25,1394.241667,438.8,2832.033333,13922.01667,466.6416667,1418.283333,1481.708333,16007.98333,448.8166667,451.9083333,2506.283333,13316.51667,2147.141667,914.775,2806.883333,10724.925,610.1333333,283.925,1917.233333,8608.733333,905.6166667,448.9916667,1391.65,6330.616667,963.5416667,176.7333333,4162.6,4925.508333,1317.35,291.6166667,3431.008333,425.275,254.9083333,120,14.52771912,10.63959269,0.680912285,0.975609756,0.659340659,-0.733481523
+866,22375.55405,942.4054054,656.3108108,1126.486486,20521.39189,756.2162162,667.7972973,1593.945946,11209.64865,598.9054054,604.2972973,1781.824324,15702.41892,1372.5,8009.391892,5346.72973,5296.189189,1326.243243,407.6891892,2529.513514,9963.851351,388.4054054,868.9054054,533.0675676,11391.60811,410.0135135,127.3783784,5316.797297,9449.702703,1566.148649,884.6351351,2795.121622,7681.432432,588.7567568,270.2027027,2605.810811,6381.567568,898.6216216,428.6486486,1332.851351,4773.567568,857.0945946,174.4324324,6568.054054,3957.662162,1296.783784,424.4189189,3237.986486,480.6891892,252.7297297,74,11.70033903,8.204059685,0.712982955,0.973684211,0.74,0.658611542
+867,26664.13265,861.5510204,784.0408163,1214.734694,22919.91837,679.7142857,860.2244898,1801.897959,12708.39796,522.8163265,417,1841.387755,17784.79592,1276.979592,3406.540816,1920.102041,6513.857143,1275.479592,435.1530612,2482.5,12225.62245,543.0816327,992.4693878,456.6530612,14466.9898,469.9081633,123.6530612,2956.510204,12513.11224,1423.357143,663.3367347,2824.744898,10229.30612,614.0918367,284.4897959,10766.78571,8168.408163,828.0714286,430.4693878,1379.44898,6032.081633,894.1020408,163.0918367,4568.938776,5227.591837,1301.408163,177.1122449,3262.55102,805.5408163,253.0612245,98,16.15432754,7.954721983,0.870357429,0.91588785,0.583333333,-1.088921222
+868,25184.72131,871.8442623,845.8278689,1164.54918,21542.40164,711.1393443,852.5,1797.02459,12111.20492,526.1557377,641.2786885,1840.098361,17478.54918,1275.196721,3623.557377,2622.770492,6306.614754,1296.139344,392.647541,3592.959016,11573.18033,552.2459016,443.6885246,659.4754098,13746.43443,494.7622951,129.5,3238.057377,11832.18033,1480.42623,720.1229508,2844.581967,9589.844262,592.6311475,290.2295082,13243.9918,7511.319672,1296.97541,431.6311475,1374.311475,5366.131148,1109.262295,167.8688525,5241.336066,4712.237705,1301.393443,165.1721311,3332.54918,865.3934426,255.647541,122,17.09887777,9.551416727,0.829437828,0.93129771,0.598039216,-0.387958195
+869,53276.47368,995.7631579,532.75,1150.644737,47387.40789,809.6447368,911.7368421,1743.763158,27062.31579,672.4078947,1486.605263,1785.052632,37873.63158,1486.092105,4524.118421,3011.447368,13971.76316,1544.657895,469.5131579,2511.026316,27620.44737,465.4342105,182.1184211,1312.355263,31471.84211,495.1842105,1002.763158,1750.947368,25893.46053,2196.263158,826.9868421,2891.486842,21878.21053,671.1973684,352.4736842,1596.578947,17256.14474,1183.552632,513.8421053,1311.355263,13473.59211,720.6842105,196.5394737,3411.460526,11007.72368,1531.328947,310.7631579,3324.631579,328.2894737,254.0131579,76,12.26039499,8.034285944,0.75536525,0.95,0.633333333,1.045706326
+870,16578.29231,849.6769231,460.6615385,1048.553846,15608.64615,652.7846154,523.1076923,1515.646154,8222.692308,552.4,433.7538462,1746.138462,11666.55385,1275.753846,2494,1520.307692,4413.338462,1298.030769,384.0615385,2440.015385,8139.907692,381.8307692,186.2769231,456.4615385,9956.030769,410.8,121.0461538,1126.861538,7654.369231,1403.692308,792.4,2811.6,6449.446154,768.1076923,266.2,1473.415385,5452.784615,941.1076923,418.9230769,1305.307692,4444.538462,1226.046154,171.4153846,2654.2,3576.4,1668.369231,7759.369231,3104.830769,352.6923077,254.2461538,65,10.42301256,8.190966571,0.618412016,0.955882353,0.590909091,0.838180141
+871,22179.19192,810.8232323,551.4646465,1081.429293,20116.78788,668.4343434,621.6414141,1534.974747,10369.76263,538.6616162,774.3989899,1782.5,14535.68182,1220.787879,7533.414141,3373.010101,5108.383838,1245.606061,379.7626263,3174.989899,9194.287879,1145.055556,1891.358586,714.7121212,10778.73737,404.9040404,168.3989899,6458.737374,8551.974747,1647.974747,860.1313131,2802.015152,6912.560606,583.5606061,258.2626263,5947.075758,5435.853535,1046.19697,417.4494949,1385.141414,4071.505051,1068.338384,161.459596,6394.525253,3312.60101,1185.166667,525.0808081,3231.560606,538.3838384,258.5858586,198,21.23486741,12.4063806,0.811576816,0.925233645,0.628571429,0.290772447
+872,28299.45304,864.6685083,615.9226519,1136.911602,24742.77901,694.6519337,723.1491713,1754.497238,14211.56354,555.7679558,1115.320442,1820.718232,19650.66851,1272.149171,5355.535912,3230.922652,7192.044199,1289.121547,382.2486188,5302.546961,13324.81768,1968.58011,137.2872928,884.519337,15831.09392,452.7016575,119.2044199,4372.027624,13020.30939,1709.480663,833.5690608,2820.430939,10855.48619,637.5524862,275.7403315,9702.314917,8727.983425,1228.657459,416.8508287,1351.502762,6612.20442,724.5690608,162.8563536,4627.403315,5548.61326,1294.298343,190.1049724,3252.513812,616.8508287,255.8342541,181,18.36969298,12.97561307,0.707852952,0.914141414,0.635087719,1.339655873
+873,26946.52903,801.816129,543.9870968,1126.522581,22857.51613,637.3290323,655.883871,1680.648387,13275.60645,525.5032258,978.3322581,1846.025806,18267.38065,1224.406452,4839.570968,2932.819355,6725.925806,1234.535484,370.2290323,4892.387097,12622.02903,6035.441935,327.083871,820.8870968,14703.78065,439.1741935,114.7612903,3476.587097,12275.98065,1582.541935,737.4451613,2801.096774,10344.30968,610.1096774,268.4935484,10699.46129,8235.13871,1085.974194,405.0548387,1334.774194,6214.664516,790.4225806,155.3032258,3429.719355,5330.658065,1262.241935,217.3193548,3250.290323,655.816129,260.1741935,310,31.01542114,13.29605063,0.903450889,0.901162791,0.478395062,-0.768630267
+874,13461.825,703.60625,452.3375,1065.2625,11336.34375,563.51875,378.425,1507.90625,6476.08125,449.26875,376.1875,1809.525,9533.25,1112.425,3233.775,1628.11875,3644.675,1116.64375,394.4375,2500.96875,6413.88125,458.43125,1144.15,497.975,7684.6875,361.75625,114.6,3791.4375,6522.1,1286.18125,695.425,2850.075,5380.53125,545.48125,246.3375,15916.34375,4429.675,731.56875,375.3125,1355.31875,3230.80625,929.19375,147.9875,3791.8375,2826.2625,1140.54375,201.425,3146.53125,818.35625,256.86875,160,19.25235477,11.1103819,0.816679071,0.914285714,0.740740741,-0.050454684
+875,19500.86923,755.9846154,515.5769231,1095.707692,16385.74615,618.8,1324.738462,1687.407692,8611.869231,485.4692308,2010.361538,1857.523077,13168.4,1177.884615,6641.630769,3499.323077,4860.176923,1170.684615,361.7846154,7067.876923,8481.738462,1162.246154,955.0923077,2140.207692,10121.63846,404.6615385,116.5230769,4954.392308,8486.838462,1935.992308,900.8307692,2791.638462,6970.776923,545.8384615,263.6538462,18447.69231,5307.6,1293.146154,398.9153846,1424.184615,3395.415385,892.0076923,158.2384615,8417.253846,3136.576923,1157.369231,341.0615385,3159.807692,966.1692308,254.6230769,130,17.34276143,9.678145258,0.829806657,0.928571429,0.677083333,-1.100536548
+876,25882.44248,846.1150442,499.9026549,1120.955752,21846.69027,678.5575221,732.300885,1713.486726,11046.79646,505.3716814,1480.150442,1787.778761,17953.84956,1252.530973,4181.061947,2526.628319,6553.424779,1256.628319,384.2300885,4478.097345,11787.68142,461.7168142,305.9292035,1548.353982,14628.44248,430.6283186,126.9292035,2677.451327,12232.50442,1751.752212,696.0265487,2835.221239,9811.752212,581.1150442,291.4867257,18577.20354,7447.566372,1116.39823,426.079646,1425.59292,4596.761062,798.3451327,164.7256637,6053.40708,4383.637168,1269.893805,996.9026549,3243.353982,1016,257.0530973,113,13.74744733,11.30696858,0.568797386,0.904,0.627777778,-0.174907249
+877,33482.64865,906.4774775,504.7387387,1086.495495,29145.15315,766.5045045,777.5045045,1540.558559,15940.36937,598.5495495,534.3963964,1760.432432,22656.90991,1402.09009,5251.954955,2529.378378,8399.990991,1380.261261,423.7837838,2494.585586,13974.36937,421.5135135,1734.243243,532.9369369,17176.30631,457.4594595,137.8468468,2358.045045,13699.06306,1761.324324,927.6756757,2825.477477,11370.40541,846.7027027,291.6306306,1924.738739,9261.981982,922.4864865,468.972973,1367.846847,7166.666667,1068.738739,181.2612613,4075.657658,5859.27027,1409.900901,348.7117117,3231.135135,457.7657658,255.3513514,111,13.350948,11.84045901,0.462032888,0.834586466,0.528571429,0.889590963
+878,22302.47287,837.4186047,802.4651163,1152.496124,19157.30233,657.620155,840.8372093,1748.03876,11172.03101,540.8914729,434.8992248,1829.713178,15605.07752,1261.821705,4552.48062,2378.697674,5679.852713,1278.062016,381.3953488,2455.736434,10311.37984,601.9689922,136.2945736,460.4418605,12158.09302,451.1162791,117.5968992,5662.069767,10526.39535,1361.093023,842.8604651,2809.790698,8806.689922,615.7596899,278.8372093,12198.32558,7147.069767,912.627907,422.6899225,1336.364341,5417.914729,719.5116279,166.9689922,8996.317829,4673.271318,1309.906977,148.3953488,3344.984496,733.0697674,256.7054264,129,14.69042568,11.5266938,0.619951823,0.969924812,0.708791209,-1.005997512
+879,23428.96629,865.3707865,762.6966292,1139.483146,20829.94382,682.8764045,800.2921348,1818.41573,11254.96629,521.494382,2295.044944,1898.224719,16289.13483,1277.539326,6152.921348,5305.033708,5932.303371,1267.808989,393.0337079,7234.932584,10907.93258,667.1011236,153.5617978,1508.292135,13141.59551,547.1011236,125.2696629,3852.876404,11038.53933,1801.348315,774.8764045,2797.561798,8919.224719,619.741573,269.3932584,6197.168539,7064.94382,2304.157303,430.3595506,1363.932584,5183.752809,902.6741573,164.9775281,5141.078652,4453.269663,1270.483146,281.1235955,3278.292135,855.8988764,254.988764,89,12.14370613,9.768364523,0.594091719,0.946808511,0.741666667,0.527302897
+880,18093.57265,770.1623932,543.2905983,1109.700855,16196.11966,607.1538462,1086.470085,1664.282051,8474.811966,481.3076923,1336.17094,1769.846154,12721.69231,1162.495726,5164.871795,3595.393162,4682.700855,1175.692308,358.2051282,4267.273504,8344.247863,681.2051282,877.2905983,916.2136752,10020.34188,2066.871795,114.1965812,3522.974359,8272.452991,1447.555556,772.8376068,2804.205128,6631.376068,540.025641,292.2564103,33943.34188,5204.811966,1450.162393,396.3418803,1419.461538,3529.188034,827.6153846,158.6324786,8996.017094,3164.957265,1177.059829,358.7606838,3168.923077,926.2136752,256.5213675,117,13.17712896,11.38081234,0.504041884,0.966942149,0.75974026,0.040237209
+881,53168.72973,930.7567568,567.7027027,1160.810811,45216.7027,760.4864865,664.6756757,1690.702703,24947.21622,635.972973,447.3783784,1796.297297,34616.94595,1392.108108,4578.540541,2434,12365.05405,1462.432432,446.2432432,2396.567568,26874.48649,604.2702703,436.2702703,475.5405405,29175.18919,410.5135135,140.6486486,3959.621622,23143.35135,1538.891892,999.0810811,2826.378378,19154.27027,646.0540541,321.6216216,3246.378378,13582.35135,902.5135135,472.7567568,1331.918919,10817.67568,670.1351351,180.4864865,2720.297297,8566.540541,1386.648649,160.7027027,3283.783784,253.1081081,255.2432432,37,9.071199858,5.345994662,0.80788723,0.973684211,0.685185185,-0.279876332
+882,31657.07229,975.9156627,636.4819277,1097.385542,27728.38554,717.6144578,653.0120482,1601.108434,14856.83133,602.8674699,498.7349398,1754.638554,20375.22892,1305.481928,7100.072289,3625.819277,7618.674699,1394.313253,446.9277108,2420.506024,14085.08434,395.7349398,1351.39759,452.8433735,16846.07229,466.4216867,129.2409639,4942.13253,13370,1522.433735,887.1807229,2807.915663,11255.95181,626.3614458,298.0843373,5385.566265,8339.228916,906.2771084,431.5783133,1337.53012,6790.638554,870.0963855,169.4216867,3625.349398,5181.253012,1286.433735,306.9759036,3419.253012,279.3373494,256.6144578,83,11.50832307,9.428759762,0.573366234,0.976470588,0.576388889,0.760797227
+883,24452.80822,951.0410959,1100,1272.643836,22306.41096,734.7671233,1077.767123,2071.342466,12114.23288,578.739726,791.8082192,1929.630137,16514.34247,1324.849315,4355.835616,3585.986301,6023.246575,1321,405.6164384,3233.027397,11008.87671,969.4383562,234.3424658,658.0684932,12878.08219,476.0410959,128.739726,4228.493151,10879.0274,1600.684932,1059.150685,2828.410959,8909.753425,606.3287671,296.1780822,20222.54795,7133.424658,1244.794521,441.5342466,1344.09589,5509.794521,880.8767123,164.4520548,5065.479452,4588.972603,1327.561644,193.1232877,3254.657534,759.9863014,255.5753425,73,10.27594989,9.257877074,0.433971402,0.935897436,0.663636364,1.185890763
+884,26279.1954,766.4252874,528.9233716,1090.965517,22494.14176,624.4482759,805.0153257,1820.785441,11887.34866,487.3448276,1585.59387,1866.371648,18068.99617,1187.911877,7438.789272,4321.022989,6530.969349,1198.249042,396.9731801,4883.065134,11930.84674,1469.881226,1436.340996,678.8659004,14320.28736,990.4367816,120.7164751,6964.061303,11910.17625,1675.992337,981.3180077,2798.030651,9536.337165,559.8467433,269.6091954,15545.7931,7492.873563,1355.007663,396.8659004,1377.203065,4939.348659,935.7586207,156.2796935,6583.574713,4465.731801,1184.54023,310.5210728,3172.923372,943.835249,260.9885057,261,19.90418905,17.09338449,0.512339049,0.942238267,0.654135338,-1.332246285
+885,35433.74026,842.6623377,600.8571429,1110.12987,30825.07792,670.8311688,559.7142857,1654.779221,16705.19481,565.8701299,477.5194805,1824.935065,23218.1039,1242.805195,5485.909091,4452.857143,8733.61039,1357.974026,397.6493506,2423.831169,16096.75325,389.012987,182.3766234,421.8571429,19482.57143,408.5844156,129.4415584,6563.974026,15461.44156,1439.090909,1296.285714,2809.324675,13022.62338,601.6493506,291.5064935,3887.935065,9370.12987,856.5454545,439.6493506,1316.649351,7616.116883,667.6363636,168.4155844,4572.077922,5994.636364,1309.766234,171.6103896,3253.168831,261,259.8701299,77,14.72248581,7.258983217,0.869998605,0.895348837,0.55,0.622499448
+886,35179.76515,984.4545455,568.469697,1107.401515,30368.68182,728.7878788,801.1666667,1616.227273,16816.70455,621.2045455,733.1742424,1785.401515,22665.90152,1329.409091,5087.924242,4888.477273,8435.977273,1384.098485,400.5606061,2623.318182,16307.59848,414.1969697,195.0606061,526.280303,18868.93182,578.8181818,129.8560606,3847.787879,15284.88636,1684.484848,823.3939394,2825.393939,12863,700.5227273,295.1742424,2065.083333,9922.409091,1008.409091,458.4166667,1315.083333,7879.704545,654.5757576,178.1590909,4832.44697,6288.840909,1325.651515,193.9166667,3382.681818,297.6818182,257.5227273,132,15.5517931,10.93361492,0.711145075,0.923076923,0.676923077,-1.069907172
+887,28410.30769,858.75,590.375,1114.057692,25775.30769,705.5961538,698.4615385,1596.182692,14381.90385,575.4519231,612.1538462,1755.701923,20235.02885,1315.759615,5931.990385,4082.115385,7050.269231,1314.326923,397.9711538,2490.759615,13822.60577,416.0576923,1597.673077,546.7307692,15803.70192,499.375,133.9519231,4409.913462,12788.83654,1583.807692,880.8846154,2805.865385,10562.86538,716.2307692,291.1826923,4348.144231,8662.394231,949.8846154,442.9711538,1351.192308,6517.144231,1086.5,179.3653846,5554.826923,5429.942308,1349.307692,969.0288462,3269.394231,491.6634615,258.2211538,104,12.51041367,10.7690203,0.508935777,0.962962963,0.727272727,0.417919236
+888,34289.54111,950.6339523,539.4562334,1097.96817,30169.33952,724.5676393,676.1671088,1566.440318,16551.37931,591.1246684,663.535809,1773.909814,23222.96021,1330.448276,5585.05305,3679.002653,8101.904509,1349.976127,401.8275862,2630.320955,15189.7878,588.0981432,657.3899204,690.1591512,17655.73475,422.8541114,137.4721485,4692.941645,14340.88329,1632.665782,903.8435013,2818.480106,11795.81698,607.8302387,280.3129973,3175.572944,9285.342175,1009.538462,445.7824934,1325.567639,6946.209549,751.4005305,170.7480106,3228.745358,5759.901857,1261.774536,360.801061,3271.437666,525.3183024,266.2254642,377,23.92958699,22.07213594,0.386287393,0.849099099,0.558518519,0.513974851
+889,12022.83784,794.3378378,672.5675676,1141.797297,10270.62162,613.4324324,512.1351351,1778,6005.202703,508.7972973,460.7567568,1860.581081,8536.986486,1232.851351,10486.63514,4716.243243,3086.972973,1156.5,354.4864865,2558.202703,5864.824324,2611.5,274,467.0135135,6821.472973,426.9459459,115.6486486,11736.14865,5831.959459,1344.22973,1401.22973,2801.459459,4940.243243,561.4864865,278.6081081,28675.52703,4088.824324,779.9864865,391.7702703,1366.121622,3128.216216,1102.27027,159.9594595,7826.405405,2715.432432,1235.378378,187.0810811,3303.378378,677.027027,256.3783784,74,12.21412025,7.882542589,0.763875946,0.948717949,0.616666667,1.037552083
+890,15056.61314,789.7664234,449.5620438,1073.788321,12758.36496,635.9343066,565.4525547,1693.379562,5634.744526,471.9051095,402.8613139,1746.919708,9492.321168,1191.051095,1617.262774,1228.430657,3443.087591,1162.919708,350.8905109,2371.985401,6455.459854,415.1605839,389.620438,483.4306569,7692.912409,421.8321168,120.2408759,2142,6444.554745,1369.693431,760.3284672,2818.145985,5177.686131,543.0729927,279.8175182,18347.13139,3934.489051,757.0145985,397.2116788,1355.912409,2186.839416,714.3138686,161.2627737,8294.49635,2209.510949,1203.459854,4510.715328,3161.875912,1053.051095,257.4671533,137,14.62817747,12.03649029,0.56828888,0.958041958,0.658653846,-1.210384513
+891,42169.17593,899.1018519,559.5740741,1142.805556,37514.5,713.3518519,491.5277778,1718.638889,19776.10185,596.8055556,454.25,1781.509259,27120.63889,1307.166667,5560.12963,4786.064815,10209.57407,1392.851852,421.787037,2430.824074,24894.24074,615.0925926,1551.166667,510.4166667,23141.55556,420.9537037,136.5833333,4482.240741,18167.2037,1478.175926,808.25,2818.157407,15038.59259,591.3981481,305.1018519,2359.296296,10500.05556,839.2962963,452.5462963,1298.833333,8838.740741,685.9907407,181.5092593,3922.166667,6422.018519,1316.046296,170.4814815,3316.240741,242.6666667,258.1944444,108,13.18914798,10.932315,0.55941588,0.892561983,0.553846154,1.463847884
+892,43078.28365,1034.567308,570.3557692,1163.418269,40863.17308,838.6778846,671.125,1772.120192,22409,684.6153846,515.875,1786.019231,31452.97596,1567.980769,5026.389423,3477.653846,10833.71635,1722.971154,457.8798077,2487.052885,20843.07212,462.3990385,726.0384615,500.7163462,23542.60096,458.8509615,145.3653846,3084.490385,18981.25481,1652.028846,910.3990385,2845.399038,15662.89904,748.2067308,328.5192308,2079.173077,12865.39423,960.7259615,514.0240385,1340.408654,10005.89423,852.1682692,200.6538462,5212.163462,7901.850962,1534.153846,365.4903846,3209.923077,380.1490385,261.9038462,208,20.10238259,13.61300712,0.735813937,0.936936937,0.619047619,-0.508122425
+893,34503.26667,879.8933333,546.2,1120.093333,30692.54667,753.1466667,661.9466667,1649.36,17130.44,583.1866667,808.7333333,1798.786667,24453.4,1339.973333,6829.293333,3901.626667,8481.96,1343.186667,405.1733333,2650.653333,16178.18667,438.6933333,411.4,1413.293333,19140.14667,448.0933333,151.24,5070.626667,15221.93333,1672.706667,828.12,2806.466667,12663.45333,612.68,293.4266667,3657.026667,10329.21333,981.6266667,450.2933333,1320.4,7777.72,721.2266667,177.6133333,6585.173333,6443.093333,1366.053333,909.68,3321.933333,501.5066667,258.4666667,75,10.70297188,9.649243699,0.432678944,0.974025974,0.681818182,0.685659911
+894,26980.17172,811.5151515,507.5858586,1085.717172,23311.68687,654.040404,995.7272727,1630.868687,13598.41414,546.1010101,2022.494949,1832.252525,18704.9596,1264.414141,6106.111111,3825.191919,6972.79798,1248.040404,358.4848485,7127.141414,12794.48485,987.969697,133.7979798,1227.656566,15137.83838,424.5757576,118.969697,4234.212121,12508.79798,1928.676768,791.2222222,2801.111111,10467.12121,754.8484848,271.3636364,9067.232323,8374.69697,1478.575758,416.2222222,1323.090909,6264.949495,648.6060606,172.2020202,4725,5333.252525,1267.313131,268.9494949,3254.494949,595.4545455,258.9191919,99,13.3255934,9.624679623,0.69161094,0.961165049,0.692307692,-0.34277956
+895,25048.15625,837.9166667,688.5,1141.78125,21457.5,673.3958333,611.4479167,1693.208333,12679.66667,519.53125,441.5416667,1832.802083,17506.75,1254.75,3046.072917,1779.083333,6372.395833,1250.041667,424.5208333,2583.572917,11391.96875,1145.291667,1260.708333,466.5416667,13262.34375,425.3020833,116.1458333,2351.791667,11619.95833,1404.489583,693.15625,2831.739583,9434.041667,606.6458333,285.2916667,15623.3125,7620.3125,1090.40625,415.65625,1387.072917,5709.552083,1103.4375,163.1875,4884.510417,4880.395833,1272.520833,182.1041667,3256.739583,778.5520833,258.0625,96,12.92743177,9.820502625,0.650315947,0.914285714,0.615384615,-0.659215015
+896,22425.89888,741.9101124,503.8876404,1091.865169,20136.01124,610.3595506,673.1573034,1688.123596,10636.08989,481.5280899,455.6516854,1796.977528,15567.58427,1162.606742,5834.359551,2956.764045,5643.853933,1174.044944,349.1235955,2532.966292,10343.2809,2996.078652,146.6067416,456.1235955,12634.30337,425.6741573,118.247191,8198.191011,10355.23596,1395.853933,854.8651685,2832.235955,8474.47191,618.9325843,271.8988764,18118.82022,6612.606742,744.0449438,395.2134831,1326.449438,4595.179775,652.8202247,157.3258427,4707.157303,4106.213483,1164.269663,158.9550562,3174.539326,910.7640449,259.3820225,89,12.1140352,10.56396372,0.48942866,0.898989899,0.526627219,-1.278356872
+897,21514.09808,754.6615385,458.65,1073.088462,18152.93269,609.8038462,603.7923077,1638.565385,7280.267308,465.6653846,780.2019231,1757.325,13177.84808,1118.042308,4158.596154,2134.782692,4630.417308,1126.817308,397.1403846,3476.944231,8544.340385,2779.026923,1334.473077,581.0942308,10164.88269,573.1192308,115.2115385,3625.003846,8137.161538,1668.7,688.6538462,2800.155769,6472.940385,585.8,230.6115385,4464.263462,4585.096154,1017.7,372.8653846,1343.496154,2363.494231,953.6423077,145.35,4491.292308,2384.971154,1048.928846,270.6923077,3151.498077,1078.155769,266.9942308,520,32.68638931,21.99186135,0.739811652,0.878378378,0.698924731,-0.184850311
+898,32468.8125,891.7443182,623.6477273,1166.028409,27656.14205,663.6818182,581.8409091,1694.238636,13759.26136,569.6420455,573.1079545,1788.636364,19918.45455,1239.028409,7664.613636,4611.238636,7004.948864,1312,390.1988636,3057.647727,13963.70455,604.9829545,582.3238636,494.9829545,16589.27841,440.6534091,128.0284091,8009.954545,12387.91477,1519.886364,768.6022727,2905.5625,10099.09091,571.3011364,273.5568182,4494.409091,6121.028409,831.8465909,425.6931818,1297.528409,5312.75,705.8465909,161.5170455,2988.590909,3974.755682,1195.619318,213.6477273,3274.25,207.6647727,259.7727273,176,18.3594162,13.14389207,0.69818127,0.88,0.628571429,1.24739753
+899,48348.53901,1050.368794,590.4397163,1172.93617,42508.16312,844.1205674,763.4468085,1764.170213,22917.96454,678.8085106,536.2978723,1794.695035,33663.80142,1558.787234,3462.48227,3831.524823,11485.87943,1883.801418,456.787234,2473.404255,21362.19149,464.9361702,805.3758865,473.3829787,25174.71631,478.6950355,150.5531915,2690.787234,20731.25532,1749.93617,919.6808511,2882.70922,17275.0922,1068.12766,333.5319149,2175.730496,14100.16312,996.822695,523.5177305,1372.446809,10781.83688,967.1205674,201.2624113,4939.347518,8965.524823,1560.87234,491.2269504,3362.049645,396.2907801,260.5035461,141,14.43127689,13.29221836,0.389396687,0.834319527,0.629464286,-1.201659078
+900,44120.725,1142.5125,600.95,1129.9,39164.1375,780.7625,531.8125,1595.325,21127.05,691.7875,484.2,1809.3625,29996.1125,1457.625,3955.0875,3866.45,10416.575,1475.8625,424.65,2443.975,20044.425,437.825,217.1125,441.55,24355.825,449.675,138.3625,3912.45,19653.3875,1568.275,892.825,2815.25,16662.1125,628.3875,307.3125,2238.9125,13462.675,902.3875,474.025,1306.0125,10068.075,700.35,179.1875,3119.325,8394.0875,1405.35,142.75,3414.95,407.3,258.3125,80,10.6587989,9.63262716,0.428112631,0.975609756,0.8,-1.303747247
+901,36808.02326,1035.186047,571.2093023,1141.930233,30984.53488,768.4651163,690.8372093,1645.581395,16423.5814,640.2093023,905.0232558,1786.162791,23503.09302,1407.255814,5728.069767,4804.627907,8161.27907,1387.790698,413.7674419,2594.744186,13709.88372,397.6744186,401.1627907,1146.488372,16084.97674,418.4418605,178.2093023,3772.418605,13155.83721,1758.325581,874.5116279,2835.069767,10739.46512,607.3023256,282.744186,2440,8661.162791,944.9302326,455.744186,1310.395349,6672.465116,730.627907,166.0697674,4250.232558,5258.069767,1315.255814,403.4186047,3387.488372,439.1395349,256.9069767,43,9.243466545,6.769732898,0.680895793,0.895833333,0.530864198,0.659782879
+902,30478.09,906.98,642.69,1179.3,27246.31,745.89,778.46,1850.56,15031.36,587.55,601.12,1888.77,20674.41,1393.55,6710.04,2894.61,7239.82,1299.96,385.62,2670.66,13957.77,9063.88,279.18,496.79,16260.63,506.14,129.51,8035.11,13429.89,1591.4,915.11,2846.11,11099.63,685.06,292.18,9020.46,8670.07,1146.39,457.32,1324.41,6530.15,698.94,176.18,5553.79,5309.02,1317.33,208.97,3351.23,576.73,260.05,100,12.61075142,10.37316483,0.568670862,0.909090909,0.641025641,1.033378156
+903,17049.82051,784.1709402,577.965812,1091.316239,14356.16239,632.3589744,480.5384615,1709.777778,8430.923077,515.7606838,428.974359,1862.837607,11624,1198.435897,7578.803419,3436.965812,4406.649573,1196.119658,358.7863248,2555.461538,7878.008547,3927.367521,102.2991453,462.4358974,9139.017094,420.9316239,113.9230769,8542.717949,7682.25641,1317.068376,1055.82906,2769.880342,6497.786325,636.9316239,262.1367521,22974.52137,5207.717949,784.3589744,382.6666667,1317.025641,3876.709402,817.7692308,155.4017094,5281.008547,3366.299145,1211.358974,192.8290598,3238.487179,642.8119658,259.5641026,117,14.51272477,10.61835034,0.681671956,0.951219512,0.642857143,-0.571502262
+904,25900.66957,803.1391304,601.5130435,1140.408696,21902.22609,634.1478261,500.2869565,1733.730435,13017.44348,520.2086957,417.3304348,1793.878261,18474.83478,1218.930435,6511.921739,4925.226087,6499.478261,1192,364.4869565,2547.026087,11820.75652,1908.252174,185.2695652,442.3565217,13957.61739,423.1565217,117.7652174,8082.991304,11967.52174,1365.556522,1217.269565,2803.608696,9922.730435,590.9652174,280.2782609,18105.56522,7993.782609,820.4086957,401.2,1313.591304,5934.295652,787.1478261,158.8869565,5826.086957,5120,1256.434783,188.9913043,3230.321739,717.826087,260.3043478,115,13.79587545,11.51422651,0.550835719,0.884615385,0.58974359,-1.004572371
+905,32206.73469,905.1938776,842.2244898,1181.295918,27751.7449,697.6122449,1094.234694,1850.469388,16428.93878,556.8979592,1425.071429,1869.377551,22830.91837,1306.908163,5365.571429,3612.469388,8101.969388,1284.265306,398.8163265,5095.653061,14960.03061,997.5102041,161.0408163,963.7959184,17803.21429,560.5714286,127.1530612,5019.959184,15227.41837,1644.122449,787.1938776,2813.918367,12417.76531,592.5408163,294.3163265,14178.67347,10218.63265,1606.346939,434.0918367,1355.183673,7469.561224,829.8673469,163.3979592,3871.520408,6404.040816,1333.632653,220.4795918,3311.102041,766.6122449,259.9897959,98,19.33556729,7.025749816,0.931649255,0.830508475,0.466666667,-0.889355293
+906,50040.97531,916.3333333,491.6049383,1143.259259,45552.19753,761.3950617,774.345679,1699.592593,25306.46914,634.1234568,910.691358,1774.938272,35191.90123,1384.08642,3924.975309,2895.888889,12936.07407,1490.802469,440.7160494,2490.481481,25835.48148,452.308642,210.617284,566.7037037,29714.4321,450.5555556,292.9382716,2283.049383,24198.82716,1840.765432,870.9876543,2825.851852,20338.49383,637.7654321,326.382716,1639,16139.62963,1205.604938,503.654321,1297.975309,12624.40741,697.5679012,184.1975309,3101.91358,10367.25926,1478.679012,230.5679012,3249.91358,319.2592593,260.7160494,81,13.60889266,7.677959761,0.825647065,0.952941176,0.566433566,-0.54736323
+907,43201.32692,1037.240385,529.3942308,1126.692308,37135.79808,797.8942308,1268.5,1611.480769,20220.96154,670.125,1731.596154,1795.807692,28552.18269,1431.865385,4295.932692,2868.817308,10290.40385,1462.326923,441.3557692,2631.086538,19495.875,442.6730769,514.7692308,1162.788462,22656.86538,457.1442308,990.2115385,2114.269231,18877.95192,2203.5,807.2980769,2822.894231,15458.49038,634.2692308,309.0288462,1692.788462,12714.70192,1093.307692,478,1345.009615,9492.586538,776.1057692,184.1826923,3339.903846,7970.490385,1425.442308,327.5192308,3424.307692,432.75,262.1538462,104,13.967828,10.53117743,0.656920836,0.904347826,0.541666667,-1.501134907
+908,39548.33019,960.8490566,560.6603774,1134.339623,34113.91509,748.8867925,824.6886792,1645.518868,18714.99057,629.9811321,1345.613208,1793.754717,26472.62264,1412.962264,6099.839623,4761.018868,9404.801887,1381.820755,422.5566038,2701.462264,17622.84906,432.8679245,301.0943396,1666.981132,20663.38679,467.3773585,469.1981132,3238.745283,16922.08491,1949.783019,947.3867925,2829.707547,13989.35849,646.8773585,307.7641509,2280.09434,11358.62264,1157.132075,473.7924528,1322.877358,8574.490566,714.3207547,178.6509434,5548.896226,7010.566038,1382.509434,366.254717,3355.679245,448.5943396,260.4056604,106,13.61651315,10.15187115,0.666443142,0.954954955,0.741258741,1.459077954
+909,49698.82051,952.3333333,510.025641,1159.307692,42524.87179,827.4871795,649.0512821,1668.769231,24344.79487,638.2307692,869.1538462,1837.615385,34579.97436,1444.641026,4251.871795,2687.692308,11893.4359,1442.205128,459.3589744,2529.820513,23086.94872,502.8461538,158.2051282,901.1538462,26857.20513,440,193.5897436,3028.025641,22009.66667,1768.666667,781.2051282,2872.358974,18119.64103,637,326.6923077,2231.871795,14477.23077,1003.564103,502.025641,1355,10473.51282,703.3333333,178.3846154,3784.051282,9002.410256,1419.435897,245.4871795,3233.025641,511.8717949,258.0769231,39,7.372815307,6.976284856,0.323532006,0.951219512,0.609375,1.470285647
+910,25789.51042,933.4479167,1113.083333,1264.65625,21153.55208,722.7395833,988.1875,2089.958333,12797.30208,581.1770833,534.5208333,2003.541667,17701.71875,1344.979167,4483.979167,2401.520833,6203.322917,1330.364583,415.1770833,2949.927083,11819.875,1024.385417,326.5833333,542.6354167,13762.69792,454.90625,123.6875,4813.125,11613.33333,1455.1875,736.875,2820.020833,9772.34375,621.3229167,281.1875,9873.6875,7827.875,837.5833333,429.6354167,1340.458333,5857.395833,910.53125,163.71875,3635.208333,4988.125,1315.822917,157.875,3280.895833,671.375,261.8333333,96,14.85421095,8.887705329,0.80125052,0.897196262,0.571428571,0.998362992
+911,24434.28571,925.2727273,574.1038961,1658.675325,21274.98701,685.2857143,776.9350649,2649.142857,11914.2987,537.4025974,398.4155844,1841.532468,16723.48052,1294.883117,5699.623377,2632.181818,6017.155844,1287.090909,445.1948052,2490.090909,11303.8961,546.5844156,713.2727273,451.7272727,13318.07792,451.025974,124.2727273,4324.012987,11385.92208,1421.597403,700.8051948,2808.12987,9296.25974,933.9350649,283.5064935,14233.25974,7463.116883,865.8441558,426.2727273,1352.064935,5569.025974,848.3246753,160.4155844,4880.12987,4764.948052,1314.636364,188.8701299,3246.584416,808.8571429,260.4935065,77,11.01287782,9.723433598,0.469533099,0.916666667,0.636363636,-0.708083645
+912,28651.17722,822.1012658,534.0886076,1185.911392,23837.25316,638.7974684,519.9240506,1922.417722,12197.16456,498.1518987,424.5189873,1821.658228,18798.98734,1205.974684,5245.911392,2683.987342,6824.037975,1211.746835,369.4683544,2486.772152,12505.75949,980.4303797,264.5443038,452.3544304,15416.08861,420.8607595,119.1012658,6742.873418,12880.51899,1411.670886,825.9620253,2811.316456,10333.31646,547.8101266,290.0759494,26002.39241,7863.113924,818.1139241,412.9746835,1349.810127,4845.417722,839.7848101,154.9873418,5867.708861,4591.113924,1197.21519,242.164557,3231.797468,998.0632911,260.5696203,79,11.96862271,9.076484914,0.651839823,0.929411765,0.658333333,-1.477591924
+913,31087.6,1227.188889,573.8111111,1148.866667,28446.01111,740.8222222,515.7777778,1686.011111,15960.12222,614.4555556,501.4777778,1807.888889,21440.56667,1350.177778,3651.444444,1607.733333,8087.9,1400.444444,439.4777778,2454.855556,17028.94444,445.8333333,227.6777778,725.1666667,17235.35556,459.3,137.1333333,1837.5,14193.62222,1978.377778,828.8111111,2849,12014.65556,709.8777778,296,1613.288889,9544.633333,1026.688889,469.7777778,1315.633333,7564.266667,682,171.4111111,1585.6,6254.233333,1337.155556,370.6,3326.177778,338.8777778,261.2555556,90,11.70137396,10.0716603,0.509070899,0.9375,0.681818182,0.296734106
+914,18983.352,806.872,606.68,1111.192,17097.32,635.848,614.896,1820.136,9350.16,510.52,508.96,1890.984,13412.864,1190.296,8597.856,5016.864,4854.272,1193.496,356.912,3279.344,8959.392,2392.712,143.608,489.088,10519.536,421.248,116.6,9925.488,8952.568,1438.736,1233.736,2791.168,7325.56,578.496,277.168,26322.088,6047.48,884.344,401.528,1363.792,4719.768,838.104,179.288,6092.064,3916.96,1232.672,186.568,3240.104,700.008,262.272,125,17.71707893,9.609596568,0.840125731,0.892857143,0.548245614,1.256608528
+915,12494.36641,698.6259542,438.4503817,1059.900763,10586.52672,584.1068702,438.4427481,1470.526718,6202.206107,459.9007634,372.8625954,1779.167939,8985.51145,1096.954198,2953.900763,1398.862595,3385.21374,1107.274809,512.8473282,2465.740458,5901.557252,472.5419847,1477.564885,487.9618321,6849.129771,377.2137405,108.5343511,2645.022901,6034.40458,1349.374046,725.9618321,2785.900763,4973.870229,618.389313,233.259542,9921.549618,4109.122137,799.870229,374.8396947,1360.679389,3074.977099,1075.885496,143.4656489,3156.10687,2629.206107,1135.870229,238.2519084,3157.923664,786.5801527,264.1908397,131,13.85900085,12.59855165,0.41668281,0.922535211,0.584821429,-0.540769795
+916,14994.19737,834.5921053,878.7697368,1129.151316,13117.85526,653.7171053,733.125,1777.671053,7160.868421,493.6184211,485.2039474,1869.361842,10498.93421,1200.868421,2682.967105,2051.559211,3947.210526,1221.414474,488.9210526,2940.703947,7008.927632,494.1842105,1527.447368,546.7171053,8438.684211,420.9868421,120.7105263,2618.828947,7110.427632,1431.861842,778.6973684,2800.401316,5863.289474,741.4078947,264.2368421,14504.18421,4620.164474,912.5789474,399.5855263,1393.190789,3426.651316,1444.868421,160.6973684,4127.802632,3004.546053,1223.940789,196.5394737,3238.098684,851.7039474,263.7039474,152,18.57665887,10.76533835,0.814965941,0.938271605,0.596078431,0.9695658
+917,47147.61538,953.8846154,540.6923077,1129.423077,40789.98077,753.2884615,684.4230769,1668.615385,22830.88462,648.4807692,719.1730769,1796.192308,31824.75,1400.980769,3686.884615,4236.076923,11407.5,1498.076923,430.7307692,2484.769231,22606.34615,439.5576923,236.2884615,524.5769231,26223.76923,447.7307692,164.5576923,2981.557692,21649.88462,1746.903846,926.4230769,2821.807692,17948.48077,629.1923077,330.3461538,1968.057692,13993.13462,1095.480769,490.4038462,1319.788462,10799.17308,682.7307692,182.1153846,2991.75,9034.115385,1438.923077,187.8653846,3376.884615,310.4230769,260.4807692,52,9.820096134,7.065879893,0.694458603,0.928571429,0.641975309,0.697992047
+918,34723.07477,1199.82243,591.1214953,1149.616822,34057.69159,819.0934579,695.588785,1761,17726.85047,645.2149533,614.5046729,1769.663551,25038.8972,1459.728972,6568.672897,3257.869159,8075.345794,1422.990654,415.8785047,2477.88785,12882.6729,396.3271028,164.5607477,469.0280374,16034.37383,567.9252336,130.8691589,2162.691589,12685.1215,1481.64486,839.7570093,2810.121495,10424.99065,807.3457944,285.7476636,1852.242991,8652.635514,915.2803738,455.317757,1304.878505,6808.429907,673.046729,183.0841121,2733.654206,5600.747664,1437.411215,3976.542056,3154.738318,350.0186916,263.7009346,107,15.15716568,9.150933529,0.797183974,0.922413793,0.648484848,0.585259865
+919,21949.18421,800.8684211,519.1710526,1086.223684,19049.67105,656.8421053,1023.789474,1687.421053,10889.85526,537.3815789,2608.815789,1890.776316,15920.43421,1233.473684,7991.381579,5282,5697.065789,1210.644737,348.5921053,9506.802632,10466.60526,690.4342105,108.75,1938.105263,12589.56579,448.8552632,118.4473684,5246.092105,10501.36842,2317.75,782.8289474,2786.960526,8898.947368,584.1973684,265.4342105,13276.94737,7195.828947,1712.776316,407.6447368,1325.921053,5390.789474,718.8157895,185.1710526,5881.710526,4773.684211,1257.315789,357.7105263,3207.210526,605.4210526,261.4868421,76,10.50077552,9.310416314,0.46245869,0.938271605,0.690909091,1.097892039
+920,25461.27322,780.6448087,530.2513661,1125.360656,21926.97814,635.3661202,515.9508197,1690.923497,12791.07104,505.3770492,565.7595628,1813.010929,17425.39344,1209.42623,5111.360656,3554.437158,6340.087432,1198.300546,374.2021858,3574.868852,11515.84153,3161.846995,257.8688525,580.6557377,13583.55738,413.726776,115.5191257,5251.540984,11560.98361,1477.622951,969.8469945,2793.836066,9444.497268,566.8360656,270.4153005,16827.05464,7617.333333,913.7814208,401.4972678,1322.562842,5779.448087,812.726776,157.010929,4380.57377,4883.459016,1235.497268,195.295082,3200.42623,753.4480874,267.0054645,183,21.7437751,11.08218936,0.860368897,0.888349515,0.67032967,0.090314058
+921,13689.38624,726.3597884,405.6666667,1036.555556,11750.25926,607.3227513,686.7724868,1539.640212,5208.238095,464.4814815,879.2010582,1744.291005,9070.634921,1144.62963,2336.962963,1780.26455,3296.396825,1150.063492,391.3333333,3817.746032,6097.280423,490.6984127,3009.259259,1057.333333,7257.481481,785.3544974,115.5767196,1294.656085,6191.555556,1659.492063,637.7566138,2801.486772,4989,529.957672,260.7037037,14207.01587,3760.47619,1040.608466,383.994709,1427.005291,2092.529101,1311.518519,158.7354497,8155.555556,2145.253968,1148.269841,965.2063492,3140.936508,1060.529101,265.9047619,189,19.55002958,12.99440651,0.747133043,0.926470588,0.617647059,-0.878145392
+922,36000.49398,880.3253012,610.0722892,1113.614458,32121.56627,703.9518072,597.4939759,1646.807229,17759.6988,592.1807229,470.1204819,1763.26506,24204.91566,1288.108434,5582.915663,3448.831325,9069.13253,1396.46988,423.4096386,2448.771084,16962.96386,401.5301205,533.9879518,447.1566265,20316.91566,456.4698795,136.9156627,4059.975904,16361.3012,1488.614458,1025.421687,2825.771084,13767.04819,650.7831325,315.2771084,7309.493976,10375.25301,873.5542169,459.8072289,1346.710843,8332.228916,752.3253012,184.8192771,4222.072289,6628.421687,1349.421687,295.1566265,3266.26506,274.3373494,263.1445783,83,14.10514172,7.936374649,0.826689585,0.912087912,0.58041958,1.048524292
+923,25910.78889,909.9111111,588.0666667,1104.288889,22897.7,726.2,586.3333333,1578.422222,12118.2,581.8888889,730.6444444,1769.188889,17694.3,1358.844444,4285.122222,4026.277778,6426.644444,1378.055556,430.2333333,2457.655556,12119.46667,432.7333333,1233.855556,717.5111111,14287.56667,491.7777778,135.4444444,3554.655556,11513.11111,1833.677778,1084.866667,2836.255556,9399.711111,1125.855556,293.3,2513.133333,7767.733333,1029.588889,459.1666667,1354.811111,5953.5,949.1888889,182.4555556,4828.822222,4757.022222,1379.266667,511.8333333,3253.388889,467.1888889,262.4,90,12.60277383,10.01306396,0.607247526,0.891089109,0.535714286,-1.189461906
+924,36409.2236,979.0745342,624.9813665,1157.254658,31408.99379,779.8447205,767.4285714,1669.509317,17263.86957,630.242236,985.1304348,1824.639752,25524.88199,1468.223602,6862.142857,5325.931677,8860.559006,1417.329193,445.0496894,2581.043478,14831.65217,413.515528,983.7453416,935.1801242,17929.62112,465.1987578,131.6024845,4029.15528,14335.32919,1821.391304,934.0124224,2831.490683,11833.67702,722.1863354,292.0807453,3027.84472,9909.074534,1162.708075,463.5341615,1365.465839,7622.57764,899.6086957,179.2919255,4739.900621,6357.925466,1378.124224,525.9689441,3284.012422,477.9440994,266.4720497,161,16.21100538,14.07073301,0.496609443,0.875,0.564912281,1.493439103
+925,19801.82576,807.4621212,599.4924242,1216.05303,16642.20455,645.0984848,733.5151515,1742.833333,9475.477273,487.3484848,555.9848485,1765.939394,13872.30303,1219.659091,2840.030303,2306.265152,5013.962121,1222.166667,382.4772727,2522.727273,8936.810606,501.5227273,835.2045455,633.7121212,10738.63636,402.3560606,121.7424242,1641.121212,9184.545455,1417.174242,703.4924242,2812.560606,7529.227273,584.1893939,265.0378788,13182.25,5876.590909,934.9924242,411.1363636,1366.818182,4262.704545,1319.318182,159.3333333,4752.909091,3745.295455,1247.030303,204.1969697,3210.090909,869.9166667,265.4545455,132,15.34536131,11.16324959,0.686142281,0.992481203,0.628571429,-0.655672409
+926,22426.55128,959.4230769,759.9102564,1204.935897,21403.11538,690.2435897,1179.653846,1780.910256,10582.66667,566.6923077,1818.423077,1839.782051,14387.21795,1216.628205,9227.102564,4085.602564,5000.679487,1248.294872,381.3717949,6483.576923,9137.512821,1048.333333,1126.076923,875.9615385,10466.32051,503.8846154,124.7564103,7147.666667,8041.025641,2027.769231,618.9102564,2863.551282,6403.897436,541.6282051,260.6025641,4199.871795,3576.564103,1085.474359,393.4358974,1331.794872,2900.25641,785.2307692,150.9487179,2899.166667,2293.474359,1093.74359,505.6538462,3223.833333,198.9615385,264.525641,78,15.37992993,6.705373125,0.899955369,0.951219512,0.5,0.734685562
+927,45904.53982,925.5221239,573.539823,1158.787611,40543.43363,731.9115044,493.380531,1733.159292,21553.47788,607.0176991,454.0707965,1788.902655,29775.62832,1360.946903,6070.814159,2863.141593,11345.63717,1436.973451,427.2654867,2414.946903,21709.99115,496.9646018,526.1327434,477.5044248,25373.30973,428.1769912,135.6902655,4478.814159,20091.45133,1512.920354,884.4778761,2839.690265,16914.53982,645,314.8761062,2981.230088,11993.84956,858.2389381,458.4424779,1328.40708,9783.469027,682.1946903,182.6814159,3840.433628,7434.734513,1380.504425,210.8849558,3313.318584,251.9292035,265.1681416,113,13.42729468,11.03445914,0.569785904,0.88976378,0.579487179,-1.216037376
+928,36700.49265,944.5073529,543.9044118,1121.169118,32898.71324,743.1470588,619.4191176,1606,18652.30147,622.6617647,1181.257353,1817.044118,25828.66912,1334.713235,6743.639706,3313.198529,9653.110294,1405.147059,414.6323529,2582.654412,18563.97794,485.4044118,238.2279412,1041.382353,21448.21324,443.9926471,760.4117647,2866.360294,17364.68382,1825.441176,823.7941176,2834.066176,14616.63971,606.25,296.0220588,1654.705882,11471.58088,970.625,454.6397059,1312.463235,9013.044118,689.9926471,177.2794118,3055.455882,7412.632353,1346.352941,206.1911765,3346.433824,328.1397059,265.5441176,136,13.57939899,13.00081548,0.288789712,0.944444444,0.693877551,-0.772431231
+929,24355.0303,867.3737374,622.4040404,1137.949495,20928.0101,677.0505051,642.040404,1710.555556,11153.35354,554.9494949,655.5252525,1779.565657,16073.60606,1262.818182,6675.292929,4694.323232,5948.989899,1293.787879,402.3434343,3011.141414,11428.19192,437.2323232,2419.919192,673.8888889,13863.47475,413.7171717,128.6464646,8757.20202,10404.29293,1841.525253,808.5656566,2808.474747,8560.909091,571.0808081,301.4646465,5032.050505,5683.383838,891.0606061,424.3737374,1372.20202,4950.656566,1135.808081,177.3636364,4232.10101,3592.545455,1235.868687,359.2323232,3366.575758,221.6060606,264.7676768,99,12.92339558,9.862840006,0.646189339,0.961165049,0.707142857,1.270471262
+930,15834.40845,1123.253521,581.7323944,1054.239437,15119.01408,730.7042254,744.5352113,1438.521127,7402.352113,634.8873239,871.7887324,1870.422535,9523.549296,1234.422535,5786.873239,3904.873239,3938.619718,1249.943662,356.8732394,2408.211268,7489.901408,352.4788732,144.1971831,792.7887324,7995.450704,435.2816901,115.5774648,3610.28169,6200.802817,1660.126761,771.7605634,2792.380282,5376.521127,538.1830986,235.6338028,1885.478873,4286.056338,1070.380282,380.4929577,1282.521127,3634.295775,571.7323944,147.2957746,3235.042254,2582.211268,1124.521127,167.3943662,3538.873239,305.7042254,266.7323944,71,13.32716571,7.603483303,0.821280126,0.865853659,0.606837607,0.021413576
+931,15490.96196,705.9293478,499.4347826,1066.929348,13492.55435,591.3097826,384.1630435,1580.967391,7512.853261,457.9130435,358.8641304,1793.429348,10415.39674,1093.48913,4938.847826,2737.576087,3811.059783,1102.657609,434.4347826,2464.505435,6993.728261,2282.847826,1726.5,429.7771739,7972.451087,377.1304348,111.576087,6056.288043,7030.831522,1319.445652,898.173913,2785.423913,5702.195652,567.7608696,254.2391304,16473.38587,4621.744565,838.5163043,374.5543478,1386.951087,3435.836957,1220.173913,147.0271739,5305.108696,2897.358696,1137.13587,255.3967391,3174.434783,798.9782609,269.875,184,21.52739537,11.38499166,0.848708692,0.897560976,0.657142857,-0.260835631
+932,24162.30263,752.0855263,510.1710526,1091.572368,20363.34868,622.3092105,824.0921053,1760.118421,10394.78289,484.9276316,1556.342105,1865.072368,15795.86842,1148.25,5779.078947,4802.559211,5869.598684,1170.789474,351.3223684,4259.046053,10269.39474,1079.013158,193.3157895,2060.203947,12279.22368,407.5197368,327.5197368,4871.789474,10185.45395,1861.776316,909.8355263,2816.217105,8313.565789,541.1776316,249.25,11907.125,6286.092105,1008.157895,389.5131579,1348.348684,4066.361842,664.2631579,155.3881579,5228.638158,3717.835526,1148.822368,274.8289474,3148.809211,965.1315789,266.5065789,152,14.53828267,14.14744181,0.230313707,0.904761905,0.633333333,0.964667827
+933,52556.43689,1053.436893,601.4854369,1174.097087,45458.54369,818.7281553,682.4174757,1730.621359,25058.87379,688.8932039,536.3592233,1787.834951,36014.40777,1552.640777,5077.320388,5540.300971,12584.52427,1543.864078,452.7378641,2456.097087,20586.04854,439.1553398,284.7281553,536.4174757,25033.53398,525.4854369,144.6116505,3771.990291,20420.98058,1604.368932,1023.650485,2828.019417,17216.20388,646.3592233,332.0097087,2655.145631,13957.21359,972.2330097,507.7961165,1337.699029,10515.31068,738.8252427,192.8058252,5165.873786,8780.019417,1489.582524,210.7378641,3363.708738,410.3106796,266.6893204,103,15.65651931,8.919175689,0.821867932,0.837398374,0.572222222,-1.266080304
+934,45976.64407,982.6779661,589.7288136,1158.288136,39482.42373,856.6949153,947.9322034,1723.779661,22316.05085,663.5084746,988.2711864,1815.338983,32365.59322,1538.627119,6594.694915,5205.661017,10805.55932,1492.627119,444.2033898,2800.576271,19687.9661,497.0847458,169.1525424,1341.152542,23068.49153,432.3898305,171.2033898,3865.508475,19032.40678,1905.423729,788.2711864,2824.050847,15813.61017,684.3220339,319.559322,2755.288136,12694.84746,997.3389831,486.3898305,1308.372881,9305.661017,686.7627119,188.0847458,3407.728814,8123.016949,1408.491525,271.779661,3251.254237,509.6949153,265.6440678,59,10.22920895,7.656808361,0.663107704,0.893939394,0.59,0.481033641
+935,22389.93137,768.9411765,515.0784314,1109.813725,19742.42157,617.0098039,508.4803922,1768.705882,10288.96078,490.1078431,556.6862745,1822.392157,15201.0098,1175.72549,5378.058824,3912.039216,5452.627451,1174.843137,353.6862745,2584.343137,9957.764706,2298.95098,120.9901961,554.5588235,11989.51961,637.6960784,117.4313725,6957.421569,9795.215686,1314.176471,950.8235294,2790.539216,8015.5,612.5098039,273.8921569,22457.11765,6248.960784,800.5980392,398.8235294,1328.205882,4258.27451,643.3235294,158.9901961,5531.705882,3789.04902,1187.147059,194.7745098,3208.362745,916.9215686,266.1078431,102,15.54237074,8.633791905,0.831516323,0.927272727,0.566666667,-1.109910993
+936,27595.11364,840.4204545,595.9886364,1109.988636,24524.13636,673.0568182,574.8068182,1609.897727,12664.02273,556,851.3409091,1781.102273,17555.07955,1283.670455,9427.647727,6262.636364,6503.590909,1298.204545,388.0454545,4152.522727,12828.45455,367.9090909,1568.636364,466.1704545,14839.61364,398.5340909,129.2272727,8643.909091,11520.35227,1813.079545,763.5568182,2803.784091,9557.284091,567.7386364,285.0795455,2379.272727,6681.931818,920.4772727,426.5909091,1343.375,5679.693182,978.9545455,188.6477273,4579.613636,3958.034091,1237.568182,221.2954545,3261.965909,238.4545455,267.1363636,88,12.46373158,9.320422263,0.663920105,0.967032967,0.615384615,1.116322
+937,17410.44,777.03,587.26,1128.36,15079.75,638.89,447.8,1681.59,8389.11,577.07,407.28,1825.86,11780.81,1186.76,4800,3350.26,4314.74,1230.23,442.84,2476.46,7831.17,2468.84,775.57,445.25,9054.29,386.71,111.89,5227.13,7685.36,1317.18,989.56,2788.89,6466.87,665.17,281.72,28901.36,5234.87,761.14,384.01,1368.12,3974.59,1033.21,162.14,7408.54,3371.09,1211.97,194.53,3189.1,727.66,266.96,100,12.27652195,10.79498998,0.476231586,0.925925926,0.699300699,-1.382107752
+938,22340.63462,767.125,543.7836538,1107.4375,19145.32692,611.4663462,626.7884615,1682.692308,11187.30769,510.2836538,813.3173077,1878.596154,15379.76442,1195.663462,6371.370192,4418.908654,5624.432692,1182.442308,361.0721154,3365.927885,10184.48558,872.2740385,155.8942308,904.1971154,12039.89904,396.4903846,114.5096154,7080.081731,10192.37981,1698.764423,1047.942308,2789.745192,8452.115385,562.7451923,266.3173077,19434.32692,6831.778846,903.9663462,395.5961538,1340.923077,5254.985577,800.625,156.75,5365.995192,4438.769231,1204.798077,262.7644231,3214.514423,741.4038462,270.1778846,208,17.8337767,15.45695886,0.498788372,0.932735426,0.679738562,0.581290046
+939,19639.85938,723.96875,513.59375,1084.570313,17018.92188,588.6484375,498.0390625,1549.34375,9803.953125,457.8984375,444.7890625,1774.210938,14179.59375,1134.414063,4631.164063,2657.703125,5236.53125,1292.5,377.3203125,2770.921875,9276.0625,3770.78125,230.5625,460.1640625,11067.71875,409.296875,115.6875,7237.179688,9418.40625,1313.976563,857.203125,2807.507813,7703.429688,579.109375,260.671875,13840.91406,6372.390625,790.421875,389.515625,1315.21875,4833.148438,863.9609375,157.046875,2902.960938,4108.1875,1179.984375,156.5703125,3229.679688,770.234375,268.140625,128,16.52044918,10.25326515,0.784095001,0.920863309,0.592592593,-1.45334347
+940,16231.31507,678.9726027,466.0958904,1056.753425,14103.9863,560.4520548,405.260274,1578.630137,7950.287671,450.7123288,466.3424658,1813.630137,10894.72603,1115.219178,4554.109589,3455.684932,4082.438356,1080.410959,350.4931507,2776.328767,7437.876712,1306.986301,1184.986301,440.9589041,8751.917808,365.4246575,116.5890411,5330.684932,7423.547945,1374.356164,992.8493151,2786.328767,5970.643836,521.4520548,237.1232877,9104.69863,4728.794521,742.4657534,365.6712329,1324.027397,3383.068493,933.0821918,150.4794521,4451.684932,2927.821918,1102.821918,177.6986301,3132.465753,833.9863014,265.6986301,73,13.92108941,6.754539128,0.874402144,0.924050633,0.651785714,-1.303356237
+941,18975.79817,740.2385321,447.7201835,1080.40367,16196.70183,595.0137615,485.7706422,1640.756881,8945.972477,469.1788991,447.6055046,1799.105505,13089.6422,1162.293578,4353.56422,2188.440367,4754.857798,1137.642202,353.5137615,2546.09633,8604.53211,9262.045872,141.2385321,478.5,10331.98624,491.1330275,115.7247706,3930.197248,8600.958716,1338.495413,835.7844037,2790.720183,7015.399083,687.2706422,247.6376147,8255.307339,5517.298165,811.8715596,388.4449541,1311.155963,3878.178899,655.0183486,152.5825688,3391.674312,3402.247706,1167.637615,141.1055046,3188.454128,899.587156,269.3119266,218,19.85730248,14.10608752,0.703825609,0.947826087,0.712418301,0.925118098
+942,27182.1791,860.5671642,651.9850746,1183.840796,13762.72637,498.39801,1029.532338,1451.313433,6713.905473,454.2338308,1381.263682,1750.21393,9677.965174,994.1940299,8182.875622,3134.930348,3444.920398,1015.323383,316.8507463,5791.900498,6635.78607,295.9552239,241.7562189,743.199005,7920.139303,328.5273632,103.5721393,6445.701493,6106.189055,2072.970149,499.1791045,2795.706468,4987.885572,482.9303483,221.3233831,5977.273632,2846.442786,856.7064677,345.9552239,1293.432836,2483.467662,569.8358209,139.5373134,2192.940299,1968.875622,965.7562189,358.2885572,3138.721393,192.4577114,272.1243781,201,17.3869993,14.96141652,0.509459801,0.975728155,0.656862745,0.802648195
+943,34194.28571,956.0714286,564.8333333,1101.619048,29589.5,712.7142857,733.4047619,1636.52381,16578.7619,598.7619048,1003.095238,1805.214286,22440.7381,1296.166667,5821.333333,3942,7953.738095,1359.785714,401.5238095,2421.904762,15223.88095,386.8333333,204.6666667,1122.97619,18061.71429,454.4285714,134.7619048,4185.785714,14372.30952,1839.261905,788.3333333,2809.714286,11815.88095,689.7619048,293.2857143,2198.857143,9281.404762,1104.214286,450.3571429,1301.261905,7273.595238,654.8095238,176.2619048,5909.285714,5949.142857,1352.5,152.6190476,3392.857143,298.6904762,266.3809524,42,9.113642879,6.841120077,0.660704548,0.857142857,0.583333333,1.46545059
+944,27817.65882,940.6823529,523.4352941,1132.752941,24596.78824,708.2,594.3058824,1574.894118,13287.4,585.9764706,550.8588235,1819.294118,18977.88235,1349.329412,5329.4,2435.682353,7049.305882,1358.505882,392.9411765,2452.164706,12817.61176,905.4823529,1028.294118,521.2235294,15004.64706,481.7411765,132.2941176,1602.788235,12332.56471,2094.364706,1392.882353,2819.164706,10090.54118,685.8117647,283.8705882,1624.952941,8322.305882,948.9411765,455.7176471,1320.011765,6408.882353,878.0823529,171.3529412,3109.247059,5263.141176,1342.117647,145.7176471,3336.917647,459.3882353,268.8117647,85,12.82053908,9.162387721,0.699467122,0.885416667,0.544871795,0.442122641
+945,8989.313433,790,928.0447761,1164.537313,9077.134328,621.3283582,789.238806,1783.432836,4395.985075,498.1492537,685.1641791,1905.19403,6975.955224,1176.880597,5637.313433,3121.58209,2676.432836,1209.447761,343.8507463,4259.164179,4519.671642,1574.044776,104.3880597,622.6716418,5339.164179,439.2686567,110.8208955,4959.597015,4108.149254,1459.731343,908.1641791,2784.865672,3476.462687,607.5223881,263.7462687,21749.1194,2920.179104,1113.671642,401.1044776,1348.149254,2424.223881,838.2985075,153.6268657,6316.776119,1976.19403,1206.537313,215.761194,3253.61194,661.880597,267.7164179,67,13.44330847,6.590469279,0.871586575,0.917808219,0.572649573,-1.088379026
+946,24014.35052,778.1134021,487.1134021,1147.56701,20343.40206,614.0103093,618.9587629,1755.659794,11663.71134,518.2680412,564.8350515,1827.082474,16090.1134,1205.917526,5482.927835,3150.57732,5651.061856,1163.546392,485.1134021,3351.824742,10866.73196,4084.051546,481.9381443,499.0412371,12521.59794,418.1546392,114.7835052,5568.42268,10732.85567,1627.814433,926.3608247,2789.412371,8770.494845,584.0515464,256.9896907,8625.298969,7174.453608,947.1443299,396.5979381,1362.360825,5381,772.8247423,163.0721649,3576.597938,4588.979381,1217.474227,180.4226804,3168.886598,693.1958763,269.257732,97,15.07368296,8.599578502,0.821295649,0.873873874,0.532967033,1.00596728
+947,20955.8963,737.5185185,525.8296296,1083.22963,17877.62963,608.0444444,555.2,1698.525926,8947.659259,461.6592593,606.8814815,1742.333333,14001.53333,1128.17037,5932.807407,4014.940741,5108.140741,1149.22963,355.9111111,3012.533333,9153.422222,1174.562963,519.5703704,487.9925926,11143.94074,404.7407407,112.2888889,6849.755556,9345.97037,1618.325926,989.5851852,2787.659259,7624.585185,539.2592593,250.8666667,13284.7037,5779.592593,863.8666667,391.4888889,1326.333333,3732.748148,830.4814815,151.2814815,4665.585185,3475.555556,1118.459259,252.9407407,3186.77037,981.3037037,269.8074074,135,14.902191,11.81477005,0.609454554,0.931034483,0.692307692,0.124706709
+948,47070.90909,1132.357143,679.5909091,1219.727273,42378.18182,863.7077922,806.1688312,1821.844156,23381.92208,759.6883117,539.5714286,1827.201299,34278.11039,1574.584416,6763.38961,4536.766234,12462.16234,1946.902597,475.8636364,2504.428571,23710.65584,497.5064935,1500.214286,497.8116883,28351.25974,516.6623377,154.7077922,6145.792208,23205.37013,1887.571429,1042.474026,2838.837662,19301.01948,777.3246753,343.2467532,2361.155844,15472.51948,1042.779221,536.6558442,1365.071429,12231.28571,1016.88961,203.4480519,4246.487013,9973.922078,1600.487013,216.7337662,3422.623377,385.6623377,272.3246753,154,21.39903049,10.28801938,0.876846549,0.827956989,0.475308642,-0.828339549
+949,29128.65517,890.3908046,594.3678161,1142.528736,25264.43678,736.4367816,648.9655172,1604.011494,13638.90805,585.7931034,599.1724138,1798.114943,20013.16092,1372.643678,5815.597701,4403.724138,6941.114943,1351.689655,410.137931,2560.367816,12616.18391,1594.45977,564.9425287,713.5057471,14308.57471,430.908046,128.1954023,4082.574713,11671.09195,1555.643678,888.8850575,2811.103448,9701.701149,631.8045977,291.4022989,4333.252874,7774.712644,878.5862069,454.6666667,1338.494253,5866.666667,801.8965517,184.8505747,4581.45977,4707.022989,1323.689655,564.9885057,3255.517241,501.6781609,268.7701149,87,11.41693728,9.869325006,0.502725798,0.956043956,0.659090909,0.784243135
+950,24222.66518,749.3928571,456.9508929,1080.522321,21386.52679,622.65625,794.7723214,1611.870536,11858.51339,501.0892857,1434.236607,1851.254464,16467.07143,1183.598214,6092.321429,3693.058036,6205.294643,1179.441964,358.6517857,5384.799107,11099.21429,5550.138393,375.59375,1040.053571,13238.75893,435.5848214,113.7098214,4780.138393,10709.07589,1874.665179,782.5535714,2796.799107,9019.334821,646.2857143,251.2410714,4040.607143,7233.401786,1225.111607,393.5982143,1315.6875,5454.883929,694.5848214,194.6875,3698.566964,4587.991071,1196.147321,224.1919643,3204.205357,606.1026786,272.78125,224,22.49240715,14.11231056,0.77867657,0.885375494,0.589473684,0.850590896
+951,23204.69027,802.4778761,549.8849558,1124.823009,19281.61947,635.3716814,701.5663717,1715.672566,10801.80531,488.8495575,1564.070796,1774.221239,16504.19469,1215.672566,5822.451327,3359.743363,5868.415929,1186.893805,372.9911504,4323.380531,10610.93805,554.7610619,216.9380531,1621.911504,13064.25664,2165.035398,122.9557522,4163.699115,10800.77876,1458.053097,768.1946903,2825.460177,8795.123894,558.7433628,291.3097345,30675.85841,6857.00885,1246.088496,408.7876106,1380.964602,4601.486726,691.3628319,160.2831858,6864.60177,4274.221239,1211.486726,289.1415929,3164.123894,928.8053097,269.8761062,113,14.49261574,10.21263267,0.709526892,0.933884298,0.733766234,-0.212162353
+952,27191.20915,784.7973856,543.254902,1313.124183,23100.71242,621.5098039,667.5620915,2163.732026,11300.51634,470.0392157,475.3594771,1861.437908,17936.98693,1155.941176,4474.052288,3040.352941,6529.267974,1194.72549,359.3856209,2642.183007,11762.34641,5342.143791,211.6993464,436.1176471,14446.20261,451.4248366,118.8823529,5982.712418,12004.61438,1464.169935,1073.176471,2822.470588,9625.470588,580.5490196,265.0718954,10813.79739,7250.124183,919.6732026,395.4379085,1313.431373,4555.30719,689.7254902,153.7777778,5118.640523,4209.464052,1166.921569,223.0196078,3192.228758,1000.24183,270.7777778,153,16.97537062,14.51593151,0.518434724,0.796875,0.5,0.569173936
+953,48931.39506,942.2098765,562.5925926,1163.45679,44170.59259,757.5679012,601.7901235,1753.580247,23633.32099,635.4938272,458.1604938,1772.765432,32808.88889,1385.469136,5888.160494,3783.074074,12520.46914,1466.407407,448.8765432,2403,22851.01235,433.6790123,198.8395062,441.4197531,28342.23457,433.7407407,140.0864198,3886.469136,22406.97531,1557.938272,929.4938272,2838.185185,19002.03704,637.9876543,325.1728395,2317.061728,13810.75309,875.2098765,479.3580247,1307.123457,11147.45679,700.6419753,176.4320988,3244.716049,8733.777778,1430.333333,182.4320988,3289.91358,261.0864198,270.4567901,81,13.33013779,8.490228787,0.770930062,0.870967742,0.519230769,-0.800640864
+954,37584.13924,953.0253165,562.3164557,1126.848101,32682.65823,780.1012658,896.3797468,1668.556962,17449.82278,621.4683544,584.9873418,1794.974684,25590.17722,1402.759494,6260.924051,4178.670886,9205.696203,1431.746835,431.3670886,2546.253165,16638.5443,425.6835443,1129.924051,598.5949367,20178.62025,575.1772152,141.9746835,3610.835443,16562.58228,1652.949367,940.6075949,2798.101266,13517.59494,632.5189873,301.4810127,2436.746835,11141.29114,943.5822785,493.6582278,1342.860759,8396.544304,926.4556962,182.8101266,4864.443038,7277.405063,1475.531646,322.2658228,3257.341772,421.9240506,268.9873418,79,11.29719454,9.049795146,0.59857642,0.951807229,0.718181818,-1.016193988
+955,22648.04396,753.9010989,490.1813187,1100.258242,19691.05495,615.021978,530.8956044,1686.027473,11237.09341,478.3351648,417.5054945,1838.653846,15717.32967,1154.956044,5317.291209,2989.016484,5792.56044,1162.461538,373.0384615,2599.230769,10473.53297,4606.258242,420.0879121,444.1703297,12594.08242,423.5879121,119.8021978,7868.763736,10528.2967,1335.285714,837.1153846,2803.956044,8534.186813,568.8846154,260.1483516,13521.73626,6802.983516,781.478022,393.2472527,1337.318681,4944.175824,963.6043956,150.4120879,3196.21978,4295.648352,1183.307692,166.4120879,3221.258242,839.1043956,272.3186813,182,22.82493484,11.15884193,0.872346434,0.808888889,0.527536232,-1.251220209
+956,25231.12025,752.164557,524.2151899,1104.341772,21389.10127,593.7531646,495.4873418,1778.544304,11247.1519,479.9303797,459.3037975,1849.310127,16849.06962,1153.335443,5906.613924,2608.702532,6265.056962,1155.810127,363.7658228,2665.506329,11146.57595,2568.405063,449.9050633,526.2025316,13164.68354,456.2151899,119.9810127,7752.835443,11125.92405,1384.835443,875.9050633,2808.379747,8990.588608,528.2594937,268.721519,18775.06962,6890.348101,801.0126582,393.2025316,1336.588608,4485.544304,790.3417722,150.2468354,4392.291139,4128.563291,1151.632911,221.7405063,3171.702532,951.0063291,272.3037975,158,20.42002402,10.71971923,0.851126192,0.827225131,0.554385965,-1.22712369
+957,36084.86486,861.3783784,591.3603604,1144.468468,17516.88288,560.2612613,518.7837838,1493.522523,9124.927928,486.2702703,1005.387387,1754.234234,12879.68468,1077.009009,9035,3254.648649,4918.477477,1110.162162,351.4054054,3432.315315,9598.36036,324.2072072,404.3153153,831.1081081,11355.4955,353.5855856,111.7747748,4825.657658,8692.657658,1827.648649,666.2882883,2810.954955,7176.36036,514.2072072,242.5225225,4106.027027,4658.495495,782.018018,373.963964,1311.90991,4151.396396,639.5855856,148.2972973,2396.018018,3041.243243,1090.45045,390.4594595,3150.873874,211.9099099,272.3333333,111,13.2183725,10.74928701,0.581973073,0.965217391,0.656804734,-0.746914603
+958,41419.94722,947.7055556,611.2694444,1142.180556,36863.61667,729.4361111,573.8305556,1690.463889,20288,620.325,482.9583333,1790.897222,27576.78333,1343.863889,5602.841667,3757.733333,10391.38056,1470.030556,429.0638889,2439.763889,19686.575,421.5666667,431.4888889,452.075,23831.05,441.7222222,135.025,4041.105556,18831.37778,1544.908333,919.6305556,2852.116667,15861.87222,671.0888889,311.6611111,4973.102778,12094.33889,883.9972222,472.2694444,1332.580556,9780.666667,739.6638889,186.6888889,3513.833333,7612.377778,1388.544444,248.3277778,3344.583333,275.2638889,278.5611111,360,25.79425922,19.20225729,0.667690273,0.820045558,0.666666667,0.152285329
+959,28721.60656,808.3770492,559.9508197,1089.754098,26393.72131,670.6557377,1150.377049,1582.393443,13974.63934,543.5245902,1674.704918,2035.737705,20028.40984,1244.918033,5143.754098,5777.491803,7435.655738,1316.672131,386.4754098,2579.081967,14683.59016,394.6393443,203.852459,832.7540984,17222.2459,464.5245902,151.6065574,3004.540984,13714.29508,2246.639344,895.4098361,2808.196721,11513.19672,598.6065574,270.4590164,2304.688525,9148.245902,1917.672131,445.2622951,1316.393443,7312.836066,654.7868852,174.9672131,6325.344262,5902.114754,1312.803279,356.442623,3211.852459,312.557377,270.9836066,61,11.9560283,6.814619311,0.821663074,0.871428571,0.554545455,-0.578511765
+960,36885.225,1231.6375,662.1875,1185.0125,32295.375,846.3625,622.0125,1828.375,19734.15,745.6125,661.65,1829.55,26289.4625,1531.25,7232.95,3812.6875,8948.9,1474.6375,475.65,2466.2625,16162.175,438.1375,653.7625,528.775,18687.55,496.9875,136.65,4025.4875,15205.55,1899.625,946.475,2824.6625,12852.575,769.4375,315.5,1838.575,9815.125,1075.225,483.2125,1333.7125,8126.8875,818.6375,187.4125,2549.8,6526.8375,1571.975,944.375,3445.5125,343.3375,270.675,80,12.52539549,8.590807171,0.727723018,0.909090909,0.615384615,-1.36990912
+961,39664.53435,984.6564885,623.6335878,1139.503817,34257.00763,778.5648855,828.3053435,1650.564885,18641.9542,644.0305344,1005.870229,1822.251908,26557.51145,1450.587786,7982.59542,5194.244275,9601.778626,1427.061069,431.8244275,2579.038168,17892.9084,458.389313,524.9847328,1016.717557,21410.83969,1171.931298,141.0076336,5150.221374,17203.32061,1924.198473,1062.351145,2813.671756,14136.82443,652.9160305,314.0229008,2306.732824,11617.25191,1422.603053,481.9465649,1336.038168,8944.679389,786.0305344,182.5267176,6069.679389,7317.21374,1433.969466,196.9160305,3540.51145,450.2442748,272.0687023,131,16.475855,10.56589308,0.767293928,0.942446043,0.623809524,0.766976417
+962,20100.07955,756.3522727,584.5795455,1107.556818,17384.70455,604,461.9886364,1901.784091,9857.693182,612.5227273,418.1875,1940.920455,14119.32386,1159.136364,6761.840909,4060.943182,5090.431818,1164.914773,488.375,2518.960227,9190.642045,1282.340909,1021.397727,446.7613636,10791.05682,391.4602273,116.5113636,8949,9185.102273,1357.295455,1178.585227,2786.318182,7574.784091,656.9715909,259.4375,22026.09091,6157.869318,765.0397727,380.5170455,1383.323864,4681.011364,993.8409091,156.2329545,5668.579545,3930.005682,1199.431818,163.5340909,3177.102273,711.5284091,270.9431818,176,23.94294165,10.05159765,0.907609861,0.842105263,0.695652174,1.567661452
+963,15355.19915,726.4915254,504.7754237,1067.021186,13034.44915,582.4915254,622.5466102,1686.233051,6240.190678,451.3601695,523.9618644,1817.915254,10228.95763,1109.389831,5123.237288,3938.487288,3831.165254,1119.237288,343.1398305,2863.932203,6800.271186,1942.474576,1513.70339,458.9915254,8315.300847,415.9322034,116.0169492,7327.101695,6892.771186,1599.457627,1102.711864,2787.004237,5674.012712,547.9110169,250.8771186,15476.7161,4314.262712,828.4449153,383.2245763,1353.305085,2630.050847,1047.550847,153.1101695,6570.686441,2522.025424,1110.487288,465.2161017,3159.326271,1012.216102,276,236,20.03703079,16.46384929,0.56996192,0.911196911,0.59,-0.494852411
+964,35320.30172,1083.293103,579.7844828,1132.965517,30769.57759,786.0517241,1336.043103,1714.422414,16848.41379,663.1465517,1122.560345,1845.801724,22724.03448,1392.586207,6174.344828,3247.525862,8327.672414,1408.137931,415.3965517,2498.327586,16447.93966,433.387931,172.9224138,2261.327586,19330.52586,464.4482759,133.6293103,3600.008621,15574.69828,1940.051724,758.4482759,2807.974138,13020.23276,637.5775862,303.3534483,1639.439655,10145.30172,1082.344828,477.3103448,1322.258621,8249.258621,676.9310345,185.9396552,3354.810345,6482.767241,1389.543103,195.8965517,3427,293.25,273.0344828,116,13.35971458,11.45677188,0.514382071,0.913385827,0.594871795,1.258878795
+965,22345.79167,1189.020833,735.6458333,1215.3125,21901.1875,894.9375,746.0416667,1766.25,10599.16667,701.4375,1177.520833,1846.208333,14923.41667,1612.875,4423.4375,5761.354167,6639.104167,1511.354167,436.875,2488.125,10740.0625,492.1666667,1522.625,553.2708333,11233.47917,601.2083333,149.1666667,4468.208333,8488.791667,1859.104167,954.4166667,2817.8125,7408.3125,878.375,319.9791667,2394.25,6062.666667,1658.583333,482.625,1400.125,5400.5,1149.104167,217.7916667,6572.708333,3870.1875,1538.020833,635.5,3433.916667,400.3333333,271.1041667,48,10.74728645,6.598821492,0.789306921,0.842105263,0.484848485,0.513177534
+966,38145.01266,923.0379747,523.0506329,1104.746835,32370.46835,728.1012658,612.6962025,1577.873418,17606.87342,614,624.7594937,1730.924051,25218.20253,1363.151899,4130.43038,3596.164557,9086.734177,1395.468354,421.2531646,2475.139241,17200.88608,410.6202532,334.4556962,638.2278481,20648.37975,431.5316456,145.0759494,3940.189873,16731.73418,1611.987342,887.0632911,2814.21519,13708.74684,629.3037975,287.8481013,1911.202532,11264.96203,937.0253165,456.164557,1329.810127,8513.341772,716.0759494,177.3291139,4385.683544,7262.367089,1407.620253,277.2025316,3323.936709,433.4303797,271.5063291,79,11.3128245,9.036776435,0.60158585,0.908045977,0.718181818,1.196731884
+967,22776.25714,718.8071429,466.7357143,1083.821429,19355.8,592.9142857,469.5571429,1572.578571,11320.42857,490.7928571,468.65,1760.4,15963.12857,1142.121429,3802.792857,2108.171429,5958.907143,1160.1,378.6428571,2796.114286,10948.6,6584.921429,565.45,461.7071429,12715.08571,389.7142857,109.5642857,3628.078571,10679.68571,1380.607143,770.85,2780.135714,8902.1,650.6,243.6571429,7416.635714,7290.55,828.2,380.1357143,1336.185714,5491.164286,976.3785714,148.3,3385.021429,4686.978571,1181.214286,183.6,3158.342857,672.0428571,273.2857143,140,15.39114779,11.95969073,0.629438928,0.897435897,0.714285714,-0.920478632
+968,12412.32653,679.3605442,465.292517,1070.714286,10464.20408,557.8707483,402.4489796,1506.013605,6004.517007,443.5102041,352.0204082,1769.714286,8596.401361,1058.952381,3522.904762,2275.836735,3206.401361,1073.292517,353.2517007,2440.959184,5755.217687,4318.122449,1447.727891,454.7891156,6646.911565,397.2857143,110.4013605,4906.727891,5813.782313,1282.14966,819.9319728,2792.836735,4787.993197,576.3945578,233.8843537,14624.01361,3859.489796,707.6734694,372.6394558,1335.544218,2814.795918,1134.217687,148.244898,4313.605442,2414.727891,1109.054422,170.7755102,3166.326531,810.0544218,273.8367347,147,14.48303722,13.13246488,0.421672959,0.954545455,0.7,0.09484718
+969,31315.25,839.75,585.3977273,1105.102273,28933.98864,684.5340909,654.7272727,1595.738636,15946.45455,585.4431818,762.3636364,1802.920455,22092.48864,1253.590909,5599.363636,5143.647727,8023.136364,1354.306818,390.8295455,2558.818182,16323.43182,423.4318182,730.6590909,682.9886364,19103.28409,471.2954545,174.8295455,4871.477273,15418.45455,1585.011364,933.8977273,2819.568182,13087.18182,604.7045455,294.5113636,2361.022727,10186.96591,1262.352273,450.9204545,1322.443182,8068.306818,881.2613636,180.1022727,8562.045455,6745.556818,1335.943182,238.3181818,3258.579545,319.7727273,274.5113636,88,12.44842515,9.526471194,0.643703231,0.926315789,0.523809524,-0.110692146
+970,29902.86614,925.2047244,503.3149606,1096.228346,27060.2126,750.6692913,560.015748,1590.637795,14756.83465,598.8582677,460.8818898,1767.433071,21247.16535,1382.519685,3939.913386,4159.267717,7594.755906,1422.086614,453.519685,2433.133858,14190.8189,422.5511811,1246.661417,463.4566929,17072.2126,444.5433071,137.2992126,2507.275591,13518.8189,1628.76378,1016.15748,2818.346457,11234.73228,645.3700787,306.6141732,2032.464567,9160.582677,889.9606299,480.0551181,1344.748031,7146.417323,921.6850394,187.2677165,2988.496063,5705.677165,1453.566929,1707.149606,3191.275591,369.1968504,274.023622,127,14.82543482,11.59091052,0.623496667,0.907142857,0.755952381,-1.458396764
+971,23707.0892,827.7089202,507.4882629,1097.192488,20716.99531,682.0234742,915.629108,1582.821596,11637.70423,545.9295775,1737.920188,1839.309859,16431.66667,1253.239437,5687.014085,3596.619718,5701.122066,1231.86385,362.2394366,4707.455399,11058.32394,1853.389671,206.8779343,1441.920188,12540.06573,435.6150235,145.3333333,3652.206573,10638.12207,2233.549296,769.7887324,2811.15493,8835.061033,621.1502347,274.9812207,7066.2723,6927.107981,1155.394366,432.1737089,1348.084507,5202.746479,660.9765258,169.1690141,4617.107981,4371.28169,1244.962441,687.8826291,3262.788732,569.971831,277.0657277,213,23.51000718,11.84824219,0.863723544,0.922077922,0.560526316,0.792025027
+972,22619,729.8990826,478.1100917,1070.550459,20093.92661,620.6880734,568.6605505,1651.46789,11563.89908,504.8807339,491.4036697,1831.880734,15954.01835,1163.642202,5815.93578,3742.513761,5884.633028,1165.440367,353.8715596,2644.46789,10865.3945,3070.073394,118.4311927,479.2018349,12692.36697,413.3577982,112.1376147,6994.33945,10502.33945,1354.798165,1136.614679,2771.963303,8797.412844,555.3577982,242.0917431,8109.073394,7068.697248,877.9633028,377.9633028,1302.082569,5376.504587,636.2568807,150.1834862,3213.706422,4535.330275,1198.788991,158.587156,3164.311927,637.9449541,273.6605505,109,12.76401763,11.03932318,0.501981423,0.939655172,0.644970414,-0.668541769
+973,18711.69394,749.569697,539.5121212,1103.663636,16413.35758,614.9242424,550.969697,1644.336364,9036.272727,477.6363636,677.3848485,1777.693939,13083.85152,1160.215152,3827.848485,2437.257576,4764.563636,1169.972727,357.1272727,2651.872727,8642.2,2086.515152,215.9363636,1033.833333,10364.03333,409.2666667,119.9909091,4100.421212,8640.918182,1388.154545,789.2878788,2798.257576,7005.527273,591.0060606,269.8121212,18188.3303,5626.524242,1066.112121,394.5787879,1338.027273,4050.363636,743.5727273,156.8030303,6090.287879,3551.90303,1187.590909,391.8757576,3202.806061,888.530303,279.3424242,330,24.19519521,17.870204,0.674160557,0.934844193,0.681818182,0.774088967
+974,24134.55372,851.1983471,493.8347107,1074.826446,22259.94215,699.6942149,691.9752066,1493.479339,11914.49587,555.4628099,581.8181818,1745.53719,17267.33058,1352.256198,4392.347107,2030.495868,6187.652893,1329.801653,408.6198347,2447.479339,11335.86777,570.6198347,643.6363636,576.5867769,13238.46281,457.9586777,123.8181818,2153.479339,10548.6281,1503.983471,832.5619835,2788.942149,8856.859504,896.8760331,277.3966942,3809.421488,7393.677686,889.1900826,442.5371901,1359.446281,5811.280992,791.2561983,176.7438017,2668.752066,4705.85124,1364.016529,2720.157025,3177.181818,490.6033058,276.0165289,121,15.1112381,10.40046024,0.725464139,0.9453125,0.630208333,0.257462799
+975,27771,749.1456311,454.9223301,1067.135922,24165.41748,613.5631068,1093.446602,1606.38835,13789.21359,526.5339806,1583.84466,1843.058252,19003.43689,1189.563107,6009.543689,3381.446602,7000.631068,1196.475728,356.9417476,5204.320388,13026.81553,3346.679612,113.815534,682.038835,15210.23301,404.4951456,110.5242718,3877.038835,12697.91262,1784.252427,773.7864078,2790.398058,10651.31068,632.7572816,256.8932039,3975.067961,8483.320388,1159.184466,390.0776699,1310.106796,6290.320388,620.0194175,163.9320388,3549.223301,5432.553398,1201.708738,242.8058252,3210.165049,618.2621359,276.4368932,103,15.64115308,8.780876281,0.827547493,0.903508772,0.64375,-0.171923722
+976,22608.86111,749.6851852,530.5648148,1087.333333,19758.69444,606.0555556,496.3055556,1791.231481,10416.28704,475.6574074,638,1864.203704,15275.35185,1135.490741,5809.101852,4396.324074,5497.712963,1145.175926,347.4444444,3894.62037,9759.287037,1995.166667,125.3240741,858.3518519,11749.22222,648.8240741,119.8148148,5238.898148,9691.657407,1405.953704,1111.037037,2782.555556,7997.425926,545.7314815,267.7407407,22009.75926,6224.222222,932.9907407,385.2685185,1332.546296,4216.972222,712.6388889,152.9351852,5168.259259,3760.296296,1158.175926,225.462963,3213.416667,918.5092593,275.6944444,108,13.73441998,10.43232821,0.650419202,0.923076923,0.642857143,-0.709055203
+977,22437.2126,753.5826772,532.2283465,1180.716535,18458.25984,591.7795276,444.5984252,1833.874016,9481.448819,468.2204724,451.6299213,1798.645669,14625.26772,1133.582677,5009.370079,3346.913386,5333.629921,1157.787402,348.0629921,2643.094488,9408.055118,3593.574803,165.5826772,491.3149606,11309.55906,410.3228346,118.7322835,5966.897638,9421.708661,1341.212598,1071.330709,2914.480315,7748.188976,541.7244094,251.8818898,15955.96063,5895.244094,757.2283465,385.4724409,1333.488189,3816.440945,922.2598425,147.8976378,5153.094488,3525.559055,1123.015748,195.1811024,3143.11811,971.3228346,277.0551181,127,14.89229593,11.17925756,0.660672935,0.976923077,0.610576923,-0.476683854
+978,31692.61364,930.1818182,697.9886364,1174.193182,27709.21591,718.5795455,796.2727273,1821.818182,14494.05682,595.2840909,780.5340909,1898.977273,20441.32955,1306.227273,10983.98864,4574.272727,7351.352273,1343.090909,421.1704545,3321.818182,14475.34091,404.7386364,1705.5,1185.409091,16912.35227,453.1931818,133.7045455,7297.409091,12864.46591,1943.181818,683.9772727,2834.488636,10484.75,569.8977273,303.7727273,4118.886364,6859.909091,936.1477273,430.0454545,1342.613636,5839.704545,1013.545455,165.6704545,3303.852273,4190.363636,1246.590909,379.6022727,3353.590909,223.0454545,274.625,88,12.98997265,9.267504713,0.700721134,0.871287129,0.698412698,-1.380825612
+979,40131.2803,1054.386364,557.2045455,1160.19697,34883.74242,810.6666667,559.6515152,1660.257576,19386.11364,656.9166667,528.0530303,1751.128788,27685.18939,1464.931818,5862.340909,4343.242424,9554.924242,1439.780303,421.3484848,2434.287879,17600.2803,439.8484848,417.4242424,468.0681818,20502.53788,490.3257576,134.9166667,3844.257576,16822.34848,1710.765152,964.6969697,2799.325758,13735.01515,643.5606061,311.9166667,1907.113636,11319.41667,964.469697,462.2878788,1315.378788,8492.80303,725.6287879,181.5075758,3443.30303,6859.143939,1389.833333,199.2272727,3396.174242,464.1742424,277.9848485,132,19.27908831,9.332740285,0.875020324,0.910344828,0.485294118,-0.660811465
+980,27658.54359,895.1487179,522.5948718,1071.451282,24275.34359,685.6461538,673.4461538,1470.676923,13438.95385,579.0461538,826.6358974,1768.271795,19403.31282,1311.45641,5619.851282,2394.169231,6749.097436,1307.389744,384.3435897,2735.620513,13482.6359,769.2871795,259.974359,868.5384615,15246.20513,401.7692308,122.4153846,3285.830769,12787.4,1685.779487,743.1846154,2803.810256,10835.10256,677.9538462,278.7230769,3436.379487,8678.374359,841.2871795,425.6666667,1334.784615,6398.338462,670.2410256,171.8512821,2732.861538,5530.558974,1274.964103,542.9179487,3229.471795,509.6358974,279.7435897,195,17.92555958,14.06263324,0.620126577,0.9375,0.637254902,-0.713425817
+981,20470.55085,735.279661,512.1101695,1080.440678,17511.9661,584.3135593,442.4576271,1644.432203,10349.5,478.2542373,562.2966102,1824.474576,14251.88136,1133.279661,6382.483051,3849.016949,5190.805085,1155.720339,349.8813559,3117.805085,9384.661017,2407.711864,126.4576271,462.7542373,11003.68644,394.7627119,113.3389831,6499.864407,9352.940678,1370.949153,888.3644068,2771.330508,7623.118644,537.4745763,262.8813559,18211.64407,6186.644068,827.0338983,380.1694915,1305.40678,4717.423729,812.9745763,153.7457627,4149.110169,4025.711864,1164.466102,192.6779661,3200.508475,765.7711864,277.1440678,118,16.24303203,9.669674567,0.803494509,0.900763359,0.605128205,1.040862698
+982,34778.42157,1029.421569,601.627451,1142.5,31871.04902,773.3529412,1086.72549,1685.421569,18280.7451,655.8137255,1338.166667,1857.882353,24760.43137,1383.127451,6453.372549,4198.303922,9630.872549,1494.323529,437.4901961,2770.823529,18373.2549,540.2745098,257.0686275,1496.401961,20302.58824,875.2254902,170.4607843,3356.539216,16363.4902,2133.990196,855.4215686,2831.656863,13978.7451,644.0098039,310.3431373,1768.941176,11114.77451,1180.558824,475.1568627,1328.245098,8630.509804,719.0490196,188.4607843,4096.009804,7091.745098,1380.882353,246.1176471,3432.803922,329.6960784,277.2058824,102,14.40236685,9.354879722,0.760329417,0.944444444,0.607142857,-0.933338892
+983,22045.73333,1231.277778,630.1,1090.566667,19275.72222,786.4333333,684.8111111,1492.511111,10628.12222,653.7444444,994.3777778,1804.544444,15164.2,1363.855556,4436.011111,2910.7,5793.344444,1361.388889,395.6,2421.733333,10409.62222,396.6111111,1217.7,481.8222222,11994.56667,453.7444444,124.4888889,2744.344444,10276.62222,1650.833333,933.4666667,2803.711111,8686.8,683.4666667,261.6111111,1812.788889,6879.211111,1148.744444,415.8666667,1368.644444,5352.255556,1179.433333,167.8333333,3166.222222,4679.155556,1265.766667,196.0666667,3579.466667,394.6666667,276.8555556,90,15.05214619,8.831079024,0.809805094,0.796460177,0.545454545,1.360439583
+984,42587.31538,1009.230769,582.3076923,1146.676923,39495.07692,802.8846154,731.7384615,1710.430769,21428.10769,661.4923077,688.1230769,1917.861538,30458.42308,1527.484615,5516.261538,4741.307692,11274.42308,1526.515385,448.3846154,2475.215385,18838.26154,444.2230769,381.3769231,1093.738462,22260.41538,463.0538462,142.9769231,3242.576923,18204.56154,1741.976923,961.4615385,2835.038462,15442.59231,700.8307692,308.3538462,2321.415385,12735.07692,985.6923077,498.0846154,1327.323077,9611.892308,748.3384615,190.7923077,4300.184615,8127.123077,1515.576923,368.6153846,3268.830769,410.2307692,276.6846154,130,17.39938394,10.96789912,0.776301855,0.802469136,0.637254902,-1.210062552
+985,40330.68,973.37,519.04,1113.38,35503.03,747.32,819.11,1630.28,19149.78,622.6,910.48,1871.83,27605.14,1396.26,4394.29,3731.85,9928.43,1416.64,413.45,2477.52,19411.51,431.97,352.82,953.95,22678.66,478.9,135.87,3618.04,18715.1,1796.87,928.14,2807.22,15731.82,634.71,311.3,1930.99,12714.88,933.24,483.1,1334.64,9542.81,728.77,177.53,2379.51,8275.92,1407.12,176.51,3359.4,421.07,279.52,100,19.15943292,6.941997563,0.932050683,0.909090909,0.446428571,-0.722401683
+986,35545.07527,872.2150538,535.0322581,1107.236559,31226.94624,709.6989247,755.6236559,1564.698925,16633.54839,588.4731183,782.1397849,1792.172043,23937.41935,1381.053763,7307.870968,3596.709677,8908.731183,1384.397849,409,2520.795699,17550.52688,421.516129,394.8709677,849.0860215,20216.65591,624.9032258,133.7741935,3702.913978,16074.46237,1893.526882,932.9462366,2809.817204,13369.84946,629.7204301,301.5268817,2166.354839,11116.08602,1082.11828,479,1321.075269,8640.645161,737.8064516,186.3978495,5571.806452,7096.989247,1412.268817,159.3010753,3337.075269,444.0860215,278.5376344,93,14.1115975,8.690078142,0.787893844,0.93,0.550295858,0.725546412
+987,32452.9469,917.699115,527.6946903,1103.261062,29732.00885,756.9424779,600,1578.70354,16380.89381,602.7035398,506.4070796,1752.411504,23834.89381,1418.579646,4726.880531,3757.570796,8420.982301,1393.10177,417.3185841,2464.699115,15192.37611,422.4159292,1147.566372,533.0088496,17484.0708,429.7699115,132.5265487,3380.221239,14526.78761,1589.632743,857.9026549,2806.446903,12143.81416,688.7654867,291.0044248,1995.862832,10008.11504,914.1150442,468.7035398,1348.557522,7585.911504,931.2654867,180.7522124,4037.128319,6332.774336,1399.853982,813.9778761,3228.035398,477.8761062,280.5840708,226,19.13582217,15.37989839,0.595003788,0.914979757,0.664705882,1.330450117
+988,24110.15,789.21,616.2,1141.39,21522.45,644.44,685.59,1701.86,11993.45,523.59,834.65,1812.66,16403.73,1217.87,4635.09,3867.97,6060.97,1209.94,363.51,3465.2,11318.43,1896.15,116.38,583.99,13047.25,421.13,112.72,5901.26,10672.53,1490.31,896.8,2806.7,8962.86,586.13,251.77,8200.05,7296.09,1205.07,401.57,1320.76,5479.04,692.3,154.09,3601.78,4662.13,1222.53,152,3218.05,659.9,276.78,100,12.63024542,10.93354932,0.500625373,0.862068966,0.699300699,-1.561991601
+989,28702.58491,871.2264151,884.8396226,1183.669811,24626.85849,686.3679245,1039.556604,1964.462264,11880.03774,499.0849057,487.8773585,1870.415094,18372.33019,1221.150943,2693.556604,2284.877358,6741.943396,1293.122642,379.6698113,2508.056604,12380.48113,1104.349057,130.3584906,448.3679245,14954.9434,482.3490566,125.4433962,3086.283019,12530.5566,1485.90566,868.5943396,2831.198113,10236.20755,575.3962264,275.8301887,10601.45283,7499.40566,1037.122642,418.6415094,1337.962264,4815.971698,662.3773585,160.8018868,3665.896226,4436.867925,1216.745283,171.4150943,3264.716981,992.9716981,277.6226415,106,12.98775969,10.64205368,0.57323499,0.929824561,0.679487179,0.948982836
+990,51987.59172,1004.319527,611.2485207,1213.39645,40785.21302,726.7337278,565.7278107,1748.467456,21261.52663,600.0236686,456.2307692,1772.106509,30069.10651,1325.804734,6517.822485,4943.272189,11374.76331,1414.183432,423.5029586,2401.514793,21855.14201,418.8461538,246.260355,431.0828402,26200.40828,418.3313609,139.7514793,6423.278107,21064.0355,1526.248521,923.1952663,2833.029586,17859.16568,616.5857988,325.6745562,1891.846154,12924.84615,878.3668639,481.4674556,1303.869822,10695.18343,691.4556213,184.0946746,2612.893491,8085.065089,1389.455621,131.6390533,3338.852071,249.0177515,279.0532544,169,19.83169362,11.3274143,0.820826674,0.908602151,0.592982456,-1.119109704
+991,39370.17333,1045.706667,575.8133333,1107.293333,35703.21333,792.24,1091.066667,1614.24,19755.64,662.2933333,1795.653333,1889.466667,26635.16,1396.186667,6749.706667,4527.56,9781.88,1403.906667,411.1866667,2495.32,19695.16,430.7733333,154.64,2061.613333,23023.18667,484.1866667,145.3733333,2911.16,18713.74667,2625.213333,772.2133333,2816.706667,15554.22667,622.2533333,317.4133333,1633.266667,12332.02667,1617.68,462.28,1318.64,9680.72,666.12,180.2933333,2987.28,7995.88,1373.133333,180.6,3456.56,303.6266667,277.6133333,75,10.25838507,9.644859438,0.340642865,0.925925926,0.619834711,-1.39555507
+992,22543.87037,705.8395062,463.2283951,1047.814815,19622.54938,596.6049383,656.3950617,1571.691358,11293.83333,472.4012346,673.5246914,1787.080247,15903.7963,1144.623457,7540.283951,3192.166667,5805.271605,1147.432099,339.4506173,3544.62963,10736.5,7142.018519,126.345679,502.7469136,12561.64198,419.9135802,111.462963,7219.333333,10373.2037,1491.333333,1001.018519,2779.302469,8744.246914,599.0555556,246.6790123,6092.777778,7085.895062,918.2222222,371.962963,1300.567901,5237.518519,629.5679012,151.537037,3683.179012,4459.283951,1170.888889,170.8950617,3187.574074,627.1481481,281.9259259,162,15.81993717,13.76188199,0.493214905,0.885245902,0.595588235,-0.470894001
+993,19654.33333,763.5490196,539.4901961,1066.973856,17619.03268,626.1633987,740.1699346,1693.385621,10029.07843,509.2941176,1552.627451,1860.751634,14167.00654,1197.490196,9042.424837,4534.385621,5216.849673,1201.058824,355.3006536,6461.640523,9739.189542,999.5882353,104.4836601,1331.686275,11327.36601,555.8562092,114.1764706,10615.18954,9380.823529,1698.816993,1045.875817,2787.686275,7979.555556,565.5555556,271.0915033,18361.29412,6432.333333,1459.339869,386.1960784,1356.542484,4932.54902,699.130719,160.3333333,5709.699346,4207.712418,1195.928105,243.9869281,3181.614379,644.8431373,280.4379085,153,21.64688473,9.444859296,0.899794015,0.889534884,0.5625,-0.750441935
+994,15758.16667,707.7916667,486.375,1071.291667,13705.16667,571.5729167,568.25,1590.625,7726.40625,597.7083333,392.75,1816.114583,10694.71875,1092.583333,5349.15625,2567.583333,3927.114583,1112.0625,469.15625,2508.833333,7237.84375,2663.416667,1343.666667,424.6666667,8398.760417,378.84375,109.8125,5833.458333,7060.895833,1304.3125,714.625,2777.552083,5903.25,645.5416667,251.2291667,23908.35417,4885.03125,708.25,377.2395833,1372.552083,3699.90625,1148.354167,150.125,4986.635417,3158.104167,1139.65625,163.1458333,3179.0625,731.1666667,278.2916667,96,12.24837338,10.10800643,0.564763266,0.96,0.671328671,-1.416254473
+995,21244.08163,778.2517007,493.8027211,1095.510204,18671.72109,634.0544218,474.8571429,1658.142857,10120.01361,509.2993197,408.7006803,1824.503401,14341.2585,1221.70068,5073.836735,2325.789116,5168.292517,1219.197279,452.2380952,2488.557823,9562.693878,6385.272109,615.1972789,480.2040816,11118.81633,438.0408163,113.1496599,5989.92517,9314.632653,1443.789116,794.2993197,2790.959184,7656.306122,682.1836735,260.1836735,7851.965986,6326.326531,774.6802721,385.9251701,1336.85034,4846.721088,864.3401361,150.4285714,3052.714286,4012.673469,1217.360544,192.4489796,3144.809524,693.8367347,280.7278912,147,16.11383826,12.69038854,0.616255896,0.913043478,0.65625,0.278500552
+996,18468.00606,729.6484848,512.0545455,1094.333333,15812.79394,599.9151515,423.4,1587.442424,9104.642424,468.6424242,371.8181818,1784.981818,12759.78788,1119.521212,4184.684848,2213.527273,4682.345455,1157.375758,368.3818182,2442.854545,8439.151515,4852.284848,492.3575758,425.1272727,9722.218182,396.6666667,111.3575758,5101.945455,8388.454545,1292.854545,759.230303,2780.393939,6710.272727,582.7272727,251.2545455,16657.33939,5460.084848,736.430303,380.369697,1354.812121,4156.327273,795.0121212,148.8909091,3318.181818,3470.684848,1158.915152,177.0121212,3203.848485,784.6545455,281.4424242,165,15.42870595,13.72694196,0.456542814,0.93220339,0.6875,-0.349923069
+997,23922.6993,853.2447552,729.2867133,1171.468531,20380.58741,679.7692308,723.5384615,1794.230769,11770.62937,513.4125874,434.2377622,1880.664336,16582.85315,1264.524476,4283.804196,2292.958042,5971.405594,1300.685315,380.027972,2474.258741,11043.1958,634.5524476,423.5104895,445.4125874,13195.9021,437.5594406,125.5034965,4720.601399,11148.1958,1387.160839,675.1888112,2837.076923,9161.762238,635.5034965,282.4335664,12265.82517,7245.167832,954.7342657,424.2797203,1346,5265.041958,967.8181818,158.979021,2975.293706,4603.237762,1269.727273,152.2867133,3300.223776,849.2797203,279.6083916,143,16.52546053,11.30446628,0.729422353,0.959731544,0.733333333,-1.042511921
+998,55088.85185,1026.351852,588.7222222,1197.481481,49264.07407,820.8518519,825.2777778,1822.981481,27062.35185,685.4259259,451.6481481,1770.796296,37373.03704,1458.888889,5566.407407,4115.462963,13855.64815,1564.425926,453.2592593,2439.944444,26623.96296,474.8888889,758.8888889,458.6296296,32298.27778,464.8148148,146.5,3828.314815,25701.48148,1641.555556,1076.62963,2817.555556,21672.22222,650.1111111,348.6666667,2264.444444,16358.98148,957.1851852,524.9814815,1310.462963,13125.62963,861.5925926,194.7592593,2400.888889,10239.03704,1508.37037,157.7777778,3303.814815,264.2037037,279.1666667,54,9.007866785,7.782337899,0.503579238,0.931034483,0.6,-0.253057152
+999,59970.19872,1183.346154,675.474359,1233.096154,54859.25641,904.3461538,1017.570513,1890.198718,31007.58333,743.5064103,1133.153846,1829.051282,44876.87821,1689.326923,7037.910256,4874.019231,15909.85256,1742.282051,514.3205128,2488.570513,29648.58974,530.2820513,264.3525641,584.3461538,35823.48718,588.0320513,342.6858974,5564.679487,28170.47436,2215.858974,998.9679487,2844.891026,24035.6859,826.6089744,376.4423077,2141.237179,18796.86538,1293.352564,567.5641026,1334.865385,15027.50641,776.1538462,208.1474359,3048.769231,11657.58333,1630.198718,621.4679487,3554.679487,345.4487179,281.8589744,156,15.61882224,14.25409703,0.408802137,0.861878453,0.696428571,-1.165141576
+1000,19911.42857,1083.84127,512.4285714,1063.968254,16843.66667,745.6507937,563.4920635,1496.761905,8931.492063,586.2063492,481.7619048,1785.349206,11669.69841,1288.174603,2283,1357.698413,4009.777778,1134.126984,339.5079365,2436.15873,6997.714286,2426.793651,720.2380952,467.4126984,7936.666667,345.9206349,106.0793651,3067.52381,6746.126984,1318.285714,712.4761905,2774.206349,5684.730159,508.2539683,221.1428571,1938.428571,4542.380952,709.1904762,365.5873016,1319.968254,3407,775.6507937,148.7936508,1434.746032,2799.888889,1068.507937,208.2380952,3290.31746,522.6031746,278.8095238,63,10.65762651,7.799921892,0.681451858,0.940298507,0.715909091,1.39769063
+1001,22846.54651,743.9186047,471.1744186,1104.360465,19140.13953,614.244186,413.9069767,1713.511628,11288.45349,519.9069767,382.0697674,1841.209302,16095.01163,1153.569767,4192.430233,2714.5,5760.662791,1165.569767,398.7093023,2458.104651,10657.62791,8159.802326,386.5465116,432.755814,12536.15116,423.0930233,113.5348837,5177.860465,10779.40698,1314.790698,935.3023256,2788.686047,8927.686047,735.2906977,259.4069767,14296.12791,7289.953488,729.4883721,384.372093,1329.116279,5461.476744,758.6744186,146.1976744,3274.069767,4650.034884,1173.918605,123.8953488,3149.127907,707.755814,279.2906977,86,12.8955779,8.537349204,0.749471188,0.955555556,0.796296296,1.391497732
+1002,23954.03125,766.2421875,511.96875,1097.210938,20395.32813,616.1015625,570.0546875,1754.59375,9831.328125,471.1640625,422.6015625,1810.328125,15878.83594,1135.835938,4194.71875,2798.929688,5951.0625,1192.398438,367.2734375,2458.882813,10474.15625,3885.679688,1560.226563,446,12877.51563,427.8828125,117.2578125,4810.382813,10612.78125,1424.734375,887.7265625,2801.648438,8683.609375,585.359375,262.296875,15242.76563,6534.992188,809.265625,390.8203125,1355.375,3911.398438,1054.960938,155.703125,5302.460938,3760.265625,1152.679688,252.84375,3334.609375,1022.390625,284.3515625,128,16.38329158,10.71418739,0.756520155,0.941176471,0.62745098,-0.186200565
+1003,22924.27083,796.3958333,567.3854167,1122.265625,18533.96875,622.8125,573.4895833,1711.953125,9172.369792,474,418.1197917,1766.505208,15259.04688,1197.40625,4125.739583,2189.385417,5542.322917,1205.9375,376.0260417,2424.515625,9958.057292,3285.984375,879.1979167,443.8072917,12358.76563,430.4479167,124.1041667,4159.895833,10173.34896,1402.760417,946.484375,2800.708333,8174.854167,717.1822917,275.7291667,17319.84375,6193.65625,864.453125,404.6614583,1364.234375,3650.260417,877.3333333,160.234375,6470.625,3538.802083,1206.713542,263.7135417,3200.791667,1033.010417,284.2760417,192,19.24918915,13.91633802,0.69089292,0.893023256,0.64,0.001624538
+1004,24041.33333,934.5263158,561.1754386,1115.649123,22005.5614,709.6666667,736.2280702,1619.22807,11459.68421,588.6315789,873.0877193,1850.45614,15191.22807,1313.912281,5788.964912,3036.473684,6018.438596,1309.105263,382.6842105,3723.350877,11307.73684,396.6491228,519.4035088,1666.368421,13014.54386,439.2982456,126.7894737,3189.403509,10271.7193,1849.631579,728.9824561,2848.929825,8731.368421,729.9473684,281.9122807,5574.438596,6758.105263,1040.684211,435.8596491,1360.22807,5665.666667,729.3157895,173.877193,3829.105263,4294.754386,1282.666667,473.0350877,3402.473684,287.3333333,281.3684211,57,11.17172348,7.442003926,0.745820963,0.850746269,0.475,-0.35177411
+1005,42785.68085,1115.553191,657,1161.765957,38069.56383,813.9468085,979.2340426,1715.744681,22221.82979,700.8404255,938.9255319,1808.255319,29476.51064,1455.148936,6816.43617,5371.12766,11527.96809,1528.010638,481.393617,2907.159574,21892.75532,563.2765957,242.6702128,843.1489362,22927.69149,1131.787234,146.5212766,4371.031915,18773.28723,1822.521277,1063.042553,2821.340426,16104.52128,642.8617021,326.9680851,2352.531915,12683.08511,1168.606383,486.2553191,1330.457447,9619.553191,691.712766,187.4361702,6004.787234,7750.255319,1431.297872,270.7021277,3498.031915,334.0212766,284.4255319,94,16.49703152,7.784795679,0.88165706,0.94,0.534090909,-0.492550629
+1006,52935.73333,996.0666667,529.3777778,1159.133333,44907.02222,805.4444444,690.2,1725.311111,24956.8,676.3777778,488.4222222,1780.733333,35066.6,1479.555556,4053.355556,2929.822222,12203.97778,1513.155556,448.5555556,2439.488889,23700.77778,459.2444444,308.9111111,456.3555556,27331.8,481.3111111,145.1777778,3066.688889,23159.75556,1599.044444,825.3777778,2803.822222,19283.93333,676.7777778,326.2666667,1888.444444,15513.17778,1009.888889,500.7333333,1310.177778,11492.53333,948.8222222,188.8222222,3032.644444,9957.111111,1478.333333,150.1333333,3374.511111,430.4,279.3111111,45,8.624086603,6.935002961,0.594435256,0.882352941,0.5625,-1.149168749
+1007,23788.65152,1054.55303,557.7651515,1096.484848,20138.46212,742.5,540.3636364,1547.962121,10842.80303,601.4318182,456.2878788,1759.712121,14952.81061,1315.159091,4455.098485,3540.416667,5156.469697,1297.924242,387.5681818,2491.075758,9960.757576,435.75,1674.840909,466.0606061,11291.56061,452.6590909,125.4772727,4943.628788,9272.401515,1547.818182,795.5378788,2812.666667,7587.80303,574.8636364,256.9166667,2575.515152,5874.954545,812.1818182,417.7424242,1317.416667,4461.257576,890.5075758,155.3712121,1978.590909,3669.583333,1170.568182,204.2575758,3453.939394,540.2727273,282.4166667,132,14.40538049,11.76675598,0.576877566,0.970588235,0.733333333,-0.260922183
+1008,21477.5,730.0555556,545.7986111,1087.020833,18553.06944,607.7569444,597.5763889,1846.4375,9812.909722,463.5138889,428.875,1844.506944,15153.42361,1123.791667,5440.333333,3458.326389,5550.479167,1147.729167,350.1805556,2531.6875,9746.847222,4087.756944,326,458.7569444,11731.99306,406.4166667,116.6180556,6639.361111,9787.388889,1354.833333,900.4166667,2815.034722,7999.666667,521.6388889,268.3125,23285.55556,6172.715278,763.0902778,384.375,1331.506944,4066.5625,725.7430556,159.9444444,5264.673611,3762.465278,1130.041667,208.3888889,3153.958333,955.4722222,281.8680556,144,16.60513852,11.16943407,0.739961471,0.947368421,0.705882353,1.427561356
+1009,41477.41176,995.1911765,616.5294118,1143.911765,37124.08824,783.0882353,555.5147059,1737.985294,20463.57353,645.5882353,639.6911765,1847.676471,27987.01471,1404.426471,6695.808824,4284.970588,9956.985294,1439.411765,419.6617647,2458,20071.91176,454.9264706,255.8823529,522.0735294,23369.33824,463.7941176,133.6029412,3910.029412,19012.10294,1718.205882,957.5588235,2819.705882,15863.25,639.0441176,316.9705882,2277.044118,12340.80882,1028.279412,486.0294118,1325.073529,9501.602941,714.1764706,185.9705882,5351.411765,8074.161765,1417.308824,167.8529412,3378.588235,312.3676471,281.2205882,68,12.26783032,7.575136454,0.786586799,0.906666667,0.581196581,-1.36953611
+1010,41907.88679,869.0377358,485.3584906,1079.773585,35935.32075,719.7735849,657.9811321,1593.886792,19823.09434,600,535.5283019,1769.792453,28241.18868,1357.377358,4492.90566,2623.075472,10367.15094,1422.301887,418.0754717,2490.660377,19691.79245,428.3584906,303.1886792,521.8867925,23083.09434,441.2075472,129.1509434,2997.471698,19074.0566,1592.735849,865.5849057,2812.018868,15905.66038,642.1320755,307.6981132,2013.679245,12950.24528,949.0188679,476.5283019,1317.622642,9590.735849,717.1886792,179.1320755,4381.698113,8310.150943,1406.528302,140.0377358,3289.150943,437.0188679,282.6037736,53,9.108965792,7.939610958,0.490171607,0.913793103,0.535353535,-0.443699376
+1011,28944.45,1007.625,539.65,1078.275,24825.7875,741.1375,604.15,1588.675,13725.0875,633.075,993.6125,1759.475,18872.1625,1334.725,5366.3,4003.2,6715.125,1331.425,383.4,3640.05,12393.0375,444.1,126.4375,753.825,14507.1875,1139.5375,123.8375,3241.2125,11952.6625,1720.8625,667.875,2798.9625,9902.4375,600.525,284.35,3016.1875,7785.575,1468.5875,436.375,1319.6625,5832.9625,612.925,176.5,2558.3,4716.95,1216.6,509.8375,3387.525,557.2375,281.2375,80,12.16431982,8.498489477,0.715472646,0.952380952,0.615384615,-1.201420345
+1012,15977.95968,762.483871,604.3467742,1114.137097,13807.42742,607.1370968,479.3467742,1758.685484,7830.903226,504.3387097,503.7983871,1887.58871,10746.69355,1174.032258,6888.564516,4918.040323,3927.298387,1154.693548,410.0403226,2945.741935,7113.483871,578.9435484,471.733871,471.5564516,8326.709677,399.4516129,113.6693548,9978.137097,7033.741935,1379.362903,1135.040323,2781.846774,5811.548387,565.8629032,270.8548387,20471.62903,4723.58871,790.016129,379.3870968,1330.669355,3572.112903,959.8387097,152.3306452,5279.137097,3033.427419,1175.604839,201.8709677,3215.032258,756.6370968,283.4435484,124,13.79706139,11.80482513,0.51763044,0.96124031,0.632653061,0.654986576
+1013,16170.83146,732.1235955,526.7303371,1088.022472,13651.2809,590.1011236,504.7865169,1539.94382,7629.191011,459.5955056,419.5730337,1760.550562,11113.42697,1125.134831,2955.94382,1882.359551,4151.966292,1137.876404,365.3595506,2436.505618,7335.955056,1640.146067,1004.067416,499.0786517,8717.325843,405.2022472,113.4157303,1725.842697,7393.573034,1313.921348,1068.707865,2818.617978,6134.337079,571,261.8651685,14892.67416,4859.842697,823.5168539,388.3595506,1325.101124,3492.325843,1013.460674,152.505618,4840.696629,3023.561798,1149.831461,203.0337079,3145.067416,875.752809,283.1348315,89,13.85652485,8.275324848,0.802081176,0.946808511,0.674242424,0.703662606
+1014,25334.02837,757.2695035,499.7304965,1088.141844,21224.36879,616.1985816,723.212766,1671.496454,12088.66667,479.9007092,1668.673759,1813.815603,17646.57447,1166.092199,5848.822695,4314.035461,6401.70922,1157.652482,360.7730496,4889.297872,11520.66667,1720.177305,121.3191489,1147.156028,13916.29078,422.4255319,119.7163121,5839.64539,11557.98582,1566.333333,913.3333333,2794.695035,9446.609929,891.1985816,278.177305,17339.97872,7528.411348,1233.865248,398.6241135,1363.730496,5295.375887,780.8085106,158.9219858,4444.404255,4672.87234,1178.212766,227.964539,3178.723404,905.4255319,284.5248227,141,16.12464249,11.24502154,0.716700459,0.946308725,0.629464286,-0.664990028
+1015,20344.7706,749.0668151,454.1358575,1092.020045,16437.77951,596.142539,580.9643653,1636.775056,7272.060134,452.7438753,774.2360802,1739.832962,12586.60579,1128.120267,3844.011136,1891.30735,4526.089087,1167.383073,347.2516704,3244.706013,8099.144766,4994.051225,1294.11804,506.0489978,9948.311804,426.3184855,114.2694878,4417.908686,8158.033408,1572.886414,713.8530067,2797.403118,6421.432071,953.311804,248.2516704,11656.06013,4839.207127,923.5746102,370.2739421,1343.768374,2648.064588,923.4454343,150.7884187,4378.873051,2629.844098,1090.296214,246.5902004,3131.610245,1053.062361,288.7104677,449,24.90518929,23.40793936,0.341499353,0.921971253,0.719551282,1.389449747
+1016,40915.11013,950.6784141,669.1497797,1174.911894,26764.74009,630.154185,433.8237885,1687.9163,13853.52863,520.9118943,467.4625551,1774.788546,19576.4978,1222.792952,7515.493392,4313.92511,7306.85022,1224.154185,376.6872247,2455.066079,14315.28634,355.9118943,133.4537445,470.8325991,16846.29956,380.9823789,123.9955947,7497.449339,13151.57269,1393.955947,682.8370044,2821.872247,10899.96916,543.7753304,272.6696035,3306.07489,6884.259912,748.9647577,408.3832599,1291.374449,5905.462555,593.1321586,157.9471366,2403.678414,4402.23348,1152.506608,167.6784141,3195.810573,213.2687225,284.784141,227,25.24535792,11.85206453,0.882945763,0.890196078,0.582051282,-1.287839607
+1017,43460.12,1023.146667,618.9866667,1151.813333,40237.10667,819.7466667,740.8933333,1770.28,21149.05333,658.5733333,841.6933333,1773.933333,31394.38667,1487.08,8315.946667,5479.92,10777.82667,1524,445.96,2457.786667,16019.57333,398.0533333,716.9866667,453.2133333,21363.89333,492.3466667,157.6666667,4449.973333,16424.57333,1824.333333,1041.546667,2848.466667,14023.89333,941.6,311.9466667,2284.066667,11631.25333,1119.72,476.6666667,1319.253333,9278.16,826.7733333,186.52,3431.44,7458.04,1457.32,807.3466667,5173.44,357.5333333,281.9733333,75,11.15881253,8.823363728,0.61219332,0.9375,0.681818182,0.888339512
+1018,12966.3122,675.6780488,442.9341463,1047.356098,11413.70488,563.9804878,379.2585366,1489.770732,6470.758537,584.8829268,394.9731707,1779.641463,8975.35122,1074.382927,4515.773171,2226.014634,3375.719512,1084.060976,475.0682927,2581.729268,6213.131707,922.0829268,920.7926829,456.7195122,7092.546341,351.6097561,106.9609756,4401.92439,6114.463415,1321.378049,696.5829268,2788.390244,5171.702439,746.6414634,237.3195122,13563.2439,4220.246341,703.0219512,359.1,1358.602439,3193.243902,906.4512195,147.0268293,3525.402439,2725.02439,1107.192683,162.7902439,3307.380488,732.9243902,291.2756098,410,32.40926114,18.90570375,0.812226183,0.811881188,0.50617284,-0.816133117
+1019,22485.91949,759.059322,496.3898305,1137.199153,19712.18644,625.9872881,506.8050847,1722.110169,11104.89831,476.220339,393.4915254,1805.088983,15728.95339,1162.957627,3198.110169,2543.970339,5745.881356,1182.288136,367.0762712,2421.644068,10512.8178,884.0974576,580.7838983,467.3686441,12579.39831,397.0127119,115.5550847,3017.864407,10555.47034,1330.084746,776.6864407,2805.330508,8624.902542,570.4152542,258.9067797,12082.99153,6910.855932,837.3855932,398.8686441,1340.084746,5051.347458,965.1144068,157.5635593,3512.605932,4368.508475,1189.610169,159.6694915,3162.262712,864.4194915,287.0974576,236,19.09889367,16.19772877,0.529839791,0.880597015,0.69005848,0.189450413
+1020,22250.27536,1050.188406,512.6376812,1069.956522,20157.76812,723.7826087,535.0434783,1434.014493,10829.75362,617.1449275,475.3913043,1737.275362,16168.04348,1317.666667,2327.376812,2229.768116,5647.753623,1537.942029,412.6956522,2420.942029,10268.31884,395.3913043,1454.130435,467.5942029,13563.18841,449,124.4927536,2940.26087,11156.04348,1570.637681,997.0289855,2808.434783,9456.333333,695.057971,277.5942029,1975.913043,7542.797101,850.115942,448.6521739,1352.956522,6027.666667,951.0724638,183.6811594,4009.666667,5029.463768,1298.681159,254.7681159,3243.855072,370.4637681,283.0869565,69,11.05464613,8.900451082,0.593095447,0.945205479,0.522727273,1.11546721
+1021,16687.09836,965.3934426,546.7786885,1105.04918,15446.27869,762.0163934,726.5163934,1584.745902,8274.598361,609.9098361,692.7868852,1846.803279,12234.97541,1349.196721,5755.008197,2890.770492,4436.606557,1412.688525,445.9672131,2469.393443,7884.991803,397.6311475,3965.696721,668.0819672,9521.836066,558.7131148,134.3032787,3274.581967,7928.327869,2166.688525,959.5901639,2832.008197,6816.172131,1261.786885,278.9918033,1983.237705,5404.885246,1076.844262,446.2704918,1410.92623,4341.647541,1850.106557,176.7459016,4047.245902,3708.106557,1404.508197,278.7786885,3408.754098,390.4590164,285.8688525,122,13.74533217,11.36906229,0.562022882,0.968253968,0.726190476,-0.253951651
+1022,22802.83721,710.1511628,463.9302326,1063.174419,20008.74419,591.3372093,456.872093,1644.255814,11376.46512,465.4302326,588.2209302,1897.965116,15736.75581,1125.813953,5471.686047,3628.337209,5783.790698,1139.523256,339.4069767,3781.302326,10729.22093,3584.674419,105.4651163,671.1046512,12433,415.7790698,109.1162791,7051.94186,10316.56977,1354.44186,1003.604651,2767.790698,8678.604651,563.5232558,246.3604651,4907.27907,7032.906977,879.4767442,380.9651163,1291.372093,5270.418605,621.3604651,138.9302326,2471.895349,4495.174419,1161.290698,144.9418605,3147.895349,652.9186047,285.3023256,86,12.06959404,9.465394526,0.620464284,0.905263158,0.558441558,0.053567147
+1023,18185.2562,711.3526171,504.3415978,1090.972452,15144.91736,576.3884298,553.3278237,1637.415978,8651.438017,463.1184573,421.2093664,1782.490358,12237.44077,1130.876033,5376.184573,3258.071625,4489.22314,1113.082645,333.7272727,2569.931129,8108.848485,2908.62259,452.0055096,445.1763085,9350.008264,385.862259,111.3939394,7139.203857,8136.62259,1364.749311,1049.30854,2786.38843,6598.347107,634.6528926,245.6225895,14203.19008,5352.76584,745.2754821,372.7024793,1318.600551,3960.212121,800.0578512,150.2258953,4625.495868,3340.201102,1121.355372,178.9614325,3158.842975,803.2176309,288.7272727,363,31.52915769,16.34671252,0.855099855,0.864285714,0.585483871,1.40344455
+1024,18546.68317,720.7425743,460.6039604,1067.415842,15790.43564,578.6732673,385.7871287,1642.826733,8930.757426,469.9158416,366.980198,1845.876238,12562.96535,1113.009901,5420.430693,3864.306931,4678.143564,1116.950495,344.8564356,2447.138614,8441.455446,4690.975248,446.2425743,422.1584158,9921.20297,398.9851485,117.1089109,6001.232673,8401.841584,1262.034653,918.6138614,2796.361386,6830.767327,538.1089109,245.7623762,13002.56436,5499.094059,746.2623762,376.3217822,1318.415842,3995.653465,813.7178218,152.2772277,3805.688119,3431.905941,1130.079208,173.1633663,3241.480198,833.6188119,286.009901,202,17.67045071,14.93891922,0.534105048,0.943925234,0.698961938,-0.754997733
+1025,45813.38065,1038.767742,683.4451613,1203.354839,40659.87097,826.1870968,661.0645161,1851.258065,21821.25161,653.6193548,533.2258065,1805.780645,30678.13548,1495.625806,7096.832258,7110.658065,11190.15484,1540.245161,500.1741935,2538.309677,21116.33548,479.4387097,2294.032258,507.2516129,25469.6129,488.6967742,148.7290323,6850.548387,19934.42581,1806.316129,1100.535484,2830.122581,16708.37419,636.7612903,343.5225806,2573.129032,12039.72903,965.4516129,506.3741935,1360.883871,9830.019355,1141.941935,191.7677419,4457.651613,7471.522581,1463.470968,214.5290323,3317.593548,255.5741935,287.8258065,155,16.5929216,12.87951973,0.630479791,0.885714286,0.506535948,-1.225724039
+1026,35838.34483,966.2068966,629.2327586,1116.181034,31228.00862,741.612069,785.8017241,1668.775862,17219.28448,621.1206897,914.6637931,1850.362069,23723.23276,1345.181034,8009.318966,4126.181034,8851.956897,1412.491379,409.2931034,2627.560345,16888.71552,452.0603448,217.2672414,1316.215517,20057.06897,455.887931,130.4137931,4951.387931,16187.68103,1921.965517,833.7844828,2805.775862,13466.35345,632.4137931,296.0344828,2026.741379,10397.07759,1018.698276,458.4310345,1309.008621,8327.362069,700.2327586,176.9137931,4916.422414,6952.482759,1366.474138,211.8965517,3419.387931,296.8189655,285.362069,116,15.48659528,10.09738982,0.758211764,0.899224806,0.568627451,1.430297232
+1027,40827.58537,1086.170732,569.0243902,1164.731707,34966.70732,879.8780488,687.7317073,1736.512195,19473.56098,705.5121951,520.3414634,1815.780488,27910.97561,1658.926829,3789.926829,3619.95122,9509.243902,1575.219512,463.7560976,2434.146341,16802.73171,459.5121951,215.9756098,655.6097561,19090.97561,442.3414634,142.2926829,2312.682927,16044.02439,1649.682927,846.7317073,2807.073171,13516.63415,890.6585366,336.4146341,1935.097561,10797.07317,959.6585366,517.8536585,1342.780488,8082.560976,727.6341463,195.4390244,3272.268293,7071.390244,1588.707317,383.804878,3179.317073,408.4146341,284.5365854,41,9.862745866,5.477487111,0.831602425,0.976190476,0.5125,-0.613067676
+1028,17104.0122,656.2621951,452.0304878,1035.140244,14737.10976,549.7317073,422.7195122,1461.286585,8425.878049,457.4695122,403.5609756,1798.207317,11837.17073,1083.128049,3593.853659,2088.939024,4366.817073,1093.914634,369.5121951,2658.012195,8082.439024,6112.042683,661.1036585,442.4878049,9237.554878,379.4634146,105.7317073,5143.347561,7872.457317,1310.591463,816.2621951,2779.121951,6647.152439,638.652439,226.3414634,3624.554878,5492.615854,729.7987805,357.2621951,1315.237805,4061.445122,796.9207317,140.2743902,2464.70122,3449.762195,1097.359756,142.1158537,3085.743902,672.5182927,286.5060976,164,15.96565579,13.21193782,0.561432698,0.964705882,0.728888889,-0.739161274
+1029,43493.81818,942.8099174,633.1900826,1180.644628,35154.02479,674.2396694,446.785124,1657.289256,18315.61157,555.9834711,469.0578512,1792.719008,25809.21488,1273.049587,8362.636364,4803.363636,9622.041322,1323.785124,412.5454545,2396.53719,18453.95041,382.1322314,645.892562,425.4214876,22101.09091,401.785124,128.0413223,7496.545455,17382.60331,1471.446281,743.446281,2820.504132,14412.94215,576.6033058,291.9008264,3170.181818,9863.206612,823.338843,445.0330579,1309.933884,8462.198347,710.5289256,165.768595,2334.024793,6263.049587,1265.68595,180.0826446,3234.785124,228.1239669,287.8512397,121,14.2629436,11.55661099,0.586078505,0.902985075,0.576190476,-1.241344641
+1030,16069.38947,1013.642105,534.2,1038.736842,14107.70526,668.7157895,512.1578947,1377.473684,7045.989474,587.5263158,603.5473684,1758.252632,10351.34737,1225.178947,4364.894737,3080.726316,3998.252632,1214.136842,365.3157895,2450.284211,7378.978947,355.3578947,649.7368421,526.0842105,8158.094737,403.6736842,118.3894737,3441.084211,6655.989474,1553.568421,833.7263158,2793.821053,5858.031579,619.2947368,233.4842105,1826.726316,4748.915789,836.0421053,390.4421053,1310.884211,3800.578947,729.6,155.1684211,3303.747368,2993.789474,1153.652632,312.3263158,3500.515789,427.1578947,286.7052632,95,15.40934222,8.535079019,0.832589923,0.87962963,0.50802139,1.363967596
+1031,27291.30317,753.5429864,448.3303167,1060.986425,24279.74661,640.7828054,747.3574661,1528.710407,13511.42534,518.361991,1526.085973,1810.895928,19219,1258.746606,5522.58371,3647.778281,6901.60181,1206.049774,344.1493213,3832.289593,13078.88688,3856.285068,160.280543,1084.289593,15446.08145,583.3936652,128.4660633,2985.135747,12651.70588,1701.429864,704.0452489,2802.755656,10629.45701,990.6470588,263.7239819,3842.371041,8545.714932,1194.665158,412.3891403,1317.877828,6388.321267,624.5882353,150.8461538,2786.266968,5469.235294,1238.384615,636.1674208,3191.343891,589.0678733,289.959276,221,20.81558913,14.11988621,0.73475527,0.932489451,0.619047619,0.360568163
+1032,20834.10843,722.2228916,481.7168675,1079.957831,18481.6747,595.3493976,561.060241,1612.825301,10372.21687,488.3192771,390.8012048,1831.909639,14550.75301,1135.240964,5359.572289,2725.012048,5218.849398,1152.680723,353.2831325,2524.825301,9677.783133,2222.373494,394.8253012,445.1325301,11372.99398,380.5240964,111.3795181,6660.253012,9584.192771,1307.542169,856.9156627,2779.361446,7917.987952,641.5843373,250.6204819,12562.68072,6452.379518,746.4518072,373.8072289,1335.753012,4973.46988,786.126506,154.439759,3683.849398,4124.698795,1155.783133,163.6445783,3197.319277,704.1024096,289.5783133,166,16.19289985,14.29908466,0.469285368,0.846938776,0.54248366,-0.931668781
+1033,17277.36283,721.8141593,546.2035398,1101.19469,14613.21239,585.1238938,532.0265487,1660.530973,8042.707965,452.1681416,499.4778761,1795.336283,12118.49558,1128.79646,6577.380531,3335.327434,4377.610619,1109.256637,334.9469027,3032.230088,7990.159292,1756.973451,172.6371681,499.5840708,9776.185841,432.9911504,115.920354,9713.548673,8084.761062,1420.769912,964.2035398,2816.59292,6670.858407,551.7433628,270.4159292,30792.33628,5260.460177,773.3893805,382.3097345,1316.787611,3511.584071,737.9292035,152.079646,5489.283186,3274.557522,1153.539823,198.5840708,3229.823009,927.2831858,287.0088496,113,13.21161983,11.23327379,0.526367586,0.941666667,0.620879121,0.596395947
+1034,31493.37736,1170.377358,533.0849057,1066.95283,30510.83019,886.6415094,802.4716981,1607.839623,14331.5,658.7735849,604.9528302,1691.141509,20454.80189,1427.367925,2409.349057,2089.5,6108.04717,1329.245283,384.7169811,2422.075472,8460.613208,352.1792453,474.8962264,400.0377358,10109.39623,344.5471698,110.2075472,2959.839623,8324.698113,1308.04717,657.4622642,2800.575472,7010.122642,544.2641509,236.0283019,2085.122642,5622.141509,731.9716981,383.9528302,1300.311321,4306.245283,609.0566038,146.4056604,1270.933962,3670.933962,1085.801887,228.3679245,3355.641509,525.7924528,287.1886792,106,13.86508259,10.08692008,0.686102137,0.946428571,0.588888889,-1.232167613
+1035,13989.88312,1169.636364,526.3246753,1018.818182,13534.7013,747.9220779,723.1818182,1352.220779,6770.246753,637.7792208,1157.324675,1757.272727,8301.12987,1258.467532,2958.493506,2030.623377,3252.25974,1179.220779,337.1168831,3113.74026,6191.155844,393.2467532,103.1298701,957.5194805,6552.61039,431.6493506,139.1298701,1648.415584,5298.077922,1657.324675,593.987013,2809.571429,4569.714286,661.1818182,231.987013,2856.883117,3348.597403,911.3896104,373.4025974,1307.727273,2860.844156,555.8051948,147.6753247,1768.61039,2130.415584,1053.87013,504.1558442,3520.831169,564.2207792,286.6623377,77,12.41430206,8.439727906,0.733361304,0.885057471,0.5,-1.03939014
+1036,20767.58,766.4333333,590.6,1118.166667,17786.8,599.62,639.62,1822.486667,8662.173333,467.4533333,437.62,1836.386667,13448.22667,1147.64,4473.973333,2937.586667,4987.58,1162.246667,347.6666667,2457.706667,8801.333333,534.1866667,134.38,460.3,10847.36667,401.6933333,113.8533333,5960.673333,9038.373333,1342.28,932.2666667,2820.893333,7396.06,537.6333333,278.8533333,24282.07333,5578.7,780.66,391.8066667,1332.186667,3526.413333,705.3866667,152.9933333,4736.68,3316.753333,1139.806667,206.08,3178.946667,987.2,287.9666667,150,18.78301369,10.55938535,0.827016685,0.903614458,0.657894737,-1.422305195
+1037,23105.70395,777.1644737,490.9868421,1118.855263,16625.23684,588.75,429.4868421,1704.013158,7007.513158,434.5394737,448.125,1785.842105,12573.83553,1085.256579,5336.414474,2694.671053,4382.315789,1118.065789,335.7631579,2651.657895,7895.618421,906.0789474,1486.078947,465.7828947,9643.914474,409.5855263,117.4407895,6886.592105,7637.144737,1480.638158,669.0065789,2787.703947,6016.598684,594.4407895,237.6118421,9334.815789,4461.815789,865.3552632,371.8092105,1304.835526,2271.690789,983.8223684,145.7434211,4678.618421,2300.684211,1055.730263,232.9868421,3144.467105,1071.190789,289.2960526,152,14.85128621,13.30539292,0.444238714,0.938271605,0.779487179,-0.208092833
+1038,18893.25175,741.9300699,449.1958042,1097.020979,10141.95105,515.041958,539.8951049,1495.461538,4240.174825,411.6993007,624.1818182,1710.468531,7652.51049,1009.314685,5118.825175,2151.818182,2734.867133,1024.433566,307.2027972,3642.335664,4992.412587,6610.048951,228.034965,469.0909091,6060.916084,448.3426573,107.972028,6749.41958,4880.013986,1855.363636,690.9020979,2771.363636,3926.867133,753.0629371,215.2307692,6060.216783,2837.076923,782.7202797,345.013986,1281.776224,1450.307692,593.4125874,134.7412587,3931.706294,1481.06993,956.3916084,204.8671329,3100.699301,1084.076923,290.1888112,143,15.94359649,11.49111625,0.693210153,0.966216216,0.700980392,0.355129482
+1039,34414.54054,898.0135135,603.2702703,1121.216216,29752.82432,684.4594595,707.8513514,1612.162162,17024.55405,584.9324324,918.7432432,1886.418919,24210.21622,1304.283784,7287.027027,5438.635135,8830.121622,1367.040541,410.3918919,2681.972973,16788.06757,608.1621622,779.8648649,624.5135135,20373.85135,1520.391892,132.4459459,6481,15854.2973,1549.337838,969.0135135,2804.702703,13534.44595,624.1216216,287.3378378,1926.351351,10532.17568,1212.905405,454.5810811,1323.243243,8470.783784,800.9054054,179.3243243,7802.472973,7049.297297,1379.459459,305.9054054,3385.662162,320.4054054,288.972973,74,11.38938417,8.521358886,0.663490913,0.925,0.632478632,-0.000716332
+1040,20023.49462,861.4408602,482.1935484,1049.88172,18405.67742,674.5483871,450.172043,1425.032258,9428.580645,561.5376344,432.3548387,1727.27957,13805.43011,1271.16129,3171.602151,1823.032258,5217.903226,1464.236559,373.7956989,2403.612903,9202.580645,373.172043,867.7204301,420.7526882,11229.84946,415.0752688,127.8494624,2049.462366,8853.247312,1450.139785,847.5053763,2818.311828,7600.236559,698.7311828,274.1182796,1627.677419,6362.44086,817.4731183,437.2795699,1352.72043,5168.677419,837.8172043,181.688172,2887.225806,4090.731183,1317.591398,471.5376344,3308.88172,365.5913978,289.7634409,93,13.15748536,9.247025054,0.711391668,0.96875,0.596153846,0.680231978
+1041,14595.575,711.94375,517.19375,1054.2625,12866.5125,588.7,677.89375,1584.0875,7194.9125,478.4125,1012.7875,1800.475,10239.83125,1132.1375,8671.775,3665.71875,3811.50625,1135.63125,337.70625,5661.35625,7072.2625,2029.06875,140.84375,473.88125,8081.9625,399.675,110.4375,8037.58125,6784.7,1539.50625,910.15625,2785.64375,5790.5875,573.69375,248.18125,12579.75625,4728.33125,1104.925,372.4,1313.075,3597.45625,696.275,155.05625,4872.8625,3105.5,1153.70625,251.54375,3174.8125,660.6125,292.375,160,20.0894399,10.89779357,0.840079189,0.924855491,0.701754386,-0.183030785
+1042,15003.2193,738.6929825,574.6666667,1096.245614,12859.23684,578.1666667,432.3157895,1690.149123,7336.912281,475.5789474,442.3245614,1896.280702,10126.58772,1115.54386,5991.798246,3855.105263,3739.280702,1124.307018,334.2105263,2724.27193,6838.008772,785.2368421,124.1666667,457.1491228,7799.631579,383.7017544,113.2280702,7940.210526,6693.894737,1298.921053,1116.008772,2794.885965,5436.263158,527.7894737,272.5789474,30043.75439,4437.078947,734.5350877,381.8333333,1368.184211,3353.157895,677.0614035,152.9298246,5615.122807,2849.824561,1141.903509,188.0263158,3214.473684,773.7982456,289.8070175,114,13.5468409,10.87444217,0.596343977,0.95,0.626373626,-0.570931455
+1043,35467.11111,929.3555556,631.2111111,1118.244444,31934.43333,750.9666667,553.6,1710.366667,17498.46667,618.8222222,639.3222222,1809.766667,24160.45556,1350.488889,10353.11111,4545.5,9205.288889,1405.533333,406.4444444,2455.066667,17696.92222,436.2,212.2777778,483.3444444,20558.47778,448.0333333,139.9333333,6732.333333,16595.28889,1641.533333,969.8666667,2807.977778,13909.17778,631.5666667,312.8666667,2270.111111,10831.46667,988.4888889,477.7666667,1306.888889,8648.055556,687.6888889,190.3666667,5231.611111,6989.5,1387.711111,166.1333333,3334.833333,309.5111111,289.3,90,15.14522995,8.253082313,0.838481878,0.865384615,0.545454545,-1.123418082
+1044,21977.1123,761.5935829,628.7433155,1093.197861,19172.38503,654.1069519,782.4171123,1695.572193,10586.48128,501.3636364,1043.090909,1857.518717,15030.18717,1188.374332,3865.812834,1655.631016,5592.919786,1252.128342,368.0106952,3266.620321,10337.87166,2103.796791,794.3475936,655.342246,12186.12834,391.2513369,113.7647059,2439.68984,9839.807487,1619.914439,622.9411765,2811.647059,8258.299465,637.0748663,253.4278075,6278.074866,6589.438503,969.8823529,395.8395722,1339.721925,5056.465241,775.7005348,153.4919786,4194.989305,4221.197861,1214.946524,251.1604278,3176.818182,611.6898396,292.2834225,187,17.14264372,14.15387084,0.564178646,0.930348259,0.733333333,0.292059893
+1045,22587.21429,730.5,448.6632653,1086.397959,19525.32653,598.9489796,395.8163265,1649.122449,11079.81633,469.1428571,394.4897959,1821.765306,15405.0102,1134.520408,5328.836735,3614.581633,5696.163265,1143.306122,346.2244898,2460.163265,10455.56122,1047.040816,150.744898,430.0102041,12416.66327,392.6020408,118.1428571,6759.489796,10349.04082,1305.357143,834.1122449,2784.642857,8510.132653,546.9183673,258.6632653,10958.56122,6683.94898,735.1122449,394.3061224,1325.632653,4964.193878,824.1530612,154.8163265,2588.642857,4251.214286,1165.857143,150.9591837,3210.734694,850.1020408,289.5816327,98,14.20970501,9.214830706,0.761224426,0.924528302,0.583333333,-1.120494872
+1046,46056.17181,928.3964758,483.5198238,1112.568282,39979.08811,774.8281938,655.5286344,1615.612335,22186.15859,618.0088106,519.1894273,1751.889868,31840.18062,1463.352423,3450.180617,3169.960352,11481.45815,1499.370044,434.7709251,2484.550661,19251.82819,424.1806167,272.6872247,529.6079295,22468.66079,411.0792952,133.4801762,2421.436123,18502.76652,1569.687225,970.3259912,2826.555066,15607.70044,690.4669604,301.8634361,1815.105727,12768.31278,922.4581498,480.2643172,1309.052863,9520.052863,702.6872247,183.1145374,3052.290749,8268.814978,1439.057269,243.6563877,3295.581498,415.9162996,295.6387665,227,21.37579459,14.11637189,0.750922349,0.915322581,0.616847826,0.398435064
+1047,36925.03659,832.7195122,476.8292683,1080.512195,31583.7439,675.5853659,572.2804878,1553.853659,17189.87805,563.0609756,619.9878049,1742.292683,25159.65854,1301.195122,4163.109756,3444.402439,9313.865854,1355.597561,389.8292683,2479.536585,17638.4878,409.8902439,324.5731707,518.6341463,21248.86585,447.9390244,136.0609756,3861.243902,16863.43902,1652.341463,962.2195122,2803.158537,14194.52439,618.6219512,289.6585366,2316.012195,11613.52439,931.9268293,455.2195122,1309.231707,8957.536585,717.6463415,175.6097561,4794.04878,7468.621951,1361.170732,152.5609756,3232.512195,438.9146341,290.5609756,82,15.58249811,6.930660667,0.895643771,0.911111111,0.485207101,-0.840711259
+1048,34502.71642,866.7462687,466.880597,1070.776119,30310.31343,693.1641791,626.641791,1538.134328,17052.08955,573.7462687,596.880597,1729.552239,23909.58209,1298.507463,3293.164179,2474.865672,8621.134328,1334.701493,396.1343284,3248.432836,16018.62687,417.880597,157.7014925,441.4029851,19345.89552,395.3283582,124.6268657,2938.044776,15551.8806,1663.835821,749,2822.41791,12841.01493,650.0447761,282.3432836,2432.179104,10332.32836,1028.955224,438.3432836,1314.597015,7753.298507,646.761194,167.3134328,2368.686567,6627.597015,1278.895522,197.4626866,3343.447761,546.5522388,290,67,10.16513477,9.140664412,0.437502411,0.971014493,0.67,-0.654516544
+1049,36355.21905,964.6095238,517.3047619,1102.152381,31918.95238,762.4285714,770.6285714,1603.104762,18160.33333,621.9619048,993.9714286,1777.428571,25380.01905,1398.085714,4493.714286,3206.07619,8994.609524,1392.32381,406.9333333,3217.209524,17196.89524,439.9142857,127.1809524,947.1428571,20290.1619,479.4666667,164.8761905,3159.619048,17024.4381,1878.87619,779.0380952,2814.438095,14202.37143,660.3047619,296.8761905,2816.92381,11304.87619,1157.885714,470.9619048,1339.361905,8304.657143,649.5904762,172.9619048,2393.409524,7332.6,1344.447619,310.6380952,3416.142857,555.6952381,292.5333333,105,14.76247092,9.877047817,0.743204185,0.889830508,0.583333333,0.49466374
+1050,33141.83051,986.4745763,527.7457627,1122.084746,29763.05085,735.5762712,648.6779661,1625.423729,16594.81356,625.9322034,715.6779661,1777.457627,23234.69492,1353.779661,4464.389831,3244.40678,8995.067797,1400.050847,399.6101695,2435.559322,16540.28814,433.9491525,326.9491525,466.6101695,19055.94915,459.8305085,141.0847458,3321.457627,16223.81356,1723.457627,943.0677966,2828.237288,13789.89831,799.3898305,309.8135593,2386.084746,11061.59322,1020.542373,471,1345.40678,8485.322034,696.2542373,180.6101695,3279.610169,7155.847458,1446.644068,955.0338983,3464.576271,356.8474576,291.559322,59,12.17974305,6.569433008,0.842066516,0.893939394,0.487603306,0.698707538
+1051,33273.72189,829.1005917,494.4852071,1100.023669,28185.7574,680.9467456,618.4911243,1512.47929,15603.68639,566.9822485,790.0532544,1721.343195,22803.76331,1325.449704,4980.532544,4025.508876,8295.08284,1362.189349,403.2721893,2624.650888,15471.73964,406.7278107,318.0887574,557.9940828,18348.15385,468.3313609,133.5207101,3476.633136,14898.39645,1614.609467,923.7988166,2798.64497,12478.18935,688.704142,288.183432,1999.278107,10344.57988,975.556213,465.7692308,1310.337278,7925.242604,701.408284,180.4615385,3016.301775,6619.130178,1375.08284,538.6331361,3199.692308,451.9526627,294.4556213,169,19.0300951,11.57997446,0.793547362,0.928571429,0.586805556,0.642670218
+1052,35822.46667,919.6833333,470.6833333,1085.583333,31674.98333,720.5666667,740.2166667,1516.616667,17500.45,595.7833333,498.9,1757.433333,24801.43333,1360.65,3456.5,2001.483333,8659.2,1374.366667,397.5666667,2510.9,15002.03333,408.1166667,124.8666667,505.75,17639.63333,380.8833333,126.2666667,2897.466667,14524.61667,1447.966667,736.5666667,2816.166667,12003.9,658.6666667,268.5,2756.416667,9494.316667,853.8666667,429.9166667,1283.383333,7085.133333,629.2666667,160.4166667,2261.616667,6270.2,1260.433333,241.1333333,3380.133333,533.1833333,291.7333333,60,10.70910709,8.010792911,0.663658649,0.882352941,0.5,-1.086342446
+1053,40188.43137,848.0326797,488.8169935,1103.366013,34630.96732,759.6078431,638.4248366,1634.784314,19874.16993,573.6666667,1189.496732,1810.823529,27891.14379,1355.444444,4580.124183,4098.836601,9954.078431,1347.457516,396.8104575,3011.03268,19352.12418,480.6470588,121.5424837,883.7647059,22700.37255,519.7843137,198.2156863,3205.196078,18639.11765,1644.633987,840.6470588,2812.993464,15863.96732,683.2222222,303.8562092,3806.830065,12760.42484,1055.339869,466.2679739,1311.261438,9508.150327,659.4705882,174.2091503,2593.712418,8095.111111,1389.117647,508.7973856,3259.522876,578.9281046,295.6928105,153,18.14785718,11.50350833,0.773433911,0.805263158,0.536842105,0.327372302
+1054,14472.20661,698.0247934,503.9834711,1061.710744,12012.96694,561.2479339,402.4710744,1593.380165,7137.644628,446.1404959,397.3553719,1792.297521,10134.46281,1094.157025,6199.68595,4018.347107,3678.570248,1102.446281,342.0991736,2520.983471,6632.553719,1423.702479,843.338843,424.0826446,7754.545455,389.5454545,113.1570248,9066.165289,6693.603306,1293.421488,996.2644628,2782.727273,5422.842975,522.661157,248.3140496,16273.23967,4396.107438,737.9338843,368.446281,1325.140496,3197.123967,913.5702479,150.1735537,5212.719008,2782.801653,1111.942149,173.2727273,3189.917355,822.3553719,293.4793388,121,16.17857447,9.88168805,0.791793752,0.916666667,0.6875,0.124895955
+1055,47845.53333,1101.626667,570.4266667,1123.36,42679.93333,801.5866667,618.48,1632.226667,24505.09333,686.56,803.7466667,1759.96,33481.62667,1471.466667,3578.293333,3480.666667,13114.32,1560.773333,447.5733333,2445.946667,22572.88,447.48,244.3733333,499.5066667,26301.77333,462.2133333,143.6133333,3174.32,21727.38667,1727.573333,901.6666667,2816.506667,18549.86667,655.5333333,314.6,1952.56,14503.86667,1102.213333,475.6266667,1330.786667,11280.49333,695.4133333,191.2133333,3448.72,9371.306667,1437.386667,195.36,3458.64,348.04,292.16,75,11.97714865,8.269182362,0.723415176,0.949367089,0.619834711,0.849225215
+1056,45271.23256,917.8604651,482.6046512,1121.232558,38688.5814,786.0697674,804.3255814,1667.046512,23078.06977,623.3953488,1809.604651,1783.093023,32377.27907,1453.465116,2780.860465,2841.139535,10390.13953,1410.116279,417.0465116,2727.55814,21919.65116,495.6976744,115.8372093,863.0465116,24730.37209,433.1162791,664.4651163,2047.162791,21916,2029.767442,704.8372093,2878.209302,18194.34884,686.9534884,320.2325581,2374.511628,14334.30233,1145.348837,493.3953488,1315.069767,10483.4186,685.255814,182.1860465,2485.953488,9498.418605,1426.209302,285,3338.116279,570.4651163,291,43,7.945623802,7.035535175,0.46471485,0.914893617,0.597222222,-0.322004426
+1057,22588.81026,765.1641026,542.6769231,1114.610256,19619.10769,614.3384615,586,1724.533333,10621.87179,492.9384615,546.4871795,1829.487179,15419.18462,1184.410256,5925.035897,3263.753846,5536.194872,1160.938462,360.0358974,2963.692308,10062.81026,2315.292308,332.9230769,487.574359,12044.06154,409.8051282,119.9897436,7206.548718,9900.676923,1496.087179,901.6410256,2786.112821,8047.164103,587.2615385,289.0871795,26889.02564,6300.379487,786.5487179,392.8717949,1326.528205,4353.282051,787.8820513,152.3538462,4768.005128,3844.025641,1174.625641,191.0974359,3218.774359,917.4205128,294.0153846,195,20.03517619,12.6241391,0.776515028,0.960591133,0.619047619,1.208449519
+1058,41591.79832,922.7815126,626.3697479,1170.252101,27126.59664,638.4537815,403.3613445,1666.823529,14334.05882,527.0336134,457.2605042,1785.151261,20202.64706,1220.789916,10007.34454,5019.151261,7607.689076,1239.840336,379.4789916,2382.151261,14580.37815,404.4117647,146.512605,416.697479,17316.7479,382.7394958,127.4621849,10579.42017,13997.20168,1386.411765,934.3193277,2812.176471,11744.73109,777.4117647,282.6302521,2959.537815,8362.97479,808.512605,427.5462185,1296.705882,7124.815126,623.4621849,168.092437,3351.92437,5436.630252,1232.277311,170.4621849,3274.319328,239.5294118,293.7226891,119,13.556433,11.35318583,0.546474271,0.92248062,0.708333333,-1.038339537
+1059,23182.09559,1126.161765,628.8308824,1087.492647,21588.85294,738.6397059,873.6691176,1536.617647,11226.63235,638.7132353,1095.397059,1773.786765,15363.66176,1383.654412,7410.845588,4803.183824,5748.301471,1317.919118,379.8897059,2637.757353,11156.11029,376.125,265.7352941,817.6102941,12791.23529,777.2205882,119.8897059,5141.022059,10298.27941,1507.941176,778.1102941,2788.683824,8622.492647,589.8161765,275.1029412,2282.529412,6734.360294,1156.544118,408.8970588,1301.823529,5571.191176,642.6617647,165.3823529,3416.051471,4334.698529,1204.051471,246.6838235,3478.448529,291.8014706,294.9485294,136,15.13254436,12.53621235,0.560096657,0.824242424,0.604444444,0.851920611
+1060,31544.85,931.2,565.3444444,1109.566667,27061.26111,732.7166667,563.3888889,1609.55,15008.60556,661.8777778,521.2666667,1793.455556,21609.14444,1335.961111,4966.422222,3443.322222,7692.072222,1497.366667,431.2833333,2461.666667,14992.48333,430.4555556,1961,495.1611111,17559.66667,450.4,140.1333333,3285.977778,14039.64444,1844.7,969.6388889,2833.288889,11791.23333,763.2611111,300.3111111,2123.705556,9430.638889,899.9388889,465.5166667,1373.444444,7437.9,1108.822222,189.3055556,5700.577778,6232.538889,1407.633333,209.7,3354.927778,377.9388889,295.4222222,180,18.65299419,12.83737331,0.725501564,0.891089109,0.62283737,-0.706542725
+1061,19531.59664,660.6302521,426.3277311,1042.890756,17200,561.6470588,493.1344538,1530.008403,9684.554622,463.0168067,495.1512605,1790.571429,13654.2437,1108.747899,4165.966387,1960.596639,5010.218487,1089.453782,321.3445378,2848.453782,9196.932773,5665.781513,111.5882353,476.4705882,10727.15966,392.6554622,104.302521,5823.831933,8789.579832,1452.277311,1008,2787.907563,7579.378151,551.5714286,226.9579832,3850.067227,6137.260504,781.4117647,365.1680672,1277.428571,4499.857143,588.4537815,146.1848739,3893.554622,3815.453782,1097.352941,144.6218487,3119.361345,633.7731092,295.1176471,119,13.94020444,11.20565718,0.594849135,0.9296875,0.661111111,0.098752562
+1062,15882.04459,678.7579618,482.7070064,1082.834395,14336.87898,567.1974522,495.0573248,1594.617834,7968.55414,460.8853503,503.8789809,1787.165605,10973.26752,1090.292994,5324.687898,2918.210191,4120.191083,1098.452229,326.1910828,2937.363057,7633.573248,6430.101911,105.2611465,498.2993631,8694.929936,410.3694268,104.7643312,6509.808917,7289.55414,1368.515924,1096.11465,2788.643312,6264.484076,682.0573248,246.9808917,10730.94904,5024.987261,791.955414,359.6687898,1296.127389,3723.076433,633.3375796,146.566879,4908.496815,3176.057325,1109.656051,167.9299363,3097.993631,645.6624204,296.1082803,157,17.1075219,11.94667379,0.715777204,0.945783133,0.615686275,-0.697249054
+1063,21057.78947,737.4210526,496.7719298,1067.48538,18194.05263,606.3918129,706.5321637,1611.204678,10585.5848,492.9473684,1195.97076,1863.80117,14718.90643,1151.783626,7591.74269,3950.847953,5330.883041,1176.461988,357.245614,5448.280702,9985.02924,1057.05848,154.8128655,658.2222222,11455.24561,381.3216374,111.2339181,6900.94152,9843.25731,1625.321637,891.3859649,2794.467836,8254.783626,624.7251462,262.2397661,12551.5848,6701.111111,1034.842105,390.5087719,1345.97076,5095.245614,696.1929825,173.245614,4972.789474,4326.111111,1182.766082,271.8245614,3312.473684,715.7251462,295.9824561,171,17.10015535,13.31170379,0.627700246,0.914438503,0.670588235,0.344238132
+1064,28121.66234,823.1125541,569.6190476,1130.380952,24447.29004,653.0692641,725.7316017,1745.852814,13000.38528,512.6796537,1553.506494,1837.359307,19400.35065,1237.982684,7948.4329,4020.406926,7057.354978,1232.597403,368.5411255,6068.766234,12748.26407,452.2727273,215.8181818,977.6536797,15431.75325,428.2294372,122.8874459,6058.688312,12816.17749,1838.203463,808.7619048,2793.056277,10538.4026,564.5411255,289.978355,21485.60606,8123.645022,1287.190476,413.7575758,1377.917749,5473.064935,806.4761905,169.1774892,6077.995671,4972.896104,1238.865801,314.7012987,3219.398268,938.2857143,297.030303,231,18.80089327,15.98409559,0.526496244,0.954545455,0.802083333,0.434323967
+1065,21701.34375,894.375,795.8958333,1121.135417,19968.86458,681.9375,625.6354167,1648.0625,10512.27083,559.4166667,526.8541667,1816.09375,14914.64583,1276.666667,5294.541667,7095.552083,5666.541667,1326.729167,493.3229167,2483.666667,10607.27083,399.9479167,3410.770833,471.4479167,12905.20833,453.96875,129.1458333,8135.729167,10034.51042,1677.09375,1046.739583,2814.833333,8527.572917,609.7708333,286.1458333,5744.510417,6534.427083,903.4479167,439.4375,1365.083333,5467.833333,1409.229167,180.46875,7727.96875,4303.583333,1293.927083,351.3125,3216.947917,269.1770833,293.9583333,96,12.89992212,9.707170657,0.658594085,0.932038835,0.666666667,0.85041587
+1066,22683.33333,817.2898551,678.9927536,1144.311594,19811.55072,683.6376812,1286.826087,1805.152174,11023,506.0724638,1704.23913,1880.347826,16205.65942,1235.449275,4902.152174,2682.731884,5870.666667,1230.847826,416.3115942,3107.050725,10728.23913,660.0507246,1245.869565,3207.289855,12766.00725,461.1594203,152.942029,4055.688406,10783.34058,1829.449275,726.3913043,2833.847826,8824.318841,618.1376812,282,22762.02174,6897.217391,1174.101449,411.6449275,1387.963768,5078.84058,952.1086957,169.1884058,8880.608696,4452.514493,1237.623188,205.7463768,3263.876812,878.2753623,294.7971014,138,15.33646421,11.64296659,0.650893685,0.92,0.707692308,-1.324416093
+1067,37209.2723,881.3004695,558.2910798,1159.352113,29831.39437,673.2723005,407.9953052,1661.323944,15638.61033,555.2957746,460.5164319,1801.765258,21927.61033,1255.028169,7664.192488,4828.877934,8241.713615,1283.126761,387.1549296,2409.802817,15882.44601,381.5258216,121.4647887,421.1784038,18903.75117,415.5117371,127.0140845,6572.352113,14788.30047,1402.976526,786.7276995,2810.56338,12173.10329,577.6619718,283.6807512,3670.225352,8241.492958,927.2441315,422.3098592,1309.319249,7053.084507,623.2347418,172.342723,4549.13615,5253.15493,1238.187793,170.2910798,3222.389671,221.0422535,297.8638498,213,21.52996872,13.77158008,0.768668787,0.855421687,0.633928571,1.562506101
+1068,33081.72,927.0666667,598.76,1092.026667,29303.88,706.0933333,455.8133333,1630.986667,16098.2,600.4133333,510.36,1759.693333,22277.98667,1278.72,5130.226667,3627.92,8166.96,1365.96,401.2133333,2424.813333,15704.33333,399.28,483.6533333,474.76,18597.02667,433.6533333,130.0533333,4665.546667,15334.16,1491.853333,895.5866667,2810.386667,12811.52,604.5866667,294.4,4184.84,9838.066667,863.8933333,436.0933333,1315.066667,7783.373333,731.1466667,182.56,5702.28,6454.026667,1331.72,217.0666667,3374.973333,280.0933333,295.0133333,75,11.36097872,8.644802305,0.648845051,0.914634146,0.681818182,-0.915149738
+1069,46466.09524,1046.333333,572.3015873,1129.269841,41466.71429,812.8253968,925.6666667,1730.761905,23718.92063,674.7619048,924.1904762,1796.380952,31867.09524,1490.936508,6230.603175,3476.936508,12343.60317,1551.968254,456.7142857,2536.079365,24105.31746,607.8095238,246.1269841,640.1904762,26598.14286,480.9047619,150.3492063,4178.460317,21449.52381,1934.888889,920.0952381,2810.15873,18425.42857,653.3015873,343.4285714,2013.984127,14561.80952,1157.47619,518.6190476,1321.746032,11324.39683,748.6031746,190.4761905,4343.063492,9273.460317,1523.714286,172.3492063,3356.063492,339.8412698,293.9206349,63,11.29052651,7.252002098,0.766446138,0.969230769,0.63,0.757929605
+1070,14332.38043,708.25,485.1086957,1068.717391,11960.20652,578.3804348,474.6956522,1603.271739,6843.826087,460.0108696,395.1413043,1779.347826,9864.032609,1114.858696,8296.01087,4021.304348,3608.554348,1107.228261,387.8043478,2489.771739,6573.521739,1864.913043,1888.73913,447.2282609,7784.836957,386.673913,117.3695652,9032.836957,6580.543478,1334.76087,855.076087,2800.5,5430.206522,534,249.1956522,18724.19565,4374.663043,763.9673913,372.2173913,1357,3162.532609,1266.23913,162.4347826,5753.184783,2817.913043,1129.967391,217.8478261,3238.26087,839.2282609,295.7717391,92,13.54271875,8.864516119,0.756010432,0.92,0.597402597,-1.177854966
+1071,30488.41096,952.2671233,741.0547945,1283.780822,14981.58219,518.2739726,778.9383562,1525.047945,7395.883562,452.2671233,1032.30137,1732.650685,10729.88356,997.6164384,9017.445205,2456.383562,3918.089041,1030.150685,323.5,5336.69863,7282.280822,2005.678082,96.55479452,825.1849315,8727.506849,347.5547945,110.609589,5524.493151,6734.075342,1811.69863,528.5479452,2876.349315,5524.458904,554.0616438,217.5410959,3079.60274,3141.273973,833.0136986,342.609589,1275.924658,2743.979452,548.0068493,302.5342466,1834.047945,2190.780822,979.1575342,327.0890411,3015.965753,190.7671233,297.4726027,146,14.33386216,12.97269509,0.425329953,0.966887417,0.744897959,-0.829226127
+1072,50895.17204,1025.817204,637.6989247,1213.11828,24778.25806,636.2903226,375.7419355,1689.204301,13255.62366,510.9892473,437.8602151,1775.892473,18969.89247,1223.548387,6091.408602,3908.473118,7068.827957,1209.387097,369.7526882,2426.365591,13607.92473,388.8817204,141.6989247,416.5591398,15991.50538,376.0322581,120.8387097,6770.473118,12757.3871,1359.322581,680.3548387,2801.107527,10505.13978,548.5698925,272.344086,4279.978495,6388.075269,755.311828,402.4193548,1285.645161,5482.462366,614.4086022,180.4086022,3109.72043,4287.258065,1156.086022,186.0967742,3205.634409,205.8602151,296.2688172,93,12.7752834,9.681523423,0.652449296,0.920792079,0.775,1.387178823
+1073,50185.71951,907.3902439,472.1341463,1103.109756,44459.46341,758.1829268,759.7073171,1615.487805,24850.39024,619.3536585,1084.707317,1804.707317,35696.18293,1443.597561,3958.02439,3180.829268,12968.84146,1492,433.8658537,2467.012195,23125.2439,433.3292683,216.3902439,945.1585366,27695.39024,454.8292683,317.8536585,2787.317073,22342.28049,1880.890244,889.6463415,2817.634146,18964.15854,638.6463415,318.8170732,1643.682927,15415.30488,1132.939024,488.7439024,1309.219512,11522.62195,702.0609756,184.3414634,2451.268293,9913.5,1452.792683,144.4146341,3314.841463,429.1341463,296.1829268,82,12.48011886,8.673418692,0.719030176,0.891304348,0.569444444,0.842792433
+1074,19633.77949,702.7025641,459.9948718,1056.569231,16913.47692,581.3589744,479.4871795,1529.45641,9691.461538,657.3435897,601.8,1751.071795,13639.34359,1114.558974,5828.784615,2673.446154,4956.897436,1127.641026,464.8666667,3233.994872,8968.328205,8625.651282,970.0974359,487.3076923,10668.62051,405.2666667,109.7692308,4942.958974,8894.948718,1571.492308,803.7487179,2795.282051,7406.984615,768.7230769,248.0974359,9171.425641,6105.523077,850.7794872,374.4358974,1371.353846,4604.682051,875.3128205,152.6205128,3496.810256,3904.138462,1147.194872,182.2307692,3121.415385,746.4923077,300.0923077,195,18.11380687,13.98676681,0.6354275,0.9375,0.641447368,-0.204367652
+1075,19158.37415,740.4489796,497.877551,1112.346939,16404.44218,585.2993197,452.7823129,1629.088435,9358.081633,473.2176871,409.0884354,1837.156463,12937.16327,1123.938776,4931.870748,3130.877551,4818.095238,1161.326531,346.9795918,2565.380952,8798.55102,4955.809524,147.5782313,439.8911565,10110.72109,412.8639456,112.8367347,6255.061224,8663.44898,1309.07483,934.5782313,2793.176871,7062.544218,570.1496599,264.0544218,18690.2449,5742.217687,763.7959184,380.2380952,1347.176871,4360.040816,823.5986395,154.2993197,3752.693878,3676.959184,1182.537415,156.9727891,3265.802721,780.4081633,298.4829932,147,17.97406267,10.57806885,0.808483732,0.930379747,0.6125,-0.642975162
+1076,38742.52222,910.1333333,586.7222222,1135.333333,34578.36667,733.1444444,501.6333333,1718.311111,19097.18889,607.9111111,479.3222222,1812.444444,26459.94444,1355.188889,8738.622222,4739.766667,9904.755556,1405.9,424.0222222,2423.211111,18564.75556,526.8,497.0888889,439.1888889,22439.25556,453.4333333,135.1222222,7048.755556,17764.71111,1520.888889,996.5888889,2821.877778,14901.32222,763.5888889,303.3666667,2089.011111,10622.8,860.8333333,457.1777778,1297.866667,8710.5,763.6888889,186.5,4505.611111,6787.988889,1347.444444,135.9,3249.666667,249.3444444,297.8,90,11.84051827,10.15531989,0.5141917,0.9375,0.576923077,-0.347740994
+1077,42270.75926,1069.37037,654.8703704,1145.259259,37889.37037,747.4444444,607.537037,1738.722222,21391.03704,622.0740741,515.2222222,1829.425926,29250.90741,1345.925926,6100.87037,5300.074074,10700.64815,1434,424.8888889,2431.944444,20752.01852,446.9444444,166,489.8333333,24998.37037,449.9444444,136.6666667,5652.592593,20832.25926,1587.962963,1010.740741,2809.814815,17319.68519,613.6111111,333.4074074,2408.333333,13489.85185,901.7407407,484.2962963,1292.537037,10517.31481,688,194.2407407,3807.314815,9152.314815,1448.796296,142.6481481,3293.259259,301.5,296.8333333,54,9.480776815,7.767695489,0.57335075,0.870967742,0.545454545,-0.137083726
+1078,45365,1020.367647,530.8970588,1096.382353,39293,758.6617647,889.1176471,1573.573529,22587.29412,646.5735294,763.2647059,1778.970588,30512.13235,1362.529412,4716.411765,2868.352941,11151.20588,1421.514706,403.25,2519.514706,20787.11765,448.3970588,158.9558824,452.1029412,24510.47059,509.2058824,138.0588235,2372.514706,20034.48529,1651.955882,805.2058824,2787.397059,16916.5,603.3970588,294.3382353,1413.323529,13102.16176,935.7352941,456.1029412,1306.382353,10118.26471,637.3823529,170.2941176,1858.970588,8491.926471,1323.441176,136.4264706,3380.852941,314.9264706,296.6911765,68,9.617164765,9.280785487,0.262165121,0.944444444,0.561983471,1.441441834
+1079,28815.47872,1017.776596,656.2553191,1136.074468,26112.30851,774.893617,1484.297872,1643.989362,14510.14894,643.7446809,1893.382979,1769.723404,20025.2234,1415.797872,8516.56383,4048.542553,7468.457447,1417.106383,421.7340426,4780.585106,14785.96809,545.7553191,735.4042553,1029.478723,16862.70213,504.9361702,145.3085106,5419.904255,13243.42553,2514.808511,883.9468085,2824.255319,11419.37234,635.287234,308.5851064,1984.755319,8965.861702,1273.180851,480.6808511,1334.031915,7168.12766,858.8829787,193.0851064,6979.340426,5816.180851,1396.914894,250.393617,3352.829787,332.5,297.6382979,94,13.24586539,9.24757401,0.7159535,0.959183673,0.602564103,0.863116599
+1080,20671.91579,786.6,501.9157895,1032.736842,19433.92632,622.6947368,686.5789474,1409.273684,10284.46316,515.5368421,1072.336842,1785.768421,14707.52632,1194.8,5604.073684,3386.852632,5520.421053,1259.231579,360.5789474,2928.305263,10303.33684,384.9052632,178.5894737,674.3368421,12098.41053,371.2421053,116.5368421,3848.231579,9564.789474,1826.105263,816.4421053,2812.210526,8129.684211,715.5473684,253.4947368,3878.905263,6637.473684,1100.063158,419.9157895,1318.242105,5225.578947,646.5789474,160.5157895,4891.147368,4244.715789,1209.505263,650.4947368,3248.768421,544.2421053,297.6,95,16.36733047,7.761037717,0.880428681,0.871559633,0.575757576,1.150621579
+1081,19506.70683,729.4698795,512.0803213,1073.373494,17245.21687,592.2771084,443.3092369,1638.771084,9399.180723,472.4417671,403.437751,1838.092369,13216.45382,1130.208835,6358.514056,3850.658635,4869.546185,1143.429719,357.6827309,2486.128514,8861.116466,3193.164659,556.0763052,456.1566265,10455.61446,400.8192771,116.9277108,7582.967871,8579.084337,1346.690763,993.1365462,2780.35743,6930.465863,537.9236948,253.5542169,15912.2249,5521.104418,741.7951807,378.0120482,1329.558233,4058.172691,874.1365462,151.2449799,3710.285141,3449.37751,1135.578313,145.62249,3170.301205,853.5461847,303.626506,249,21.81653898,15.26596355,0.714394972,0.902173913,0.636828645,0.015290845
+1082,20802.13684,1088.242105,594.6736842,1087.515789,18250.81053,777.8421053,709.9157895,1472.726316,9847.747368,629.6210526,475.1473684,1748.852632,14642.41053,1397.473684,2098.136842,2256.347368,5182.873684,1484.778947,399.4315789,2452.778947,10396.95789,453,9552.136842,478.5789474,12379.35789,467.6526316,145.8631579,1449.747368,9986.578947,1873.957895,865.2210526,2819.526316,8422.705263,657.0736842,284.1578947,1463.147368,6868.726316,919.2947368,460.6526316,1327.357895,5471.715789,2938.505263,171,1411.326316,4627.810526,1396.010526,133.3473684,3363.715789,398.4842105,298.8210526,95,12.44918417,9.862016261,0.610285266,0.931372549,0.730769231,0.026948531
+1083,24673.65833,831.7666667,530.2666667,1062.825,21721.85,675.1666667,633.3666667,1473.541667,11632.58333,536.2583333,889.3166667,1765.458333,17296.34167,1271.85,6147.525,4536.758333,6487.8,1288.325,370.7166667,2640.166667,11828.39167,385,1090.591667,720.5083333,14007.28333,441.6083333,212.4833333,4664.691667,11154.03333,1772.808333,930.3583333,2825.583333,9485.933333,643.5833333,263.25,1926.55,7803.316667,970.25,426.6833333,1317.766667,6105.2,902.4666667,172.325,4714.175,5072.758333,1280.058333,295.5416667,3222.325,441.5666667,299.8583333,120,14.44348089,11.55538709,0.599944388,0.902255639,0.504201681,-1.252542478
+1084,15857.04054,1077.310811,530.2027027,1045.405405,14337.47297,706.4459459,633.2972973,1344.094595,7090.905405,606.2432432,775.5945946,1716.581081,9352.702703,1237.932432,4670.621622,2611.635135,3716.216216,1169.810811,334.4864865,2504.364865,6754.783784,371.3513514,121.2432432,754.0135135,7431.783784,343.8108108,143.5135135,3077.891892,5767.648649,1491.905405,680.2837838,2787.891892,5040.824324,574.3243243,221.2432432,2688.567568,4025.054054,803.2162162,373.3108108,1319.810811,3284.689189,576.7297297,150.8918919,2422.662162,2409.635135,1068.675676,397.2837838,3527.324324,566.9459459,297.7297297,74,12.86772146,7.733101141,0.799272365,0.902439024,0.569230769,1.081636518
+1085,25160.54167,752.3541667,479.0041667,1081.258333,22325.075,625.25,478.1166667,1630.016667,12668.58333,496.8541667,422.8541667,1791.4875,17626.325,1188.458333,5400.004167,2850.370833,6348.7125,1180.5,390.375,2668.2875,11835.79167,4216.004167,830.6208333,462.6875,13883.0875,391.1541667,114.6375,5623.075,11421.75417,1384.525,717.0416667,2799.4875,9576.866667,610.1708333,260.3458333,10227.69167,7779.275,804.9916667,391.6,1321.15,5832.7875,944.0416667,150.9083333,3670.920833,4872.704167,1196.875,163.7375,3188.2125,686.475,300.5916667,240,19.58333771,17.01220463,0.495324327,0.909090909,0.6,-0.552407247
+1086,26297.92994,768.0063694,508.5350318,1093.121019,21988.15287,649.1656051,868.4585987,1640.738854,12642,502.2547771,2304.082803,1769.980892,18155.77707,1179.101911,4756.031847,3115.242038,6504.866242,1182.184713,353.8407643,3027.503185,11899.46497,8698.834395,323.5350318,4071.898089,14080.57962,450.7834395,280.3057325,3186.923567,11817.76433,1816.840764,895.7643312,2792.757962,9667.197452,588.8152866,268.8025478,13862.80892,7605.031847,1035.127389,400.4968153,1339.388535,5366.745223,799.6305732,167.1783439,8694.165605,4699.878981,1189.050955,175.5923567,3216.159236,886.9171975,301.9235669,157,18.57084892,11.89725186,0.767840341,0.85326087,0.581481481,-0.558916832
+1087,19901.41243,733.2090395,499.7740113,1147.237288,16993.71186,584.4237288,441.5706215,1770.966102,8150.723164,457.0282486,406.1977401,1778.824859,12834.10734,1110.531073,3727.242938,2421.966102,4784.519774,1155.706215,338.2485876,2440.80791,8387.644068,795.9830508,142.1864407,464.9039548,10465.83616,385.259887,115.8079096,4255.858757,8724.457627,1293.875706,955.6610169,2858.135593,7212.824859,531.9661017,261.2372881,17208.18079,5482.740113,714.1355932,384.4124294,1319.610169,3464.096045,675.7909605,149.3728814,3971.977401,3212.118644,1118.056497,216.4576271,3168.627119,989.0169492,299.1242938,177,17.17552351,13.45523682,0.621522863,0.967213115,0.702380952,-1.299588166
+1088,30086.35088,818.5438596,524.9298246,1126.929825,24985.13158,662.5175439,912.5789474,1756.798246,11907.5614,493.1929825,1247.377193,1779.175439,18879.27193,1206.701754,4993.394737,2987.578947,6882.701754,1222.780702,366.5526316,3467.035088,12511.90351,1260.324561,189.5350877,1044.052632,15393.44737,441.2631579,128.1578947,4132.052632,12591.46491,1843.570175,807.4561404,2824.763158,10288.09649,593.5964912,281.1754386,18317.44737,7617.482456,1028.131579,410.6052632,1340.149123,4564.622807,773.2982456,157.6842105,5119.315789,4279.938596,1185.780702,270.5175439,3207.526316,1021.649123,297.9035088,114,15.31865996,9.811854206,0.767944421,0.95,0.678571429,-0.958198554
+1089,27226.03008,955.5639098,533.4360902,1060.87218,24163.21053,723.3533835,619.9924812,1489.759398,13393.7218,594.7067669,718.6616541,1728.736842,18681.90226,1327.706767,3632.496241,3644.052632,7254.120301,1405.278195,396.3834586,2514.56391,12312.70677,392.2255639,3918.684211,707.887218,14534.18797,431.2556391,207.9473684,3383.345865,11782.17293,1836.157895,952.962406,2821.203008,10068.56391,678.4962406,272.7819549,1717.766917,8135.526316,1052.233083,452.8496241,1361.744361,6282.947368,1349.293233,176.9924812,4427.293233,5424.894737,1365.796992,190.075188,3312.864662,387.5488722,300.9849624,133,15.09400718,11.60281664,0.639605253,0.936619718,0.633333333,-0.658158906
+1090,42732.16129,877.6451613,436.7741935,1080.887097,36273.98387,718.1129032,569.7741935,1574.854839,20485.6129,595.4677419,453.7258065,1767.967742,29580.80645,1345.66129,2878.290323,1601.306452,10771.59677,1461.919355,418.0806452,2429.322581,19250.66129,418.2580645,428.6612903,433.5,23979.16129,418.0645161,133.6129032,1954.580645,19474.46774,1526.887097,847.7903226,2838.435484,16219.8871,933,302.5322581,1671,13233.06452,899.6935484,461.7419355,1361.516129,10296.75806,738.0483871,182.4354839,2413.596774,8679.612903,1437.467742,663.0322581,3215.322581,362.2903226,299.4516129,62,10.08067756,8.069877075,0.599293707,0.873239437,0.626262626,1.486459584
+1091,29752.09836,785.5245902,469.9590164,1067.713115,26133.9918,654.5655738,533.0081967,1491.795082,14291.65574,527.1229508,448.7377049,1728.081967,20696.07377,1265.090164,5271.516393,3910.97541,7419.008197,1300.54918,385.2295082,2483.52459,14391,403.295082,876.3770492,476.795082,16389.91803,401.4836066,129.0901639,4294.942623,13380.95082,1450.188525,942.0655738,2813.860656,11028.90164,594.8360656,278.9836066,1941.614754,9066.631148,844.9098361,429.6967213,1298.385246,6875.721311,788.6885246,170.0409836,3826.04918,5803.893443,1277,432.7131148,3141.04918,467.4016393,300.4918033,122,13.52781486,11.54562122,0.521137489,0.960629921,0.721893491,0.895568991
+1092,34619.10417,867.1458333,481.0416667,1081.203125,30484.43229,698.8697917,661.9895833,1550.567708,17319.28646,550.3333333,487.09375,1724.598958,24918.35938,1335.958333,4044.296875,3477.125,8717.546875,1283.619792,373.1354167,2638.708333,16867.97396,462.3072917,270.0052083,510.5052083,20055.22396,393.7135417,120.9583333,4034.9375,16198.51563,1467.875,790.7447917,2790.869792,13813.35938,678.5989583,279.3333333,4083.614583,11223.21354,887.1979167,431.25,1310.619792,8406.072917,675.546875,158.296875,2377.416667,7167.604167,1324.671875,666.6614583,3226.395833,593.5572917,304.3229167,192,21.30438084,12.78289626,0.799990574,0.80334728,0.505263158,-0.90936463
+1093,15666.51908,713.3969466,534.3053435,1051.51145,13399.00763,577.5114504,418.8473282,1573.78626,7746.793893,466.6870229,372.8167939,1794.717557,10519.29008,1090.236641,5083.320611,4124.51145,3863.122137,1093.114504,326.6030534,2491.038168,7078.900763,1527.496183,136.4427481,438,8165.458015,363.3816794,109.0305344,5760.519084,7063,1238.908397,1176.923664,2779.328244,5815.801527,535.259542,260.4732824,16886.12977,4773.328244,737.2061069,369.0992366,1327.694656,3525.374046,711.8015267,151.351145,4515.992366,3025.778626,1130.312977,193.1374046,3193.19084,760.778626,302.1526718,131,13.52114851,12.46761197,0.386993796,0.942446043,0.623809524,-0.092293268
+1094,18639.53125,723.3854167,531.0104167,1098.989583,15672.73958,578.9895833,634.8541667,1687.364583,9162.416667,478.2604167,689.8333333,1790.9375,13022.27083,1109.479167,5644.635417,3927.791667,4856.177083,1128.916667,336.34375,4210.614583,8619.625,1627.197917,129.4479167,608.1145833,10001.35417,405.0625,116.1770833,7162.770833,8612.354167,1418.59375,1005.8125,2802.302083,7047.510417,639.8229167,259.6979167,19582.51042,5758.364583,1030.614583,378.2916667,1396.552083,4355.78125,878.3854167,151.2291667,5175.625,3687.541667,1147.604167,211.4791667,3220.25,791.96875,299.6979167,96,12.14219653,10.44468137,0.509961836,0.905660377,0.671328671,-1.443782331
+1095,16677.65217,739.2318841,584,1049.927536,14088.34783,588,507.6376812,1602.652174,7994.231884,480.3623188,474.5217391,1805.275362,11395.36232,1133.15942,6929.130435,4751.362319,4187.347826,1125.318841,366.7246377,3126.333333,7572.434783,939.5072464,1490.507246,482.2028986,8757.753623,385.6231884,116.4782609,9703.666667,7566.927536,1430.304348,1083.043478,2801,6163.73913,533.4637681,253.5652174,19755.2029,4940.57971,815.0434783,378.0869565,1346.869565,3726.376812,1106.289855,154.5652174,6735,3165.782609,1123.057971,217.4057971,3188.594203,804.1449275,298.3333333,69,11.57657036,7.582372029,0.755649959,1,0.784090909,1.16511557
+1096,38120.33696,874.5,563.1304348,1115.032609,34264.31522,714.0108696,786.1847826,1674.043478,19219.32609,594.5,604.4673913,1820.456522,26220.16304,1306.913043,7040.98913,4604.902174,9755.826087,1387.619565,450.9347826,2484.5,18460.45652,410.1304348,1163.684783,996.6956522,22489.72826,425.1847826,135.6847826,4877.5,18090.69565,1707.282609,893.826087,2809.163043,14970.70652,614.5108696,302.7391304,3736.336957,11244.34783,921.7608696,467.0869565,1348.25,9057.054348,904.2934783,173.6630435,4335.945652,7339.76087,1359.076087,286.9782609,3267.847826,266.1521739,302.6956522,92,14.53843772,8.667704582,0.802841669,0.867924528,0.505494505,0.627287228
+1097,27986.86022,819.8064516,493.3655914,1094.978495,25890.75269,638.7956989,580.8709677,1552.204301,14356.92473,539.2365591,827.4623656,1803.236559,19612.92473,1211.935484,5365.860215,2932.505376,7474.752688,1299.967742,373.9247312,2564.129032,14393.49462,1292.258065,277.4623656,431.8387097,16891.35484,440.7634409,125.4623656,3422.731183,13775.22581,1620.548387,879.2903226,2809.172043,11662.92473,609.9569892,298.1935484,2038.666667,9226.892473,910.8709677,439.0860215,1310.602151,7310.064516,674.7204301,170.2258065,3713.569892,5937.860215,1288.752688,176.9462366,3253.107527,309.0752688,302.9139785,93,13.59678029,9.192927829,0.73680011,0.902912621,0.553571429,0.494223943
+1098,28799.75758,1228.727273,531.2424242,1080.393939,26742.45455,746.8181818,557.9393939,1508.090909,14759.60606,651.8333333,536.0757576,1713.242424,21153.33333,1367.015152,3489.893939,2620.378788,7760.878788,1399.121212,391.5757576,2404.545455,16084.60606,425.4242424,333.8939394,443.2424242,18109.31818,426.1212121,131.5606061,4028.106061,14562.78788,1590.893939,876.8939394,2804.363636,12269.06061,604.6515152,280.5757576,1524.333333,9784.621212,914.5454545,436.9393939,1307.136364,8008.075758,654.3636364,167.9090909,2289.424242,6483.333333,1282.393939,342.3181818,3531.909091,352.5606061,300.6969697,66,10.16790909,8.776389429,0.504954542,0.846153846,0.6,-1.526708954
+1099,24390.57143,909.3571429,489.1857143,1051.385714,20968.15,660.7571429,611.7214286,1462.607143,11324.93571,587.1785714,707.6571429,1773.157143,16308.11429,1304.542857,2856.221429,1928.457143,5963.435714,1301.914286,377.7285714,2542.707143,10703.15714,458.1571429,350.5785714,612.8928571,12416.19286,443.4642857,121.2428571,1563.835714,9961.664286,1468.035714,701.8071429,2831.128571,8399.564286,818.6642857,257.3714286,2371.757143,6716.985714,976.9285714,417.7714286,1320.292857,5228.535714,1738.942857,155.8357143,1686.957143,4361.592857,2034.764286,746.95,3235.621429,514.0857143,302.8928571,140,13.56929819,13.50243605,0.099149564,0.909090909,0.625,-0.89935534
+1100,27086.7,955.48,558.52,1111.64,23362.96,712.38,531.68,1526.22,13288.64,590.36,572.96,1797.26,18291.94,1363.14,4957.76,4246.32,6736.48,1313.1,380.54,2537.76,11724.86,387.42,139.48,477.46,13648.08,626.9,125.9,4148.24,11016,1425.32,773.28,2817.82,9241.02,574.76,282.42,2181.28,7470.5,925.44,437.16,1324.22,5797.54,632.56,171.14,2912.14,4774.82,1254.36,285.34,3380.88,531.5,299.02,50,9.775862287,7.732148249,0.611890046,0.892857143,0.555555556,0.985284071
+1101,23836.15556,738.2888889,455.4592593,1068.755556,20872.53333,611.2,824.9481481,1561.666667,11936.87407,505.0518519,1215.525926,1764.148148,16542.06667,1184.081481,5998.281481,3148.837037,5960.037037,1184.355556,367.5407407,4334.725926,11335.79259,1701.511111,437.7777778,764.6592593,12931.08889,377.5703704,111.762963,4068,10836.26667,1691.088889,688.9851852,2790.6,9126.496296,605.837037,255.3703704,8195.755556,7333.674074,985.7333333,381.762963,1354.244444,5557.355556,738.2074074,165.1259259,4058.325926,4702.392593,1198.985185,257.3481481,3138.385185,673.3925926,303.3555556,135,17.19437651,10.53590897,0.790274341,0.918367347,0.6,0.876163979
+1102,20395.71111,746.6777778,544.9666667,1091.755556,17212.17778,596.0666667,419.7111111,1651.411111,9906.033333,467.9111111,391.1444444,1785.333333,14488.52222,1149.244444,6391.744444,3777.822222,5247.844444,1140.966667,338,2411.988889,9471.977778,3005.344444,566.9333333,446.3888889,11206.87778,410.8666667,114.4888889,6531.5,9367.533333,1287.966667,1081.177778,2787.4,7546.188889,635.3,264.3777778,21341.86667,6042.777778,747.7333333,381.1111111,1337.466667,4427.188889,861.2888889,149.6111111,4763.544444,3787.944444,1151.2,159.9666667,3213.277778,865.7666667,300.9666667,90,12.45453861,9.356876337,0.659980813,0.909090909,0.629370629,-1.53735472
+1103,22849.09489,762.6569343,499.4817518,1117.766423,19618.36496,593.9489051,434.8029197,1746.124088,9293.781022,455.5912409,470.5328467,1824.058394,14644.48905,1145.240876,5254.50365,3407.218978,5370.80292,1148.810219,343.5109489,2915.781022,9467.270073,5205.328467,130.3284672,456.6642336,11800.16788,424.5036496,117.2408759,6593.941606,9694.854015,1368.678832,1053.270073,2828.452555,7749.591241,543.0437956,260.3722628,12557.89781,5841.562044,766.1386861,380.4671533,1321.343066,3618.722628,676.5109489,152.270073,4103.306569,3325.919708,1113.927007,195.6715328,3137.562044,1002.583942,303.4671533,137,15.2383063,11.59472907,0.648876718,0.951388889,0.611607143,0.541184746
+1104,28714.21705,799.0465116,518.1317829,1107.302326,16284.14729,566.5116279,457.744186,1597.775194,6994.27907,426.8294574,624.1007752,1766.426357,12241.96899,1060.860465,6085.852713,2902.666667,4303.27907,1067.550388,320.8837209,4145.124031,7743.434109,1183.108527,163.7674419,488.8372093,9647.573643,392.3100775,110.248062,8796.744186,7594.449612,1459.604651,739.5503876,2789.139535,6039.465116,540.4186047,220.751938,8255.860465,4533.085271,832.1472868,362.2635659,1326.193798,2314.131783,588.4186047,141.2713178,4424.248062,2392.093023,1018.449612,261.6046512,3078.55814,1073.434109,301.6899225,129,14.28369856,12.97985541,0.417410369,0.921428571,0.5375,1.464040633
+1105,40564.95745,1020.882979,590.4148936,1126.553191,34559.61702,802.9574468,1787.56383,1700.776596,19657.41489,665.1595745,2389.978723,1843.893617,26975.52128,1423.117021,7539.287234,3963.553191,10013.94681,1445.702128,417.106383,2909.404255,18769.64894,438.9361702,377.9680851,723.4680851,22120.79787,618.3510638,712.4893617,3850.521277,17261.17021,2082.287234,816.4361702,2839.212766,14714.76596,632.8297872,301.1276596,1784.755319,11447.21277,1152.148936,480.8297872,1311.510638,9095.37234,771.1276596,191.2021277,6472.968085,7317.712766,1407.085106,503.0106383,3387.12766,323.0319149,303.4893617,94,12.89145173,9.353849053,0.688132138,0.94,0.657342657,-0.408264366
+1106,21138.71111,801.7888889,435.2666667,1044.755556,17824.65556,654.0888889,520.6555556,1404.433333,10043.41111,523.2555556,526.1222222,1725.233333,14619.61111,1254.788889,4056.733333,2465.133333,5221.877778,1255.311111,386.0888889,2524.111111,9639.044444,381.8777778,791.1666667,481.4333333,11454.52222,373.0444444,118.5222222,1846.688889,9249.777778,1434.588889,744.4,2792.955556,7651.266667,627.5444444,260.8777778,1649.411111,6142.733333,983.7555556,412.9,1319.366667,4745.544444,799.3222222,172.0333333,4134.388889,4119.9,1263.455556,1514.388889,3175.255556,499.9333333,302.5333333,90,12.50061129,9.843285672,0.616411307,0.891089109,0.532544379,0.71207838
+1107,17935.76136,700.3181818,405.6590909,1077.647727,15301.86364,573.2272727,388.0340909,1551.193182,8892.772727,480.7840909,373.25,1769.943182,12374.42045,1111.193182,2598.329545,1410.125,4535.693182,1134.602273,358.8181818,2565.965909,8484.943182,854.0795455,252.9659091,484.5681818,9875.159091,346.9318182,108.8409091,2428.272727,8406.227273,1270.863636,600.125,2845.568182,7167.965909,601.5227273,244,10663.69318,5863.340909,724.5681818,379.3068182,1325.306818,4406.454545,717.1931818,146.9659091,2199.056818,3760.840909,1150.488636,158.9886364,3186.488636,736.625,304.4318182,88,16.51381275,7.088182806,0.903196402,0.854368932,0.611111111,0.307781372
+1108,35885.49,950.2,553.84,1108.32,31782.79,743.45,659.44,1549.86,17424.47,610.21,590.88,1723.07,24986.62,1415.5,3346.94,3400.45,9259.79,1444.09,421.87,2548.68,15294.9,421.12,1245.61,489.88,18300.57,442.32,132.02,2549.49,14590.17,1720.36,895.32,2816.03,12233.7,715.92,293.7,1802.92,10317.11,1156.33,480,1336.34,7949.38,1017.54,180.6,3859.17,6730.56,1412.38,177.26,3284.59,406.79,304.19,100,13.06713483,10.85756821,0.556411959,0.877192982,0.641025641,-1.097686755
+1109,28010.46032,889.0793651,475.1111111,1045.793651,23680.92063,668.9365079,872.1428571,1432.952381,13163.60317,569.7936508,1151.904762,1816.984127,19141.25397,1295.428571,3844.952381,3190.460317,6649.253968,1311.714286,384.015873,2805.412698,12491.19048,398.5714286,157.2063492,700.984127,14772.90476,1279.761905,121,4076.460317,11912.90476,1499.47619,743.6666667,2801.793651,9920.492063,612.2857143,268.2063492,2624.174603,7907,1034.746032,440.3809524,1313.174603,6083.15873,643.031746,168.031746,3605.047619,5296.349206,1249.365079,380.2063492,3346.730159,526.047619,303.5555556,63,10.72961148,7.694314264,0.696959758,0.984375,0.583333333,0.473278995
+1110,19693.21875,684.23125,441.96875,1059.15,17301.675,572.23125,744.08125,1487.35,9867.03125,462.34375,840.95,1807.88125,13672.275,1115.80625,5598.5,3013.3875,5062.025,1112.4,327.44375,4047.65,9419.80625,6197.525,323.925,732.59375,10779.06875,416.19375,109.675,4903.2375,8928.3875,1632.5,825.45625,2770.35,7590.6625,680.325,233.80625,5496.99375,6176.725,1068.99375,367.65625,1295.33125,4581.75,679.51875,149.6625,4016.45,3892.54375,1131.475,246.6625,3118.09375,654.66875,305.7875,160,16.0482678,12.84815066,0.59920687,0.96969697,0.666666667,1.153309335
+1111,17235.63043,751.4021739,535.826087,1089.934783,12981.65217,583.2282609,443.9565217,1621.413043,5755.054348,440.7173913,403.0869565,1774.076087,9641.456522,1165.586957,5484.891304,2327.271739,3559.956522,1088.815217,330.6195652,2410.336957,6249.195652,3665.51087,751.7608696,439.9673913,7553.728261,406.076087,112.9565217,6234.195652,6264.641304,1360.347826,888.9673913,2773.402174,4976.369565,572.1086957,243.9782609,11173.5,3714.119565,691.2717391,365.673913,1311.913043,2076.521739,746.1195652,148.3043478,6585.445652,2030.793478,1046.26087,206.7173913,3108.130435,1046.358696,303.0326087,92,13.97229881,8.683023883,0.783457301,0.93877551,0.613333333,1.402283219
+1112,30942.21368,849.7521368,564.7008547,1121.324786,27904.63248,681.7521368,671.0854701,1682.384615,15354.66667,553.6410256,485.9230769,1778.059829,21399.45299,1257.752137,7520.564103,5051.521368,8073.794872,1313.08547,395.3760684,2426.136752,15026.44444,504.9401709,581.0512821,446.1709402,18328.61538,422.5213675,128.9145299,6580.846154,14254.96581,1489.57265,864.2735043,2812.444444,11849.82051,650.1538462,292.1196581,4314.991453,8721.735043,820.8632479,441.5470085,1329.239316,7217.230769,758.3931624,173.3418803,4315.34188,5676.179487,1298.316239,222.5726496,3286.128205,257.017094,305.5641026,117,15.62115992,10.85937546,0.718844524,0.879699248,0.522321429,1.157943385
+1113,22520.12593,832.6592593,664.3111111,1096.296296,21277.08148,647.1481481,569.237037,1623.97037,11210.05926,546.3703704,617.2740741,1801.755556,15552.7037,1205.577778,8400.303704,4745.474074,6028.748148,1270.896296,396.5185185,2482.777778,11227.14815,376.1333333,1287.555556,633.5111111,13350.04444,453.4148148,126.762963,5768.222222,10646.79259,1581.644444,1046.651852,2817.022222,8987.281481,613.7555556,282.4074074,5513.392593,6925.451852,847.8148148,419.9185185,1335.459259,5657.548148,908.837037,172.562963,6076.437037,4470.066667,1293.807407,352.1703704,3257.57037,278.9185185,304.7407407,135,17.58094622,10.3054709,0.810186123,0.876623377,0.661764706,-1.152987712
+1114,17135.51786,744.577381,414.7083333,1043.142857,15423.76786,598.8988095,429.8154762,1346.154762,8341.529762,489.6309524,410.7083333,1709.922619,12235.57738,1216.630952,1444.315476,1262.220238,4388.892857,1224.214286,358.7619048,2505.035714,7782.744048,351.7857143,252.3690476,435.4940476,9146.928571,345.0595238,115.922619,1108.107143,7354.547619,1323.720238,686.3035714,2884.565476,6196.125,593.9880952,242.7559524,1365.27381,5141.125,767.4047619,400.0178571,1295.369048,4019.571429,635.1785714,163.2678571,2104.946429,3373.940476,1221.595238,1065.744048,3075.97619,491.2916667,308.3095238,168,18.68057956,11.62300897,0.782860353,0.954545455,0.680161943,0.158889975
+1115,44586.71795,866.974359,476.6153846,1129.128205,37687.41026,739.5641026,634.7948718,1576.435897,22127.07692,595.3589744,448.5897436,1747.641026,31352.48718,1395.230769,3525.666667,3575.717949,10945.97436,1457.794872,422.6923077,2498.102564,21183.82051,450.8717949,137.7179487,461.4358974,25158.94872,427.1025641,136.7692308,3824.717949,21212.61538,1542.153846,1024.871795,2819.384615,17509.15385,642.8461538,318.5897436,2610.461538,13947.41026,999.8205128,494.1538462,1329.076923,10135.74359,672.8205128,179.3589744,2970.153846,9334.153846,1415.641026,292.7692308,3219.051282,537.3846154,302.8205128,39,8.536154241,6.188944866,0.688720127,0.866666667,0.541666667,-0.384735915
+1116,31234.57923,896.5901639,509.2459016,1094.26776,27257.40984,730.3005464,663,1564.885246,15144.85792,577.0546448,678.6830601,1767.131148,21345.57377,1333.945355,4557.590164,4375.699454,7722.234973,1342.710383,399.4371585,2521.131148,14018.91803,412.9344262,289.8688525,902.3387978,16576.62842,410.4098361,233.7814208,4286.262295,13465.40984,1595.644809,867.420765,2816.431694,11416.73224,729.2185792,280.9562842,2968.557377,9350.644809,883.2185792,453.2021858,1317.715847,7080.415301,692.9016393,174.8579235,3577.562842,6075.726776,1325.737705,386.9125683,3332.114754,559.4972678,307.0218579,183,16.33837411,15.24017331,0.360435962,0.867298578,0.635416667,-1.453786887
+1117,25507.749,748.9681275,457.6414343,1047.36255,22503.0239,629.5816733,1134.422311,1525.131474,12879.94821,505.3625498,1466.079681,1801.091633,18189.59761,1202.322709,6818.932271,3487.61753,6600.796813,1189.187251,361.5737052,5303.163347,12524.38247,2764.900398,407.0717131,1048.179283,14710.50199,439.685259,115.0756972,4217.183267,11929.89641,2067.772908,749.498008,2811.848606,10189.48606,600.3426295,253.3027888,5574.816733,8227.940239,1423.828685,394.0438247,1345.342629,6141.988048,706.4302789,157.4262948,4235.864542,5221.40239,1235.784861,612.5179283,3192.079681,628.5418327,307.247012,251,20.87467832,15.89032822,0.648487787,0.92962963,0.641943734,1.456253736
+1118,25806.2766,817.106383,524.2765957,1127.58156,21575.90071,682.7304965,637.1843972,1775.758865,10250.59574,479.1205674,2138.22695,1831.503546,17304.37589,1201.397163,5769.503546,2835.929078,6257.914894,1188.283688,359.5390071,3749.58156,11319.73759,846.4113475,126.9503546,795.2978723,14067.48936,438.2695035,123.5177305,5008.106383,11538.43262,2111.22695,761.0921986,2838.687943,9267.503546,582.6595745,279.9361702,18478.03546,7143.780142,1120.198582,396.6524823,1328.397163,4286.460993,724.5390071,160.1489362,5932.06383,4034.985816,1163.262411,370.1985816,3199.794326,1024.787234,307,141,17.02408248,11.83136209,0.71903104,0.859756098,0.5875,-1.004220848
+1119,22552.32558,784.5681063,489.1229236,1092.611296,15821.46512,534.5681063,566.7674419,1515.342193,6431.355482,414.7840532,701.7342193,1740.780731,11842.38538,1048.255814,4983.504983,2338.664452,4248.352159,1061.740864,326.820598,3391.059801,7555.219269,4005.259136,458.4983389,577.627907,9193.282392,436.5282392,106.4318937,5459.707641,7250.933555,1522.20598,645.4186047,2793.335548,5668.089701,516.7508306,215,3435.634551,4169.810631,844.3754153,352.8903654,1301.810631,2031.770764,635.89701,136.2392027,2366.568106,2114.774086,966.2325581,300.6744186,3072.026578,1090.182724,306.9667774,301,23.12540995,17.34846369,0.661221717,0.917682927,0.633684211,1.434097636
+1120,39992.85437,870.5825243,494.6990291,1122.271845,32663.40777,677.5242718,635.6893204,1651.854369,17981.29126,567.1456311,570.5436893,1781.495146,24914.26214,1266.708738,5943.436893,3208.815534,9395.203883,1332.563107,398.9320388,2414.038835,17808.61165,2183.805825,141.8446602,438.2621359,21711.63107,701.3009709,125.1067961,4298,17107.04854,1435.116505,741.2621359,2816.621359,14338.66019,831.8446602,304.2038835,2148.300971,10168.16505,849.5242718,434.5242718,1289.601942,8638,652.8058252,170.4271845,2787.815534,6611.436893,1285.961165,146.0194175,3198.815534,238.2135922,304.6601942,103,13.77210842,9.840679547,0.699597763,0.962616822,0.66025641,1.008779108
+1121,36774.28517,908.3992395,484.4410646,1081.627376,32097.15589,727.0874525,593.7262357,1528.471483,17669.46008,586.1787072,519.5551331,1740.60076,25715.61597,1370.768061,3946.992395,3010.505703,9357.627376,1392.429658,400.7870722,2469.030418,17447.19011,425.2357414,427.121673,727.4106464,20614.08745,434.3193916,134.7490494,2631.543726,16709.40684,1599.813688,968.9087452,2816.874525,14232.26616,739.5931559,296.6273764,1833.604563,11586.30798,918.8897338,463.1292776,1317.737643,8685.387833,742.0038023,180.3117871,3293.813688,7441.368821,1411.78327,309.9771863,3250.536122,428.2509506,309.5931559,263,20.23001217,18.16494314,0.44015762,0.873754153,0.544513458,-1.058039548
+1122,15480.98758,733.6708075,577.7515528,1081.869565,12634.69565,578.1987578,470.5341615,1548.031056,7372.496894,463.6645963,404.2236025,1775.981366,10466.58385,1117.242236,5086.223602,4490.279503,3829.229814,1126.21118,363.5900621,2594.608696,6867.043478,531.8695652,867.9875776,453.515528,8058.614907,377.4037267,113.6024845,6533.993789,6815.173913,1346.397516,1076.52795,2785.540373,5608.993789,557.447205,263.5217391,22322.19255,4567.167702,777.6770186,367.7267081,1349.913043,3389.726708,933.9130435,154.1987578,6198.409938,2931.428571,1152.652174,201.7142857,3194.708075,803.6335404,307.8881988,161,16.51271293,13.31371205,0.591547127,0.865591398,0.591911765,1.321682636
+1123,26736.7,810.575,676.4166667,1137.25,22313.01667,652.7083333,690.5,1784.558333,12458.13333,497.8166667,492.5416667,1811.908333,18399.69167,1207.758333,3931.1,2528.733333,6590.208333,1243.616667,364.8333333,2691.883333,11876.2,2567.191667,325.2416667,482.3666667,14605,446.9583333,124.25,3339.575,11939.35833,1445.758333,875.1333333,2829.5,9607.616667,598.525,272.0333333,14739.125,7651.216667,871.0166667,410.8166667,1324.916667,5398.175,833.9083333,159.7583333,4487.391667,4758.725,1229.675,158.875,3263,903.6166667,308.525,120,19.32479762,8.527861338,0.897364006,0.863309353,0.542986425,0.492867895
+1124,21610.84672,763.8467153,530.4233577,1106.788321,18380.59124,605.6350365,565.2481752,1686.927007,10238.87591,477.1605839,583.5255474,1804.810219,15467.25547,1159.343066,5894.014599,3581.817518,5488.635036,1181.306569,357.8832117,3397.963504,9876.620438,2142.941606,293.0510949,490.3941606,12206.56204,428.8613139,116.8321168,5147.343066,9976.956204,1558.248175,740.7591241,2784.59854,8048.824818,552.9489051,259.9416058,18504.19708,6477.043796,856.8467153,400.7226277,1332.664234,4509.007299,812.6788321,158.2627737,4688.70073,4036.744526,1187.386861,192.9416058,3286.226277,912.8321168,306.7372263,137,15.43476051,11.56798387,0.662031419,0.958041958,0.658653846,0.469926163
+1125,44979.65556,932.5444444,580.1555556,1185.377778,38257.45556,708.6555556,599.0111111,1796.055556,20129.22222,571.7333333,861.7111111,1849.755556,28367.76667,1291.677778,5306.688889,5034.255556,10455,1372.4,405.1111111,2722.111111,20283.92222,428.7444444,134.0666667,556,24102.41111,1090.377778,148,5746.033333,19158.85556,1590.111111,800.3111111,2816.933333,15658.41111,594.0888889,300.8777778,3553.911111,9821.088889,999.2222222,441.7555556,1308.266667,8487.066667,629.7888889,172.7111111,3340.7,6632.333333,1273.711111,193.8888889,3191.422222,205.8777778,304.9666667,90,14.27112725,8.609447215,0.797531498,0.909090909,0.6,1.480229929
+1126,30249.01471,837.7352941,517.4117647,1071.779412,25466.75,674.8970588,586.1176471,1529.470588,14930.95588,533.25,420.8970588,1734.279412,21541.16176,1303.735294,5986.073529,3431.529412,7543.323529,1254.367647,364.9558824,2490.147059,14736.94118,496.25,709.2352941,483.6323529,17585.22059,391.9558824,116.9117647,5040.308824,14280.86765,1444.808824,769.4852941,2809.161765,12094.60294,593.4411765,267.9852941,4976.264706,9712.485294,880.5588235,415.5441176,1332.029412,7241.308824,828.0441176,165.0294118,2993.602941,6278.25,1297.220588,708.5,3269.235294,605.2794118,306.2941176,68,11.93654982,7.704294176,0.763813279,0.971428571,0.653846154,0.063610269
+1127,18800.5,783.8780488,479.402439,1053.256098,16655.65854,659.2317073,639.1097561,1553.829268,9195.439024,508.9878049,695.0487805,1796.902439,13730.39024,1226.487805,4454.146341,2395.402439,4934.573171,1204.45122,448.4878049,3121.695122,9079.5,488.5243902,1618.817073,671.0731707,10868.37805,378.9878049,111.0731707,2622.426829,8606.158537,1606.207317,613.0487805,2781.658537,7425.402439,701.6341463,252.2682927,7047.195122,6022.134146,958.2682927,392.0853659,1404.817073,4495.109756,1066.134146,158.5853659,5398.341463,3885.560976,1243.45122,891.2804878,3183.439024,613.4878049,305.8902439,82,13.09048254,8.815465824,0.73925502,0.872340426,0.630769231,-0.637915016
+1128,23897.30159,757,543.452381,1099.849206,20928.62698,621.0396825,511.1428571,1675.52381,12289.88095,496.8412698,408.7301587,1846.404762,16936.74603,1179.269841,6351.809524,3825.920635,6072.912698,1185.333333,356.7222222,2712.626984,11406.71429,997.3253968,232.0634921,455.6349206,13313.5873,388.8095238,109.6904762,8116.5,11239.76984,1348.396825,1048.277778,2788.253968,9476.119048,592.6349206,259.3015873,13997.20635,7612.174603,814.1111111,386.0873016,1330.714286,5726.555556,878.9047619,159.8333333,4115.388889,4827.373016,1200.285714,155.6269841,3195.650794,709.452381,306.9285714,126,14.48709438,12.02536308,0.557652979,0.893617021,0.6,-1.188416204
+1129,22866.50595,744.9880952,485.702381,1098.166667,19807.66667,594.2380952,439.3869048,1629.642857,11051.72024,468.8154762,417.0416667,1773.732143,15823.33333,1168.25,4467.863095,2238.982143,5721.380952,1144.208333,351.1130952,2463.636905,10431.46429,11283.21429,449.0952381,447.3690476,12337.93452,472.702381,117.4761905,4504.452381,10282.38095,1365.327381,980.7738095,2807.035714,8422.815476,804.0059524,252.6845238,7943.428571,6646.535714,743.875,386.4404762,1325.321429,4815.875,797.9345238,156.5357143,3727.85119,4093.511905,1146.5,135.7202381,3216.303571,877.2857143,311.1011905,168,22.21285388,9.984517839,0.893283955,0.852791878,0.5,0.49634775
+1130,27957.56977,821.9418605,554.255814,1117.410853,23559.77132,645.3333333,811.751938,1769.542636,12292.28295,496.127907,1300.612403,1828.782946,19000.5,1203.693798,6320.248062,4131.94186,6886.050388,1217.341085,364.0503876,3977.724806,12514.05426,1109.763566,283.4922481,947.4496124,14775.57752,432.0465116,125.2945736,5657.062016,12589.13953,1854.562016,836.6162791,2813.027132,10240.98062,556.6976744,282.1395349,19358.0969,7794.224806,1194.282946,406.2364341,1335.011628,5313.651163,965.7674419,160.2790698,5692.883721,4816.430233,1213.79845,322.4457364,3229.302326,954.2868217,310.255814,258,20.50501205,16.87536846,0.568059492,0.874576271,0.590389016,-1.430023337
+1131,39327.48503,1018.05988,614.0479042,1142.700599,34846.40719,699.8562874,487.497006,1664.209581,19234.13772,586.2814371,516.5149701,1804.556886,27123.68862,1308.724551,6935.976048,5010.958084,9909.904192,1463.616766,406.0958084,2444.263473,19003.23353,420.8203593,186.1077844,467.4610778,22885.91617,459.3233533,135.508982,4148.856287,18582,1520.532934,1062.143713,2818.035928,15720.80838,618.2095808,310.2754491,2244.251497,12114.00599,882.1616766,458.7125749,1309.982036,9503.682635,687.1916168,179.2994012,4798.131737,7890.443114,1383.670659,161.4790419,3263.922156,295.8323353,307.8922156,167,16.96064627,14.78914396,0.489562542,0.865284974,0.579861111,0.889855121
+1132,29052.88542,770.5833333,436.90625,1050.53125,25543.39583,637.90625,656.375,1462.458333,13712,526.8229167,508.25,1711.552083,20067.84375,1246.447917,5549.104167,3152.447917,7469.854167,1285.28125,375.2916667,2506.645833,14127.97917,387.6666667,341.875,467.6458333,16540.65625,411.09375,126.96875,3015.697917,13084.40625,1453,932.78125,2825.34375,10860.25,613.6875,277.6145833,1951.4375,9108.385417,843.0833333,440.0729167,1297.5625,7033.260417,692.3125,168.6041667,3697.697917,5837.0625,1306.9375,215.4479167,3142.21875,458.3854167,307.7916667,96,13.74539656,9.772046503,0.703260445,0.880733945,0.527472527,-0.590457946
+1133,38385.125,850.3035714,483.2678571,1112.803571,34212.67857,702.6428571,726.4642857,1592.678571,19347.48214,581.7321429,537.0535714,1766.696429,27340.41071,1374.839286,4587.285714,4306.517857,9657.035714,1374.410714,395.2321429,2533.660714,19260.08929,452.1428571,187.2678571,466.2857143,22749.96429,404.5357143,129.7321429,3320.446429,18225.92857,1609.696429,853.8214286,2829.696429,15501.60714,665.8214286,302.3214286,3127.982143,12904.5,932.3035714,470.0714286,1304.035714,9787.071429,682.5714286,176.9464286,3384.125,8153.053571,1409.410714,428.6607143,3297.303571,571.6964286,305.3214286,56,12.09099364,6.242278112,0.856422847,0.903225806,0.583333333,-1.222010736
+1134,25323.43956,771.8681319,520.6593407,1099.494505,22220.18681,637.7912088,786.4725275,1676.43956,13013.64835,510.4725275,558.2967033,1834.67033,18396.71429,1218.153846,4926.846154,2674.373626,6562.879121,1211.725275,442.6483516,2924.153846,12089.89011,2086.417582,453.4835165,504.2747253,14348.48352,411.9010989,119.3736264,5797.307692,11792.62637,1436.472527,892.6153846,2806.340659,9891.868132,637.4285714,264.5714286,8293.087912,8097.824176,872.7472527,399.7032967,1318.846154,6071.450549,776.7692308,164.2527473,3006.923077,5126.67033,1232.285714,154.2197802,3218.230769,694.5714286,308.3846154,91,14.08756447,8.665565806,0.788432219,0.928571429,0.5,-0.596168693
+1135,45090.625,956.515625,594.71875,1192.9375,39433.10938,758.421875,512.875,1903.21875,21590.98438,620.453125,474.984375,1853.03125,29542.51563,1397,6406.1875,5795.59375,11498.34375,1454.703125,431.078125,2393.34375,21389.54688,440.671875,131.96875,432.734375,25934.84375,436.84375,152.453125,5346.859375,20466.82813,1508.375,761.75,2852.40625,16953.90625,629.5,329.3125,3763.859375,11662.64063,886.28125,468.75,1318.421875,9852.890625,648.25,174.34375,2640.21875,7530.34375,1388.609375,173.421875,3282.53125,224.703125,306.828125,64,13.55503429,6.624064672,0.87246349,0.842105263,0.533333333,-0.991617777
+1136,38253,940.2241379,592.8793103,1130.982759,34459.2931,745.6206897,1024.413793,1682.758621,19633.51724,608.1034483,908.362069,1804.086207,26917.22414,1376.224138,10298.87931,4032.810345,9947.310345,1431.948276,419.2931034,3161.224138,19348,446.7413793,270.1896552,523.4482759,22596.18966,467.6896552,145.7068966,5611.637931,17966.25862,1909.086207,880.137931,2800.568966,15485.75862,632.5172414,304.9655172,2182.5,11937.13793,1167.189655,477.0517241,1310.913793,9401.293103,754.9310345,196.8275862,9328.431034,7767.189655,1444.672414,434.2241379,3319.948276,331.5,306.9482759,58,10.16609162,7.551262687,0.669525398,0.90625,0.659090909,-1.255575443
+1137,35899.67045,1045.977273,524.8068182,1103.579545,31815.80682,680.5340909,564.4545455,1601.863636,17708.85227,583.3295455,464.625,1775.443182,24592.73864,1296.568182,5725.829545,3039.386364,9077.909091,1390.727273,401.0795455,2472.602273,17702.25,397.3409091,273.0909091,436.8977273,20730.03409,419.6818182,129.3863636,4533.034091,17050.56818,1552.647727,851.2272727,2806.170455,14228.39773,611.0568182,305.7159091,1734.295455,11338.72727,900.9659091,462.6931818,1309.215909,8952.352273,711.7840909,179.1363636,3517.227273,7425.909091,1357.795455,139.4431818,3394.511364,348.2840909,308.2954545,88,14.90572924,7.677851336,0.85713371,0.888888889,0.523809524,0.963802772
+1138,26752.78519,852.5185185,510.1851852,1051.837037,23786.51111,649.5259259,494.9555556,1471.385185,13030.63704,546.7925926,459.6296296,1714.659259,18324.25185,1226.814815,3763.148148,3074.925926,7091.42963,1348.918519,375.5407407,2470.874074,13247.42222,379.4,1028.22963,424.2666667,15740.65185,385.562963,124.9777778,3911.518519,12479.17778,1553.548148,926.9925926,2830.77037,10515.62963,632.0074074,270.8592593,1781.955556,8494.637037,832.1111111,439.7333333,1324.051852,6756.607407,1119.103704,166.1777778,4161.066667,5814.814815,1578.333333,140.5333333,3351.259259,376.1407407,310.5333333,135,19.06636552,9.969867597,0.852391941,0.865384615,0.535714286,0.596690492
+1139,23705.92045,845.0454545,484.7727273,1065.170455,20951.10227,668.2386364,603.1363636,1459.727273,11791.70455,544.5113636,490.1363636,1726.772727,16675.375,1274.022727,6425.954545,3127.670455,5982.090909,1291.602273,375.2613636,2500.829545,11531.30682,401.5113636,1273.477273,469.8409091,13573.48864,393.5568182,128.2840909,5863.988636,11171.51136,1503.579545,1073.25,2805.488636,9331.079545,697.9659091,265.6818182,3307.090909,7608.511364,865.9318182,436.1818182,1345.079545,5824.681818,977.9090909,165.5,3382.602273,5073,1293.397727,610.9772727,3306.534091,544.9318182,307.2386364,88,11.50169479,9.853380947,0.515832465,0.956521739,0.733333333,-1.469019236
+1140,21465.62363,736.8543956,510.456044,1088.093407,18255.01648,592.1675824,554.478022,1702.315934,9040.423077,457.7967033,409.5796703,1789.934066,14189.64011,1143.068681,5655.736264,3410.928571,5241.510989,1140.03022,341.6703297,2450.92033,9287.626374,1483.868132,202.0412088,440.5521978,11157.75549,403.5054945,118.8489011,7852.376374,9472.269231,1334.64011,1027.296703,2790.184066,7578.057692,558.8763736,266.0631868,21003.66758,5896.373626,737.728022,382.3708791,1327.417582,3788.115385,778.8543956,154.4450549,5241.675824,3484.728022,1130.112637,195.271978,3218.288462,979.6703297,314.0879121,364,31.07693442,15.45816861,0.867512068,0.903225806,0.541666667,0.964375523
+1141,22630.89157,758.7650602,483.0481928,1095.120482,11796.65663,529.5843373,390.9939759,1542.903614,5127.445783,412.6325301,485.4096386,1723.53012,8932.692771,1015.036145,4792.650602,2125.63253,3234.295181,1045.222892,313.5,3849.277108,5889.927711,2771.186747,440.5783133,504.5361446,7220.439759,369.6325301,110.1807229,7177.385542,5837.012048,1376.054217,703.9156627,2807.783133,4691.542169,506.2108434,227.0240964,8896.777108,3558.03012,765.1566265,343.2771084,1301.843373,1870.415663,664.8373494,139.6807229,3491.066265,1906.006024,1003.066265,188.3554217,3096.481928,1064.807229,310.1204819,166,16.14014919,13.74707284,0.523978548,0.922222222,0.610294118,1.535924592
+1142,44253.48765,932.9691358,560.5555556,1179.358025,36308.97531,728.4074074,660.9691358,1788.308642,18654.46296,582.4197531,1267.932099,1890.222222,26864.6358,1288.537037,6443.512346,3677.641975,9740.580247,1341.67284,399.7283951,3684.259259,18682.37654,1226.240741,139.1604938,1035.864198,22615.52469,440.8148148,648.3024691,4013.796296,17529.80247,2047.419753,646.8641975,2873.888889,14511.98148,604.5185185,290.9012346,3183.493827,8800.407407,1075.611111,426.8518519,1299.425926,7789.388889,630.882716,169.7160494,2515.432099,6110.993827,1246.635802,394.2037037,3209.851852,196.1666667,311.0123457,162,16.88508314,13.36949441,0.610789236,0.870967742,0.635294118,1.320251509
+1143,12486.7619,1023.222222,535.8095238,1050.68254,12002.09524,724.8253968,551.3809524,1433.031746,6062.539683,601.7460317,511.9206349,1754.111111,8830.206349,1246.714286,4826.888889,2593.460317,3505,1275.873016,350.8730159,2453.492063,6841.428571,366.1904762,2023.920635,445.5396825,7192.015873,411.9047619,118.2380952,2692.111111,6114.142857,1512.190476,815.952381,2803.936508,5461.857143,742.4920635,252.8253968,1600.968254,4368.904762,786.5238095,412.3015873,1358.269841,3616.666667,1006.793651,168.4761905,4267.984127,2769.84127,1220.428571,1069.063492,3330.301587,359.3650794,307.0952381,63,12.2051621,7.045938924,0.816537984,0.875,0.5625,-1.427727086
+1144,33957.94545,933.8,571.3454545,1122.563636,28564.83636,779.8363636,987.8363636,1570.654545,16122.43636,592.5636364,1050.2,1844.2,23410.65455,1370.836364,6136,3968.781818,8271.218182,1380.781818,403.3272727,2681.745455,13992.6,481.3454545,296.8363636,1018.981818,16369.96364,497.4,450.5818182,3030.290909,13189.89091,1923.054545,925.4363636,2788.927273,10989.10909,607.6909091,284.0727273,1906.909091,9049.945455,945.5818182,443.6727273,1333.963636,6811.072727,692.7636364,175.6181818,4151.527273,5870.727273,1330.6,319.2,3274.381818,446.0909091,307.3454545,55,11.18020549,6.320060953,0.824892086,0.982142857,0.6875,-0.993323267
+1145,23586.84274,770.8306452,514.108871,1096.637097,20017.43548,618.8306452,564.3225806,1601.387097,11681.83871,492.5806452,835.8548387,1800.758065,16596.04435,1187.21371,4779.092742,3233.532258,6050.71371,1187.052419,362.2217742,4094.975806,11006.58065,1297.241935,405.6290323,469.9274194,12812.52016,394.7056452,118.266129,4720.967742,10878.20968,1431.314516,783.1895161,2802.717742,8949.596774,571.2177419,280.1451613,24850.77823,7305.927419,1073.423387,394.1814516,1384.770161,5541.330645,916.9032258,156.0282258,3958.379032,4703.685484,1213.278226,183.9274194,3228.120968,786.358871,311.8306452,248,20.70587794,15.44726757,0.665909011,0.928838951,0.694677871,1.560590409
+1146,29348.97778,777.0888889,648.2888889,1118.722222,26040.22222,633.5777778,788.1222222,1753.344444,14390.82222,497.3444444,430.6444444,1810.5,19970.23333,1182.288889,3946.633333,2770.211111,7268.966667,1199.366667,361.8777778,2539.411111,13236.61111,5717.222222,451.7777778,469.4666667,16067.28889,454.2777778,122.3222222,4656.822222,13330.65556,1417.277778,891.8222222,2812.244444,10709.58889,559.4333333,261,8554.011111,8393.988889,837.8555556,406.9222222,1315.355556,6018.866667,893.4777778,159.6777778,3450.877778,5333,1220.277778,161.6444444,3293.133333,896.1333333,311.7666667,90,15.02354674,8.293487337,0.833822538,0.833333333,0.535714286,0.465007071
+1147,49657.7027,1028.540541,606.2027027,1144.135135,43406.75676,809.4054054,721.8648649,1741.432432,24579.40541,671,518.4594595,1741.581081,34217.5,1490.310811,6891.5,3774.324324,11517.72973,1538.013514,434.7837838,2504.689189,23131.13514,476.1756757,247.2027027,452.5,26819.7973,454.9864865,143.9324324,4927.608108,21852.37838,1635.851351,891.3378378,2835.689189,18440.7027,654.1486486,318.7297297,1854.27027,14286.44595,966.7972973,500.8108108,1307.094595,11064.66216,756.027027,199.1621622,5352.297297,9140.945946,1488.027027,155.5,3344.5,338.6621622,311.2027027,74,12.58735911,7.776903715,0.786308228,0.925,0.632478632,-0.327322252
+1148,40434.04615,975,465.0769231,1064.384615,35484.2,728.0461538,581.2461538,1479.415385,20111.55385,627.6153846,485.3384615,1737.615385,28464.92308,1353.861538,2389.446154,2182.969231,10352.75385,1438.615385,403.4307692,2449.907692,20535.04615,448.3384615,1264.261538,484.0153846,24157.13846,502.6461538,133.1846154,1731.984615,19375.2,1641.984615,871.8307692,2842.538462,16226.36923,674.6307692,312.8307692,1456.230769,13349.29231,1031.646154,482.4,1337.230769,10320.18462,957.9538462,177.0615385,2184.369231,8887.353846,1414.784615,130.9538462,3343.769231,393.9846154,309.4153846,65,9.841604702,9.057585677,0.391128069,0.915492958,0.590909091,1.097691768
+1149,30252.87603,845.2727273,559.0495868,1106.595041,25989.29752,688.9173554,788.1570248,1578.173554,14691.35537,555.8016529,949.9421488,1811.991736,21373.5124,1351.661157,5088.297521,3886.867769,7796.355372,1407.677686,394.446281,2789.909091,14719.03306,821.5619835,477.1735537,832.0661157,16792.99174,444.5702479,132.1652893,2916.157025,13585.08264,1886.438017,862.2561983,2812.421488,11437.73554,699.107438,288.5371901,1905.438017,9166.586777,1120.561983,454.6942149,1325.330579,6950.421488,766.7933884,174.9090909,4554.049587,5954.983471,1360.206612,271.1487603,3223.495868,508.4958678,312.4380165,121,16.27309062,10.00747573,0.788549873,0.909774436,0.537777778,0.758267381
+1150,45061.84314,1023.411765,506.8039216,1101.745098,38739.43137,798.254902,762.7254902,1603.254902,22623.4902,633.5882353,516.7843137,1719.156863,32322.03922,1504.627451,3764.882353,2844,10803.88235,1407.470588,401.3921569,2467.431373,21002.45098,470.5294118,140.5098039,462.8039216,24746,420.9607843,130.0196078,2624.823529,20299.05882,1644.019608,703.0980392,2816.352941,17559.56863,645.7058824,319.4117647,2179.901961,14226.70588,955.4901961,473.9803922,1322.196078,10532.11765,669.3921569,175.5882353,1665.843137,9315.901961,1452.215686,274.2352941,3328.784314,580.9019608,308.3921569,51,9.952637797,6.649283777,0.744078129,0.910714286,0.6375,1.134418882
+1151,28570.17293,764.5789474,462.2330827,1090.030075,24332.62406,612.6090226,515.3684211,1714.030075,12904.10526,479.7894737,488.3007519,1814.06015,19352.84211,1172.045113,4878.18797,4018.857143,7034.766917,1168.496241,347.5338346,2886.323308,12666.65414,1010.849624,160.0300752,482.481203,15243.40602,417.1879699,120.2330827,5811.225564,12665.00752,1414.007519,930.7142857,2788.62406,10280.92481,536.1278195,245.3308271,7600.729323,7933.097744,797.6766917,391.6766917,1306.233083,5480.766917,715.2631579,150.1804511,3233.879699,4914.398496,1168.586466,177.3533835,3169.789474,936.7218045,310.6691729,133,14.35519327,13.07551425,0.412724249,0.89261745,0.633333333,1.540758685
+1152,21188.07639,734.6111111,498.9722222,1103.055556,18380.89583,598.2569444,470.0486111,1739.576389,8776.555556,456.5763889,404.6041667,1833.916667,14016.18056,1150.083333,6204.673611,2701.680556,5108.173611,1125.25,344.9513889,2491.263889,9036.194444,1719.763889,143.5208333,437.0208333,11256.72222,408.9236111,116.9444444,7771.847222,9288.659722,1351.375,1057.3125,2787.506944,7322.166667,570.3958333,262.3402778,16929.42361,5692.756944,765.625,390.1527778,1308.354167,3568.888889,693.3472222,155.75,6155.166667,3279.097222,1120.451389,196.2152778,3181.840278,996.4375,312.9027778,144,16.06756608,11.71217918,0.684585041,0.953642384,0.6,0.878129335
+1153,18323.46196,738.3478261,462.9945652,1098.228261,13529.44022,575.951087,436.0978261,1647.25,6271.396739,434.9021739,385.6086957,1745.070652,10661.04348,1092.402174,4092.576087,1928.798913,3935.728261,1103.369565,328.6956522,2411.744565,7061.13587,6357.98913,133.3043478,437.7880435,8675.902174,461.4184783,113.1086957,7216.559783,7115.456522,1297.793478,779.1467391,2802.728261,5767.820652,610.8913043,245.9619565,11026.19565,4514.358696,685.5597826,370.7608696,1304.163043,2528.701087,621.7445652,146.8097826,4453.701087,2477.190217,1076.744565,157.9076087,3163.086957,1037.521739,313.4293478,184,18.32920759,13.11307439,0.698695065,0.93877551,0.681481481,0.422033082
+1154,44979.25926,913.2469136,580.308642,1155.012346,39752.7037,735.1728395,596.6419753,1788.209877,21964.54321,597,543.2716049,1804.91358,30519.32099,1334.740741,5666.876543,4170.666667,11136.49383,1408.580247,428.6666667,2691.91358,21740.5679,514.2592593,130.5555556,489.4691358,26712.34568,473.2345679,146.8641975,6860.530864,21154.18519,1684.54321,938.1481481,2816.259259,17153.71605,600.2222222,320.6419753,3804.82716,11447.14815,949.7037037,464.2098765,1316.814815,9753.469136,654.7283951,184.4074074,2490.098765,7728.308642,1342.82716,171.382716,3288.271605,213.2222222,310.4567901,81,14.44791462,7.374848022,0.859911133,0.91011236,0.642857143,-1.159749272
+1155,55033.62025,961.2531646,525.6455696,1166.126582,50261.8481,790.556962,680.2025316,1817.670886,28056.18987,642.8734177,506.9113924,1778.835443,38233.55696,1440.898734,6039.810127,3104.240506,14161.5443,1546.012658,448.4050633,2412.329114,26885.74684,474.0253165,141.7468354,445.1772152,33050.18987,465.7848101,143.9493671,3143.012658,26192.59494,1591.037975,673.5949367,2830.911392,21743.64557,651.8481013,341.6835443,2572.594937,15229.6962,905.6708861,504.8734177,1305.810127,12745.79747,666.6582278,187.6835443,1796.417722,9911.531646,1455.810127,151.2278481,3331.405063,229.721519,311.4177215,79,14.79053737,7.353099797,0.867665226,0.887640449,0.478787879,-1.120157629
+1156,22251.63333,795.1666667,476.4222222,1051.366667,21597.48889,647.9,523.4777778,1449.155556,10955.34444,521.0666667,508.0888889,1702.277778,15668.64444,1249.722222,3827.433333,3252.977778,6013.733333,1540.544444,368.0888889,2475.4,11320.7,373.4333333,928.4888889,473.2666667,13448.04444,378.8222222,125.6555556,2617,10390.27778,1479.577778,888.1333333,2794.788889,8914.044444,673,266.5333333,1712.977778,7376.544444,812.0444444,445.1666667,1336.944444,6058.488889,815.1777778,172.9111111,4963.7,4843.766667,1335.955556,164.1555556,3135.488889,367.0222222,312.9111111,90,12.97084415,9.45519216,0.684559117,0.841121495,0.511363636,0.107198523
+1157,43243.35338,888.0827068,473.1954887,1094.195489,37102.16541,750.1879699,794.5488722,1588.406015,21035.40602,603.962406,1028.909774,1810.218045,30429.94737,1431.218045,3530.037594,3274.684211,10823.58647,1447.225564,414.9473684,2694.172932,18329.53383,422.0902256,241.075188,739.112782,21891.21053,649.8571429,128.4360902,2629.112782,17702.14286,1688.383459,789.7744361,2814.654135,14893.81203,641.3082707,293.7142857,1937.330827,12152.3609,1096.345865,463.7894737,1318.428571,9341.451128,715.1954887,173.7443609,3004.150376,7907,1384.030075,279.6842105,3228.526316,521.3308271,313.6917293,133,15.52181169,11.44638674,0.67541392,0.910958904,0.633333333,-0.608272576
+1158,28977.85987,835.9171975,488.3057325,1068.66242,25186.04459,685.5732484,647.6369427,1445.649682,13741.58599,547.5477707,863.3375796,1767.55414,19905.84713,1283.55414,4449.012739,3338.649682,7182.866242,1306.732484,382.8535032,2623.350318,12493.97452,397.4267516,910.5732484,769.522293,14965.90446,474.8280255,167.3312102,3748.184713,11922.71975,1634.292994,793.6369427,2806.656051,10033.95541,629.4394904,267.8471338,2827.66879,8211.917197,1048.840764,424.7133758,1315.643312,6485.541401,871.9235669,169.5859873,4429.598726,5287.783439,1272.191083,276.3694268,3191.363057,533.1528662,314.3057325,157,19.11252882,11.83866111,0.785060671,0.830687831,0.516447368,-0.447169902
+1159,23378.60993,726.1347518,486.8156028,1057.141844,20587.50355,604.1843972,496.3404255,1552.843972,11722.23404,491.893617,473.7092199,1762.900709,16515.14894,1157.659574,5311.248227,3021.914894,5959.397163,1151.453901,367.0638298,2961.042553,11225.24823,5006.319149,1097.411348,514.0921986,12840.31206,390.5602837,109.751773,4851.340426,10610.55319,1417.503546,962.5957447,2791.191489,8906.524823,712.4893617,245.7304965,5615.141844,7263.546099,940.4255319,382.4609929,1335.489362,5447.687943,921.3900709,151.2907801,4616.631206,4540.425532,1189.503546,188.6453901,3118.836879,671.7943262,312.9787234,141,20.85182649,9.239498125,0.896470916,0.829411765,0.494736842,1.178250331
+1160,18954.13714,717.4,484.1028571,1076.491429,16718.12,581.1828571,470.7085714,1564.542857,9198.885714,459.6342857,399.8342857,1779.697143,13126.65714,1127.845714,5052.377143,2465.474286,4803.057143,1122.714286,343.1085714,2465.291429,8690.805714,8217.2,229.3314286,438.7714286,10331.84,429.6342857,115.8742857,5484.268571,8475.657143,1330.08,913.6457143,2788.222857,6884.994286,722.5371429,253.0285714,13490.14286,5506.611429,708.3885714,379.24,1316.777143,3991.537143,749.1828571,151.4685714,4161.005714,3397.725714,1123.748571,154.9314286,3169.194286,865.0457143,314.1657143,175,17.18867326,13.8773035,0.590070618,0.930851064,0.614035088,-1.330254998
+1161,21734.23429,877.12,909.8514286,1207.451429,19175.50286,685.7028571,904.6628571,2057.2,9984.531429,506.5771429,505.5771429,1979.834286,15130.16,1281.08,5712.045714,2943.28,5428.291429,1306.24,377.12,2506.502857,10159.81143,572.7542857,186.3085714,473.76,12364.46286,468.0857143,130.1657143,6712.68,10211.91429,1461.828571,802.52,2827.2,8347.52,591.6114286,303.2285714,24248.48,6580.874286,940.9771429,425.2571429,1356.274286,4641.6,922.1542857,168.0285714,5213.125714,4238.08,1284.788571,178.5714286,3308.102857,924.6685714,315.2342857,175,17.89061115,12.91152278,0.692213625,0.897435897,0.648148148,-0.368283558
+1162,15932.14163,694.9184549,424.4763948,1067.596567,11843.53648,548.2875536,501.7381974,1558.540773,5272.287554,416.5193133,488.3175966,1737.875536,9000.008584,1045.613734,3831.922747,1732.682403,3337.386266,1058.798283,325.4849785,3071.042918,5887.364807,4143.44206,787.3690987,478.0515021,7175.991416,398.9227468,106.8669528,4709.587983,5782.502146,1507.111588,694.416309,2788.540773,4649.991416,699.8583691,222.6094421,8011.154506,3477.06867,731.7381974,354.751073,1309.369099,1898.309013,726.0600858,144.9484979,4101.643777,1837.175966,1000.128755,160.8154506,3081.120172,1051.609442,316.2660944,233,19.93592999,15.36781628,0.637004279,0.928286853,0.728125,0.163517435
+1163,33283.38983,952.6101695,601.8644068,1125.124294,29904.27119,718.259887,546.6440678,1647.581921,16356.38418,596.3954802,708.6836158,1805.683616,22358.64972,1302.067797,7647.881356,4311.056497,8125.350282,1354.412429,397.7514124,2527.355932,15760.65537,396.819209,585.2146893,620.6045198,18794.40678,444.0960452,135.4971751,4910.672316,14986.12429,1597.824859,836.7457627,2806.090395,12658.16949,607.6384181,295.1468927,2980.59322,9714.542373,886.7062147,444.819209,1325.033898,7704.372881,758.6723164,175.8531073,3947.581921,6174.638418,1321.80791,220.8474576,3298.548023,282.4915254,314.7853107,177,19.18066396,12.40451497,0.76272768,0.907692308,0.614583333,-1.079159227
+1164,35126.95238,785.5952381,432.8571429,1085.547619,29841.7619,660.6190476,539.9761905,1451.380952,16940.07143,522.3333333,496.6904762,1744.761905,25039.42857,1264.119048,2923.238095,3109.404762,9132.452381,1320.857143,374.7619048,2496.190476,16991.57143,396.2857143,214.4285714,457.3571429,20285.80952,460.547619,133.4047619,2117.571429,16716,1479.333333,859.2380952,2811.119048,13960.57143,591.0952381,281.2380952,1715.857143,11461.61905,876,447.7619048,1314.738095,8675.071429,668.8571429,176.7380952,2531.309524,7633.97619,1331.952381,170.5952381,3245.5,450.6428571,311.952381,42,8.743482501,6.84161893,0.622673024,0.954545455,0.6,-0.099808022
+1165,33371.53403,795.6073298,471.0890052,1071.612565,28717.31414,666.4659686,911.8534031,1597.691099,16849.01571,539.9528796,1934.759162,1809.47644,23614.16754,1269.874346,6239.759162,3783.973822,8417.994764,1251.078534,369.2670157,5137.450262,16391.03141,1235.319372,229.3507853,1331.308901,19131.73298,453.9895288,126.7068063,3955.204188,15682.34555,1984.602094,706.2879581,2795.879581,13343.17801,683.3926702,271.026178,6120.465969,11008.50262,1401.816754,414.8324607,1311.764398,8019.026178,660.3717277,156.5235602,3858.04712,6803.848168,1309.120419,577.1413613,3199.722513,642.591623,314.9842932,191,17.6335189,14.39383644,0.577660635,0.955,0.561764706,-1.175455025
+1166,20818.648,711.064,487.024,1056.248,18876.6,599.168,869.528,1607.512,10702.248,482.848,885.872,1840.704,15159.76,1148.088,7799.856,4369.816,5474.888,1151.696,372.784,5392.016,9950.824,2654.92,666.2,742.16,11785.968,408.96,112.136,6809.144,9668.656,1595.528,831.96,2791.52,8034.136,584.304,248.424,7378.64,6671.136,1302.92,379.256,1362.072,5036.896,822.096,178.544,3792.384,4193.4,1169.16,193.264,3158.632,700.528,316.816,125,17.08242606,9.812057881,0.818578362,0.899280576,0.631313131,-0.076798076
+1167,18255.71429,752.1547619,530.8690476,1077.714286,15778.59524,611.8809524,707.9761905,1579.416667,8968.845238,486.5,751.5119048,1806.27381,12717.60714,1165.678571,8858.25,4853.166667,4623.47619,1155.785714,341.4404762,4159.571429,8457.535714,1041.464286,120.5952381,749.3571429,9930.702381,397.2857143,118.5119048,8157.857143,8319.107143,1600.166667,870.6071429,2778.77381,6826.5,563.6071429,259.7738095,19303.90476,5691.583333,1040,392.1785714,1312.071429,4293.928571,702.6190476,159.9285714,4842.809524,3629.714286,1196.142857,256.8571429,3222.559524,755.6071429,313.4642857,84,14.34008842,8.226882282,0.819066802,0.923076923,0.622222222,-0.298664988
+1168,34753.33333,826.3472222,495.6944444,1069.819444,31819.48611,667.25,737.6805556,1569.75,17485.08333,566.3194444,523.0972222,1735.402778,24404.70833,1268.666667,7137.847222,3344.958333,8965.416667,1342.875,393.7777778,2404.486111,17161.65278,473.1388889,206.0138889,448.8055556,20887.70833,607.7361111,129.8888889,4232.972222,16524.27778,1478.819444,892.8055556,2805.444444,14016.15278,590.5,285.6805556,1906.305556,10979.31944,876.5277778,442.9861111,1302.875,8709.041667,691.75,182.9444444,6384.152778,7100.944444,1333.041667,185.9583333,3201.611111,305.2638889,313,72,10.26687079,9.063323523,0.46979846,0.96,0.72,-0.727893966
+1169,35234.02752,829.7155963,481.8623853,1072.357798,32042.46789,680.3944954,578.5504587,1525.752294,17143.77064,553.4036697,572.5412844,1759.834862,24388.91743,1316.027523,5212.119266,2986.816514,8930.724771,1365.513761,386.559633,2474.908257,17309.53211,426.4311927,384.2844037,498.7798165,19820,521.0091743,131.2201835,3291.055046,15946.10092,1573.678899,1008.110092,2808.651376,13187.0367,661.7614679,287.5321101,1945.422018,10861.3578,982.3394495,460.1009174,1306.715596,8386.807339,714.8807339,177.853211,3551.247706,6938.688073,1351.587156,143.587156,3170.844037,465.9724771,313.8623853,109,12.75911385,11.2539485,0.471189243,0.956140351,0.648809524,-1.266367381
+1170,33018.77528,918.8764045,487.988764,1077.393258,29308.11236,723.3595506,705.7752809,1542.662921,16275.74157,582.8988764,494.9325843,1732.505618,22596.65169,1341.05618,4088.438202,3083.280899,8447.617978,1349.685393,386.0337079,2486.966292,15362.21348,430.3595506,119.3258427,494.1123596,17949.7191,398.8539326,124.8539326,3378.516854,14341.85393,1511.707865,819.4831461,2798.033708,12256.52809,733.2134831,290.9101124,2555.382022,10093.04494,876.1460674,452,1312.370787,7577.977528,660.0224719,177.7191011,3845.651685,6216.47191,1334.089888,376.4269663,3273.146067,573.9662921,313.8988764,89,12.6192128,9.772155415,0.632712132,0.87254902,0.570512821,0.95922059
+1171,33888.34286,1141.757143,525.9285714,1073.4,28089.37143,829.2142857,764,1484.2,16581.57143,622.1142857,584.8857143,1712.185714,22039.77143,1385.257143,3756.6,2371.614286,8333.371429,1290.842857,359.7571429,2433.5,15656.25714,481.0285714,107.7857143,562.2142857,19028.45714,363.8,113.1428571,2844.385714,15017.48571,1511.7,600.2285714,2788.214286,12632.18571,559.4428571,246.2,1903.071429,10336.6,785.0571429,403.8857143,1307.542857,7937.328571,588.3857143,152.9571429,1099.714286,6244.014286,1214.628571,191.4714286,3370.2,600.6714286,313.5142857,70,10.86536115,8.769209148,0.590442922,0.972222222,0.583333333,0.198606987
+1172,21747.7459,740.3360656,463.5737705,1083.352459,18735.67213,606.057377,466.3852459,1642.434426,10947.5082,484.9180328,377.9262295,1842.508197,15216.58197,1153.54918,5348.434426,3860.106557,5579.909836,1158.5,344.6803279,2470.836066,10117.85246,2929.04918,114.204918,436.6147541,11828.19672,394.5491803,114.0327869,5273.467213,9789.360656,1290.237705,854.7786885,2794.237705,8295.672131,570.7868852,248.4344262,8906.565574,6800.254098,756.4016393,387.9836066,1305.459016,5057.377049,711.8196721,150.7377049,2481.254098,4255.262295,1165.803279,147.7213115,3183.02459,729.5901639,312.8852459,122,16.12414719,10.30353881,0.769195979,0.884057971,0.652406417,1.521041272
+1173,24866.97674,795.9922481,521.8604651,1088.767442,21380.21705,636.5348837,1045.767442,1660.410853,12486.48837,529.4883721,1320.984496,1789.612403,17240.84496,1208.612403,7995.434109,4485.689922,6207.410853,1216.596899,364.9534884,5237.713178,11625.0155,648.4186047,128.9844961,664.5348837,13709.96899,406.5581395,116.9689922,7027.162791,11535.42636,1666.170543,944.379845,2775.852713,9628.596899,577.6899225,265.8837209,11798.07752,7772.596899,1090.968992,401.0077519,1350.054264,5878.984496,794.6356589,154.9379845,4415.937984,5059.48062,1241.031008,237.9379845,3168.465116,745.4418605,314.8062016,129,15.6514253,11.27484206,0.693588336,0.941605839,0.708791209,-1.105561002
+1174,36241.49333,1102.253333,577.1466667,1099.626667,31099.50667,804.0133333,542.2266667,1569.44,17468.69333,664.72,491.9333333,1721.96,24412.22667,1451.693333,2518.68,2724.573333,8397.893333,1447.88,409.0933333,2414.6,16536,452.1333333,820.84,502.9866667,19494,424.52,137.5733333,2478.053333,15702.6,1662.773333,872.2266667,2851.56,13132.25333,682.68,313.92,1699.146667,10464.46667,989.24,470.04,1334.16,8079.84,933.8133333,190.7066667,4164.44,6619.626667,1427.466667,154.4266667,3348.253333,386.5333333,313.9466667,75,10.80100421,10.26166097,0.312050689,0.914634146,0.619834711,1.511817742
+1175,25446.28272,1169.879581,628.8848168,1089.188482,22132.29319,744.4712042,824.7591623,1511.308901,12336.93194,621.3874346,822.3612565,1747.314136,17357.69634,1340.979058,7845.141361,3272.418848,6130.549738,1351.837696,396.2251309,2800.471204,11678.74869,631.5287958,790.4712042,665.5026178,13334.47644,440.0628272,135.486911,2478.701571,10872.15183,1753.471204,819.4293194,2816.73822,9205.685864,609.7643979,269.104712,1563.973822,7503.806283,1122.780105,435.2513089,1320.099476,5744.73822,797.7434555,169.2041885,2518.78534,4809.21466,1265.774869,151.2094241,3406.277487,406.7486911,316.7853403,191,19.52804819,12.55549916,0.765910707,0.964646465,0.702205882,0.74899377
+1176,21764.40336,752.2016807,501.9201681,1083.201681,18199.71849,609.2142857,647.5588235,1638.710084,10477.37395,487.4243697,425.710084,1818.382353,14890.20168,1152.365546,5140.647059,3348.554622,5410.87395,1172.029412,345.9327731,2685.554622,9782.592437,6022.079832,120.2983193,465.289916,11424.95378,426.4033613,112,6701.739496,9613.323529,1380.033613,871.1008403,2787.390756,7907.42437,701.8109244,262.9957983,17244.52101,6483.478992,794.697479,390.987395,1327.134454,4909.92437,770.9747899,155.7226891,3346.403361,4077.638655,1198.323529,152.3193277,3238.063025,768.7352941,319.2058824,238,21.8543927,14.95027028,0.729401953,0.871794872,0.62962963,0.317147066
+1177,17597.64286,689.352381,410.9714286,1039.7,15133.51429,573.8285714,394.4333333,1478.047619,8435.066667,455.2904762,365.6619048,1764.790476,12122.52381,1078.652381,4392.557143,1946.942857,4341.795238,1118.966667,365.3428571,2469.980952,7881.509524,1038.838095,1474.228571,446.5142857,9372.095238,359.7190476,111.552381,3671.504762,7704.37619,1333.4,677.547619,2792.947619,6225.247619,552.1619048,246.152381,11908.78571,5052.709524,736.1952381,367.2571429,1351.319048,3630.209524,1081.219048,146.6952381,3360.504762,3185.642857,1106.971429,183.752381,3115.466667,835.8761905,315.1571429,210,20.62086707,13.08020869,0.773071375,0.933333333,0.714285714,-1.562426924
+1178,38293.84,915.25,581.12,1153.06,35206.77,746.97,535.16,1775.45,19501.51,602.04,500.73,1835.08,26822,1360.77,7197.89,5116.81,10074.52,1421.84,415.52,2425.5,19245.55,828.19,152.27,447.01,22854.11,458.77,134.65,5099.91,18158.38,1549.13,910.69,2841.59,15293.59,953.6,320.15,3028.88,11282.98,851.22,465.67,1321.75,9232.59,652.04,184.45,3358.73,7200.13,1381.93,182.99,3323.07,253.07,314.29,100,12.3841803,10.72231684,0.50037714,0.934579439,0.699300699,-1.478480692
+1179,40922.91813,928.3450292,593.6666667,1134.192982,36506.2807,760.2748538,841.8070175,1694.274854,20306.70175,607.6023392,1542.152047,1784.385965,27894.8538,1395.315789,7943.701754,4435.900585,10355.32749,1432.77193,427.8479532,2597.982456,19909.09357,651.3684211,327.1520468,838.4561404,23432.66667,471.4619883,141.9298246,4147.795322,18501.94737,1965.847953,888.8304094,2811.502924,15896.16959,637.6081871,314.3274854,1887.777778,12399.75439,1204.356725,485.5380117,1319.263158,9707.754386,750.6900585,188.8654971,6695.233918,7971.906433,1416.280702,239.5789474,3302.619883,322.9824561,315.5730994,171,21.08866985,10.95961931,0.854353507,0.863636364,0.626373626,-1.365538422
+1180,26789.51064,924.6595745,482.7588652,1074.680851,22876.48227,691.106383,777.6666667,1573.035461,13189.55319,564.8085106,899.5035461,1816.588652,18139.12766,1275.652482,4670.304965,2455.361702,6607.191489,1213.092199,364.6879433,3231.205674,12606.42553,6316.921986,390.3120567,907.6879433,15053.2695,448.8865248,115.7943262,4027.666667,11983.43972,1580.085106,662.4822695,2791.106383,10249.11348,598.2269504,255.6453901,3065.48227,8234.141844,945.1843972,398.6666667,1340.028369,6185.64539,715.6382979,154.8085106,2207.014184,5246.553191,1239.865248,592.6099291,3361.382979,613.6524823,317.1276596,141,16.117414,11.56390334,0.69658031,0.898089172,0.626666667,-0.678475785
+1181,28396.41379,819.6034483,642.8793103,1148.12069,24342.67241,644.3103448,717.0344828,1833.172414,13875.55172,508.8448276,403.2068966,1908.051724,19782.32759,1200.5,4026.948276,2393.241379,7071.724138,1212.327586,374.5517241,2437.931034,12899.75862,1736.896552,339.2931034,457.6724138,15487.44828,423.7068966,119.5344828,4828.87931,12908.5,1375.172414,1202.62069,2932.224138,10476.67241,561.2241379,270.3275862,8512.5,8151.793103,764.8448276,398.5344828,1317.051724,5940.655172,919.362069,155.4482759,4134.672414,5195.844828,1230.655172,132.3275862,3294.724138,887.862069,314.0517241,58,9.815418965,7.547550413,0.639310882,0.950819672,0.725,-0.244978663
+1182,17195.12057,708.8865248,486.4964539,1052.77305,13377.70922,575.8156028,551.0638298,1649.099291,5458.12766,430.9432624,620.3475177,1767.985816,9580.404255,1062.638298,6905.319149,3396.893617,3387.553191,1085.262411,318.4326241,3710.141844,6000.51773,4047.695035,136.4113475,723.7588652,7201.113475,459.2695035,112.7446809,9191.212766,5724.737589,1595.262411,800.6099291,2796.737589,4484.858156,538.141844,218.8085106,5511.723404,3235.609929,829.6950355,356.0496454,1283.780142,1635.638298,564.3546099,140.1134752,4025.503546,1688.588652,997.7304965,242.4751773,3063.58156,1080.673759,316.7801418,141,16.03163039,11.33499555,0.70717408,0.965753425,0.671428571,0.854841338
+1183,39635.22642,873,541.1603774,1127.660377,36518.96226,705.7830189,494.8113208,1654.132075,20259.37736,584.1886792,548.3396226,1817.669811,27830.66038,1314.537736,6652.471698,4107.103774,10609.60377,1395.301887,404.6603774,2404.858491,19887.89623,411.1981132,185.1509434,586.745283,24269.49057,461.0943396,130.3679245,3844.877358,18992.48113,1568.113208,846.4528302,2824.603774,15942.79245,625,313.0471698,3004.726415,12141.95283,905.0754717,460.9339623,1303.235849,9903.54717,664.4433962,177.6698113,3079.226415,7743.584906,1348.726415,185.3773585,3299.377358,265.9150943,315.8490566,106,13.69939684,9.908898164,0.690524417,0.954954955,0.679487179,-1.04159116
+1184,18835.48163,714.0571429,474.8326531,1043.155102,16508.73878,584.122449,703,1604.963265,9587.897959,470.0244898,1033.934694,1831.465306,13679.86122,1155.326531,7808.567347,4219.677551,4956.771429,1151.84898,334.477551,4984.118367,8997.726531,2634.518367,101.6693878,798.8938776,10581.48571,404.4612245,111.3346939,6500.542857,8725.526531,1595.265306,863.3836735,2843.616327,7401.946939,678.6612245,244.8326531,7408.963265,6019.604082,1047.302041,374.0612245,1310.591837,4547.693878,672.0204082,158.7346939,3425.726531,3815.285714,1134.889796,271.2857143,3151.004082,714.2693878,321.3510204,245,20.21604221,16.33924456,0.588864711,0.904059041,0.586124402,0.489770825
+1185,19907.08293,774.3268293,640.2487805,1119.892683,17015.23415,617.2731707,674.5121951,1747.721951,8110.404878,467.1219512,642.7512195,1786.902439,13272.76098,1168.073171,5676.15122,2601.37561,4805.131707,1185.180488,350.9317073,3074.858537,8671.390244,1320,517.897561,517.0731707,10862.23415,444.0439024,118.9463415,6130.970732,8909.04878,1531.395122,848.7268293,2809.897561,7141.912195,582.1073171,266.3073171,18436.26829,5497.8,880.804878,389.4390244,1331.809756,3391.834146,726.3707317,156.7414634,5931.063415,3224.478049,1149.84878,220.5804878,3226.15122,1010.2,319.4390244,205,17.96465411,14.87331895,0.560844362,0.923423423,0.669934641,-1.01664163
+1186,37615.18644,847.9830508,562.4237288,1101.146893,34115.84181,694.8079096,921.0734463,1660.265537,19124.33333,572.2485876,1539.59887,1892.80226,26737.44633,1298.451977,6914.084746,5767.734463,9793.135593,1355.011299,399.0903955,2610.457627,18668,1019.548023,138.5875706,618.5762712,22202.77966,1805.175141,134.9378531,4279.062147,17764.27119,1493.180791,806.7966102,2810.451977,14911.41243,785.559322,300.960452,3076.824859,10657.76836,1299.361582,454.4011299,1304.740113,8898.819209,638.1920904,174.9096045,3832.107345,6957.463277,1320.271186,238.7627119,3212.355932,239.5706215,319.4350282,177,16.58055012,14.19039805,0.517230671,0.889447236,0.7375,-0.171660041
+1187,41882.85714,907.1587302,512.968254,1095.174603,35530.60317,712.9365079,577.1428571,1598.190476,20460.22222,599.3968254,481.015873,1773.888889,28709.96825,1323.873016,4672.142857,2671.84127,10109.93651,1427.714286,401.8571429,2446.587302,19802.34921,666.3015873,241.3174603,445.7301587,23462.61905,435.7142857,135.984127,4334.222222,19088.5873,1567.714286,958.7619048,2826.365079,16079.11111,628.6825397,310.0634921,1884.650794,12672.60317,892.3015873,473.4126984,1303.063492,9816.253968,729.2698413,182.7142857,6830.269841,8443.968254,1419.015873,161.8412698,3407.936508,343.1111111,318,63,11.44840756,7.374769627,0.764878752,0.984375,0.715909091,-0.454005106
+1188,42206.83673,916.3877551,496.8163265,1090.673469,36226.12245,722.8367347,581.7959184,1608.061224,20683.69388,606.244898,451.4693878,1742.77551,29073.2449,1392.836735,6196.44898,2731.77551,10517.34694,1449.142857,410.0204082,2419.653061,20355.73469,430.6326531,543.755102,451.1632653,24147.32653,422.0816327,140.3061224,4317.489796,19637.42857,1586.204082,846.2857143,2810.653061,16450.20408,648.0408163,320.6938776,1602.714286,13415.97959,909.244898,482.4081633,1320.77551,10251.91837,843.3673469,200.8367347,2990.877551,8881.571429,1473.836735,226.8979592,3318.918367,357.3469388,315.0204082,49,8.979912654,6.978104809,0.629402624,1,0.680555556,-1.103477222
+1189,30891.11594,1042.811594,610.2318841,1113.971014,25966.69565,795.1884058,570.6521739,1510.289855,14638.36232,640.115942,572.2898551,1729.434783,22082.18841,1519.405797,4165.072464,2800.536232,7906.710145,1457.550725,430.9565217,2482.73913,14188.28986,433.4927536,878.6811594,484.9710145,17261.92754,489.7826087,144.4782609,2835.376812,14160.28986,1642.84058,870.8115942,2820.217391,11990.95652,679.9565217,306.5362319,1764.536232,9704.710145,924.9855072,471.8115942,1322.666667,7315.782609,854.5797101,189.115942,3699.913043,6614.695652,1427.043478,295.0289855,3352.173913,438.7536232,316.7246377,69,11.02254569,8.377000889,0.649937271,0.907894737,0.627272727,0.440183715
+1190,24713.07143,809.1309524,500.4761905,1068.797619,21900.21429,692.0595238,722.1904762,1479.619048,11799.95238,539.452381,732.7619048,1767.321429,17346.44048,1324.940476,6101.880952,3528.595238,6143.380952,1319.416667,434.952381,2774.25,11713.88095,972.8452381,1088.869048,811.4761905,13833.33333,400.0833333,131.25,3040.357143,10787.27381,1805.238095,916.0952381,2804.083333,9063.964286,656.9404762,270.0357143,1918.904762,7338.488095,1047.952381,435.9404762,1348.988095,5660.285714,947.2857143,173.8095238,4294.154762,4756.440476,1308.321429,405.2380952,3174.821429,499.8571429,317.4880952,84,11.61820457,9.407340118,0.58683454,0.954545455,0.636363636,-0.676563696
+1191,41934.88421,1088.031579,512.5263158,1120.242105,34899.93684,797.4736842,801.3684211,1599.778947,20374.97895,637.4210526,1229.684211,1797.663158,27976.29474,1465.2,3862.757895,2998.421053,9907.094737,1386.978947,403.9684211,2435.252632,16802.63158,447.5578947,104.8842105,824.1684211,19566.31579,393.5263158,136.7263158,2250.263158,15552.73684,2060.631579,607.5263158,2791.989474,13115.77895,607.4947368,275.9368421,1546.231579,10421.62105,1163.642105,424.4842105,1313.757895,7789.073684,609.3789474,161.0105263,1192.473684,6242.242105,1261,138.4210526,3331.168421,590.8526316,318.0947368,95,13.08962063,9.472520578,0.690149786,0.95959596,0.659722222,-0.750067909
+1192,16531,676.9285714,406.1071429,1051.916667,14649.79762,558.8809524,452.047619,1496.77381,8160.047619,455.8452381,427.1071429,1758.178571,11503.36905,1088.845238,3148.630952,2148.916667,4259.761905,1112.202381,324.9047619,2875.880952,7858.035714,7251.047619,163.3809524,446.1785714,9174.142857,410.3571429,105.4047619,3068.142857,7740.452381,1301.97619,786.3095238,2783.857143,6600.857143,741.4404762,234.7142857,5080.869048,5332.642857,758.8333333,370.2857143,1309.702381,3978.654762,636.7738095,146.3690476,3095.345238,3303.047619,1131.583333,127.6428571,3118.428571,689.4761905,317.6904762,84,13.11462962,8.257047023,0.776914746,0.933333333,0.583333333,0.800996248
+1193,40525.08475,886.9152542,524.0169492,1164.050847,36981.94915,706.9152542,484.1355932,1736.135593,20375.28814,587.9491525,497.0338983,1788.101695,28148.10169,1317.389831,5403.508475,4585.508475,10287.08475,1419.830508,412.3728814,2404.20339,20132.27119,421.1694915,120.3898305,425.8135593,24588.91525,418.6271186,146.4237288,3770.118644,19284.62712,1478.322034,732.3220339,2803.152542,15886.94915,613.1355932,318.2372881,4117.932203,11022.9322,864.8983051,463.7457627,1326.864407,9351.118644,645.8135593,180.5932203,2145.254237,7256.254237,1373.898305,181.779661,3301.169492,220,316.8983051,59,10.87740457,7.122986676,0.755765384,0.921875,0.614583333,1.296399109
+1194,16722.02703,1309.662162,580.1351351,1048.405405,16505.33784,804.7972973,425.2027027,1406.162162,7947.743243,672.4324324,473.5135135,1718,9851.864865,1307.175676,4559.513514,2202.864865,3938,1278.864865,350.8243243,2381.391892,7510.72973,427.1351351,287.0405405,419.2162162,7874.567568,368.3378378,115.5945946,3804.810811,5975.283784,1390.324324,779.4054054,2787.054054,5266.891892,617.9054054,249.8378378,1446.297297,4228.216216,753.3108108,386.0945946,1280.905405,3794.364865,615.8648649,150.8513514,2381.243243,2539.148649,1118.743243,185.6891892,3503.094595,351.0945946,319.8918919,74,13.30645718,7.591775571,0.82127454,0.891566265,0.528571429,0.448319989
+1195,14589.34783,797.173913,579.1521739,1066.065217,14508.52174,651.5869565,948.7391304,1452.652174,7003.217391,518.2826087,1536.652174,1811.434783,10500.71739,1246.413043,6325.043478,6585.195652,4191.826087,1269.478261,361.6521739,2778.782609,7886.282609,364.8478261,1255.326087,837.4347826,8820.086957,1651.891304,119.8043478,3954.152174,6919.23913,1659.326087,1095.108696,2827.804348,6146.326087,809.5652174,259.2826087,2106.108696,5126.347826,1221.695652,415.2826087,1310.413043,4327.73913,890.2173913,173.6956522,5173.73913,3322.934783,1293.391304,563.9782609,3269.456522,446.2391304,317.173913,46,9.556289706,7.038418206,0.676413521,0.901960784,0.567901235,0.560453731
+1196,49286.82927,1034.414634,516.4390244,1139.878049,42122.63415,796.2195122,858.902439,1671.707317,25173.80488,651.1219512,1140.902439,1819.585366,34858.41463,1553.780488,5101.121951,3387.292683,11896.56098,1466.95122,413.097561,2458.121951,24353.87805,500.8292683,130.5365854,711.5121951,28795.14634,529.3902439,154.5609756,2718,23125.53659,2260.195122,712.3414634,2846.609756,19654.36585,690.5609756,330.6097561,1629.414634,15975.04878,1191.390244,509.9756098,1323.97561,11609.2439,688.2926829,180.9268293,1908.292683,10168.12195,1520.902439,166.7560976,3334.439024,583.1463415,315.6829268,41,7.837443725,7.354364077,0.345652469,0.953488372,0.640625,-0.167847754
+1197,23998.57692,799.7179487,589.6794872,1110.833333,20540.30769,649.5,874.3205128,1833.987179,9731.910256,473.0128205,1788.320513,1842.730769,16173.89744,1195.269231,7620.564103,4678.128205,5799.987179,1197.615385,363.2307692,3529.871795,10692.62821,539.2435897,186.5512821,1068.551282,13359.28205,433.6538462,121.8589744,10927.47436,10838.39744,1879.615385,823.9871795,2812.141026,8650.615385,596.1282051,290.4230769,24556.05128,6751.974359,1124.435897,398.0128205,1339.269231,4024.025641,776.7307692,156.1538462,8061.653846,3959.910256,1173.166667,390.0384615,3240.230769,1022.679487,317.6666667,78,11.20051557,9.889068935,0.469538609,0.906976744,0.644628099,-0.216874632
+1198,40650.72566,980.9557522,523.7079646,1132.477876,33850.10619,791.1681416,703.2654867,1629.433628,19209.19469,625.2477876,618.8849558,1793.672566,26972.02655,1471.840708,5072.495575,3546.849558,9180.929204,1447.106195,422.5752212,2462.327434,17636.51327,463.1504425,1426.044248,525.7610619,20822.09735,428.2566372,138.4247788,2242.230088,16684.78761,1691.690265,822.5221239,2824.964602,14130.46903,704.8318584,311.9026549,2314.176991,11454.87611,989.6902655,477.0176991,1355.584071,8596.477876,956.4778761,184.4336283,2661.274336,7228.831858,1401.39823,414.8495575,3323.132743,549.7876106,320.619469,113,15.89061122,9.264469589,0.812461169,0.918699187,0.627777778,-0.475529473
+1199,19815.75962,1002.644231,523.7692308,1058.067308,18280.20192,722.4903846,802.6442308,1422.375,9600.682692,597.9230769,639.5,1742.009615,13332.78846,1328.903846,3080.182692,2583.980769,4890.951923,1268.807692,365.4903846,2465.875,9634.596154,404.5576923,531.8557692,528.0288462,11091.47115,390.0096154,141.75,3109.596154,8646.836538,1542.048077,836.6153846,2817.634615,7597.701923,813.7692308,261.8846154,3711.567308,6299.5,836.0576923,425.0096154,1323.615385,4959.605769,744.5384615,169.0096154,2959.923077,3974.336538,1253.125,711.7788462,3390.528846,562.625,318.5288462,104,14.22748207,10.11130641,0.703506932,0.818897638,0.619047619,1.136357548
+1200,40651.30097,888.407767,537.8349515,1160.330097,36480.33981,726.6699029,633.7864078,1771.456311,20312.48544,595.5242718,632.3592233,1796.941748,28564.90291,1334.38835,5697.660194,4242.699029,10523.34951,1398.514563,413.961165,2855.912621,20233.68932,755.815534,128.0679612,605.3398058,24868.50485,430.6893204,139.7184466,4411.961165,19727.06796,1683.893204,759.1650485,2806.941748,16128.96117,601.0776699,317.5048544,4523.242718,10748,903.7961165,451.184466,1311.543689,9225.504854,641.5436893,179,2392.456311,7476.68932,1350.029126,223.6601942,3233.796117,210.2524272,319.8446602,103,15.11950952,8.929860342,0.806951002,0.927927928,0.572222222,1.029769529
+1201,25639.63636,800.5561497,581.1176471,1118.636364,24412.3369,635.0855615,446.6791444,1643.84492,13073.54545,529.5508021,507.7379679,1785.914439,18404.25668,1206.582888,6720.636364,6429.828877,6968.550802,1307.614973,373.1925134,2397.005348,13153.2246,381.1336898,107.1497326,436,15546.53476,397.4117647,123.5721925,5088.352941,12289.39572,1405.385027,894.8449198,2803.395722,10326.81283,589.8983957,286.3048128,6095.962567,7332.780749,856.2085561,419.3636364,1318.572193,6239.272727,604.5294118,164.171123,3991.743316,4797.625668,1251.545455,228.6042781,3207.122995,226.0320856,324.8609626,187,18.63587695,14.52910506,0.62623933,0.813043478,0.519444444,-1.196111619
+1202,53422.9,948.5,546.975,1145.125,46082.375,756.075,738.375,1764.8,26482.15,639.8,924.475,1761.9,37054.675,1401.975,6249.275,4665.025,13173.1,1511.65,435.9,2424.15,25692.075,455.875,161.25,615.775,32037.7,844.575,149.6,3572.675,25533.725,1672.25,882.975,2849.525,21819.5,659.5,350.7,1706.15,17108.825,1075.45,495.35,1287.625,13189.325,686.075,193.1,2827.425,10914.075,1467.775,147.6,3265.5,291.35,318.9,40,8.486729739,6.281354817,0.672454538,0.975609756,0.555555556,-1.038649193
+1203,27177.16981,958.6320755,476.3018868,1060.433962,26024.40566,728.8301887,517.9622642,1505.54717,13765.60377,570.5660377,494.2641509,1731.584906,19360.14151,1318.188679,4186.537736,2304.443396,6493.622642,1221.764151,352.6132075,2549.396226,12527.74528,1785.839623,332.4811321,497.5754717,14852.58491,371.6886792,123.1886792,4324.632075,11701.92453,1384.773585,650.9339623,2785.188679,9888.075472,575.3301887,247.5566038,3581.339623,8097.103774,809.3207547,389.1886792,1296.301887,6074.707547,667.8207547,153.4811321,1873.45283,5072.150943,1251.283019,920.2075472,3243.367925,623.6037736,321.1037736,106,12.81036888,11.15257958,0.492009126,0.876033058,0.627218935,-0.922964987
+1204,36991.81395,917.627907,481.1976744,1088.616279,32608.54651,731.2790698,585.4069767,1535.627907,17889.59302,588.6395349,585.744186,1778.895349,26111.2093,1352.465116,4347.151163,3361.372093,9156.837209,1369.895349,387.1511628,2469.011628,17856.61628,422.2674419,229.9069767,501.4418605,21336.63953,473.2325581,133.7906977,3322.627907,17194.81395,1563.081395,860.8372093,2820.093023,14509.26744,641.2325581,286.8023256,1753.732558,11912.02326,1014.162791,449.0232558,1319.290698,9065.55814,668.2790698,176.0348837,2495.534884,7761.290698,1336.662791,178.6627907,3287.697674,454.2209302,320.8604651,86,15.62785426,8.097000044,0.85531196,0.811320755,0.441025641,-0.953309297
+1205,30315.53623,1155.434783,514.2173913,1078.405797,26208.47826,829.826087,839.5217391,1487.434783,14146.11594,681.2898551,1408.521739,1842.115942,19740.88406,1428.405797,2750.956522,2578.347826,6776.753623,1356.217391,393.6231884,2567.202899,13131.43478,468.8985507,718.9710145,1417.608696,16066.42029,389.2173913,396.4492754,1595.724638,12611.46377,2080.231884,678.7101449,2786.811594,10601.55072,611.2753623,265.2173913,1525.869565,8879.101449,1102.985507,440.0724638,1329.826087,6828.84058,784.6666667,173.8405797,1985.318841,5716.144928,1299.73913,244.0434783,3321.927536,540.115942,319.6666667,69,12.17812556,7.188283076,0.807211827,0.985714286,0.784090909,-1.128020679
+1206,39796.79121,870.989011,429.5824176,1091.197802,34038.03297,718.1098901,702.9230769,1573,19544.40659,556.6593407,1336.461538,1736.505495,27658.79121,1384.417582,2649.384615,3099.67033,9595.406593,1318.208791,391.0549451,3005.703297,18595.24176,501.1098901,212.021978,1178.857143,22004.14286,391.5164835,236.4835165,1829.296703,17803.59341,1652.615385,644.0549451,2813.131868,15083.3956,600.8791209,279.2637363,2376.956044,12430.62637,998.978022,415.4395604,1314.538462,9167.846154,666.5714286,167.7582418,2106.076923,7637.835165,1377.263736,477.6593407,3150.648352,634.3406593,323.9120879,91,15.67722406,7.775859363,0.868324116,0.947916667,0.56875,0.493545452
+1207,24054.91463,785.195122,505.8414634,1101.109756,19942.43902,634.1463415,730.9878049,1752.939024,11786.19512,495.3536585,993.9634146,1925.219512,16343.10976,1209.036585,7634.682927,3926.54878,5862.170732,1206.865854,356.5853659,6039.207317,11017.13415,817.3780488,186.9878049,961.1463415,12861.93902,392.9756098,118.402439,5166.780488,11076.58537,1808.939024,745.8902439,2783.060976,9219.865854,576.2195122,271.5487805,17380.07317,7464.768293,1076.47561,392.1707317,1341.45122,5653.390244,801.9146341,166.7804878,4733.865854,4830.365854,1246.02439,342.6463415,3233.621951,758.8170732,322.804878,82,13.12451969,9.269277173,0.707956054,0.891304348,0.496969697,0.065898745
+1208,30954.68085,842.5460993,569.6312057,1139.907801,25871.56738,677.4822695,678.0851064,1791.553191,13506.40426,502.7234043,1351.163121,1823.269504,20684.19858,1250.829787,6397.12766,2887.900709,7404.078014,1239.978723,366.7588652,3336.255319,13466.99291,695.212766,189.6808511,931.9929078,15815.55319,439.6170213,124.3404255,4709.184397,13307.96454,1549.595745,734.0283688,2825.744681,10805.03546,569.6453901,294.5390071,24768.39716,8254.510638,994.1985816,415.893617,1343.843972,5655.659574,927.3333333,161.4042553,4378.879433,5086.808511,1239.170213,195.3475177,3259.879433,946.6808511,322.0780142,141,14.09069369,13.36059195,0.317717152,0.921568627,0.671428571,1.201075767
+1209,19331.55245,764.4475524,571.2867133,1113.643357,16735.9021,606.7832168,469.8111888,1755.769231,7563.741259,453.048951,489.6223776,1806.636364,12730.07692,1156.748252,6104.454545,3450.188811,4702.13986,1145.062937,336.0839161,2613.573427,8400.895105,1020.216783,154.8041958,494.8671329,10333.5035,430.4265734,121.027972,9890.664336,8459.006993,1413.909091,997.041958,2814.769231,6731.524476,550.5874126,266.7202797,24549.87413,5269.041958,772.3706294,382.7762238,1327.636364,3075.804196,758.6153846,153.2657343,8102.48951,2965.027972,1120.405594,227.8041958,3194.741259,1027.51049,324.8181818,143,19.82051219,10.03426831,0.862382799,0.89375,0.467320261,-0.812306764
+1210,19311.83333,731.1666667,511.2407407,1078.111111,12415.37037,536.9722222,506.7592593,1531.518519,5588.435185,413.2407407,561.1759259,1726.12963,9754.166667,1047.416667,6223.425926,3243.564815,3488.37037,1065.898148,318.3888889,3694.740741,6457.796296,5456.518519,230.0277778,585.8703704,7972.768519,403.5740741,113.6296296,8786.305556,6405.583333,1681.777778,734.3703704,2788.5,5114.407407,509.7685185,246.8240741,14646.84259,3915.555556,812.5740741,348.1944444,1315.453704,2035.361111,598.2407407,145.0740741,5806.712963,2073.296296,1008.546296,269.8981481,3136.657407,1068.296296,320.462963,108,16.08694661,8.932163055,0.831688229,0.931034483,0.75,-1.527030175
+1211,19632.41711,774.4705882,504.0320856,1079.823529,10776.04278,520.8449198,531.5561497,1383.941176,4199.144385,457.855615,636.2192513,1687.144385,7773.898396,991.3796791,4844.962567,1860.727273,2866.208556,1009.278075,302.486631,2831.213904,5155.59893,357.171123,1255.374332,621.6256684,6225.962567,408.0427807,102.1657754,3254.42246,4869.15508,1675.229947,572.4278075,2790.786096,3837.791444,582.1069519,206.7593583,2250.411765,2846.080214,805.1497326,332.5775401,1282.716578,1379.347594,847.2566845,141.8716578,2588.026738,1497.15508,928.3582888,1438.406417,3015.802139,1104.096257,322.1604278,187,18.62987693,12.97977652,0.717344817,0.939698492,0.703007519,1.562597904
+1212,24051.20635,728.5714286,545.4603175,1127.555556,21981.87302,610.5714286,427.8730159,1668.47619,11421.03175,489.031746,787.3968254,1844.857143,17465.49206,1109.444444,5154.68254,3523.174603,6191.015873,1181.015873,351.1428571,2811.365079,12070.28571,7296.793651,140.7936508,668.7460317,14837.25397,462.3492063,131.8888889,7123.714286,11241.20635,1479.253968,673.8095238,2824.47619,9307.539683,592.5714286,260.047619,6514.492063,5875.873016,775.1428571,396.3333333,1298.063492,5211.396825,649.2380952,155.1428571,3014.428571,4103.650794,1154.396825,221.6825397,3164,193.0952381,319.968254,63,12.34083056,6.717883078,0.838850208,0.926470588,0.692307692,-1.399666443
+1213,32247.23171,808.1341463,545.0731707,1079.841463,30601.30488,657.4878049,666.6463415,1545.573171,16647.80488,547.2073171,449.5731707,1795.353659,23214.76829,1233.804878,6824.121951,4140.219512,8740.597561,1346.54878,377.195122,2409.52439,16457.43902,384.7560976,998.597561,436.9390244,20224.0122,396.4512195,125.8292683,5002.317073,15620.2561,1437.817073,839.9756098,2799.634146,13214.26829,590.3170732,283,3736.414634,10065.82927,820.6097561,437.3658537,1326.573171,8271.890244,840.7317073,171.9268293,4048.719512,6461.085366,1286.146341,224.1341463,3247.158537,271.1097561,323.3170732,82,12.3413487,9.23604015,0.663268237,0.872340426,0.525641026,-0.876549412
+1214,39780.59036,900.8795181,555.8192771,1118.39759,35870.36145,711.253012,659.8915663,1683.975904,20045.80723,601.9156627,716.4337349,1784.855422,28081.28916,1336.759036,7278.710843,5277.433735,10269.60241,1472.746988,421.1927711,2473.819277,19780.93976,422.8313253,162.5662651,573.5542169,23761.39759,1028,135.0361446,3223.481928,18734.24096,1526.204819,994.3253012,2833.674699,16172.48193,623.8313253,326.0361446,2035.240964,12629.3253,1079.650602,485.6144578,1309.542169,9829.012048,675.8313253,188.1566265,4260.13253,7872.096386,1390.963855,139.8795181,3331.349398,297.9879518,323.5180723,83,13.03623115,9.190145143,0.709237638,0.83,0.58041958,-0.207708031
+1215,43140.97351,861.205298,525.7218543,1096.662252,38618.00662,711.8278146,700.7880795,1648.456954,21755.23179,592.8344371,728.3509934,1786.774834,30384.90728,1315.337748,6559.225166,4442.198675,11213.64901,1421.582781,401.3576159,2495.615894,21548.21192,485.1523179,195.615894,548.7218543,26079.39073,526.6887417,136.2980132,4806.331126,20774.53642,1647.609272,931.9403974,2813.576159,17751.43046,613.2913907,314.1192053,1836,13989.17881,1023.125828,477.6887417,1302.854305,10849.3245,681.6622517,186.5629139,4113.768212,8926.92053,1407.245033,149.4370861,3290.81457,309.794702,323.8410596,151,16.30653569,12.02804945,0.675214552,0.937888199,0.629166667,1.064738317
+1216,52791.15517,1083.275862,581.2241379,1136.637931,48389.63793,884.637931,530.8965517,1702.603448,27484.24138,722.1551724,447.862069,1728.655172,38865.7069,1713.224138,3173.396552,2807.034483,13405.75862,1676.603448,508.1034483,2445.224138,25371.77586,506.6034483,504.3275862,440.3965517,30483.55172,453.3793103,158.2758621,3799.12069,24645.67241,1731.241379,913.6896552,2817.172414,20742.84483,719.3448276,372.1034483,1626.534483,16712.44828,1098.793103,555.6034483,1319.068966,13045.03448,830.0172414,220.5517241,2298.810345,11070.08621,1723.603448,571.4655172,3177.482759,362.1896552,321.5172414,58,9.99972837,7.771144586,0.629333226,0.920634921,0.58,0.842749283
+1217,19989.57325,862.6305732,418.1783439,1024.471338,18363.03822,682.9617834,454.6942675,1368.254777,10083.24204,548.910828,390.8917197,1674.356688,14416.49045,1294.853503,1592.515924,1085.700637,5227.509554,1402.751592,385.1401274,2411.88535,10262.48408,402.2611465,753.7898089,439.6687898,11904.18471,383.656051,123.5541401,959.522293,9666.305732,1464.273885,783.6050955,2832.726115,8175.254777,760.2547771,266.7707006,1439.356688,6696.757962,798.1528662,439.5031847,1321.191083,5386.859873,804,175.9044586,2779.477707,4545.636943,1385.471338,415.1783439,3179.509554,374.6369427,324.9235669,157,17.5892085,11.57020014,0.753191712,0.94011976,0.71040724,0.359110571
+1218,25766.5303,834.8484848,496.4848485,1051.772727,23189.13636,707.4848485,898.4393939,1482.878788,12217.48485,549.8484848,1252.530303,1848.651515,18010.71212,1287.893939,5832.560606,4215.045455,6684.909091,1330.878788,392.9545455,2685.5,12775.71212,420.0151515,2124.5,830.1212121,13782.77273,426.5757576,130.4393939,1956.5,11430.65152,2213.590909,1033.636364,2818.515152,9828.515152,1014.954545,268.5757576,1705.30303,7931.666667,1400.181818,438.7575758,1351.318182,6083.606061,1057.015152,184.5757576,5419.893939,5163.924242,1369.333333,540.0909091,3209.363636,431.9848485,322.4848485,66,10.86547988,8.157209166,0.660591649,0.942857143,0.55,-0.388590276
+1219,26388.78814,835.4661017,597.1440678,1105.779661,22400.50847,683.0932203,652.3644068,1675.915254,13104.05932,523.059322,421.4915254,1826.457627,18171.02542,1259.949153,3745.389831,2110.79661,6442.372881,1269.338983,368.2542373,2504.110169,12286.24576,2171.898305,1703.576271,460.5508475,14011.33051,428.5508475,122.2966102,3333.771186,11522.92373,1496.186441,1310.279661,2822.805085,9645.288136,751.1271186,257.0169492,3406.440678,7777.525424,1029.915254,397.440678,1340.347458,5838.822034,1083.728814,164.0169492,7666.567797,4907.466102,1256.576271,200.8474576,3238.745763,670.3559322,321.9576271,118,15.71122531,9.668223703,0.788238045,0.944,0.670454545,1.324171977
+1220,18132.73077,695.3461538,390.8717949,1055.089744,16050.76923,585.7948718,842.5384615,1505,9056.692308,467.7948718,393.7435897,1747.884615,12448.96154,1108.589744,2830.730769,1646.589744,4553.397436,1107.692308,336.025641,2564.653846,8560.615385,13022.52564,513.3076923,434.9871795,9923.205128,451.6794872,108.9102564,3141.153846,8245.166667,1335.448718,757.4871795,2781.410256,6995.615385,662.1794872,236.1410256,4231.551282,5726.230769,751.5128205,363.5641026,1298.166667,4238.358974,762.2051282,150.5897436,2752.871795,3575.217949,1142.346154,141.5,3187.192308,682.9615385,323.3717949,78,11.72773638,8.973991323,0.643799991,0.951219512,0.557142857,0.09087164
+1221,20725.7651,741.7181208,481.6510067,1082.483221,17770.27517,595.2483221,505.5637584,1610.852349,10619.30201,485.1879195,391.6778523,1806.208054,14605.97987,1177.563758,6204.66443,3870.704698,5301.597315,1158.832215,366.8187919,2461.268456,9967.174497,2138.651007,367.7583893,427.3557047,11460.1745,389.2013423,113.3691275,7388.402685,9445.469799,1308.302013,843.0067114,2795.986577,8007.107383,620.557047,252.5704698,11434.38255,6355.033557,746.2684564,379.1610738,1307.805369,4788.020134,796.7516779,151.0134228,3352.516779,4056.758389,1172.637584,173.7583893,3173.14094,731.5771812,324.7181208,149,17.4726789,12.05565788,0.72383613,0.84180791,0.551851852,0.057350679
+1222,13871.42208,745.7207792,551.3636364,1080.824675,11702.40909,593.2922078,548.1948052,1670.116883,6305.493506,463.5324675,487.8116883,1796.616883,10190.72727,1163.188312,4732.246753,3411.032468,3709.668831,1137.077922,347.961039,2615.058442,6498.746753,893.3961039,1633.25974,493.4025974,8009.857143,402.2012987,116.512987,4493.668831,6514.194805,1403.116883,976.012987,2816.74026,5360.415584,535.8571429,270.7727273,28575.85065,4325.87013,788.038961,390.8116883,1367.077922,3105.883117,1492.948052,162,6967.545455,2755.012987,1168.051948,250.7987013,3251.88961,902.025974,321.7142857,154,22.14868707,10.45282742,0.881631248,0.836956522,0.538461538,1.367373742
+1223,29052.37143,813.2928571,524.5857143,1085.142857,26783.32143,670.6214286,760.5214286,1549.864286,14793.49286,541.0142857,960.0142857,1765.678571,20263.79286,1233.414286,6365.557143,3850.842857,7502.164286,1305.435714,379.6,2464.728571,14773.97857,406.4785714,374.9357143,794.6214286,17221.7,431.9357143,140.2214286,3440.807143,13781.98571,1735.457143,838.5142857,2806.114286,11784.04286,699.8357143,272.6142857,2187.528571,9155.885714,979.8857143,440.1071429,1316.164286,7236.757143,700.65,172.4642857,5069.135714,6017.114286,1305.121429,557.75,3233.935714,329.6428571,323.3642857,140,18.85416629,9.716659643,0.856974536,0.897435897,0.614035088,-1.247683382
+1224,19548.84524,1026.97619,507.3452381,1041.75,17383.53571,729.6071429,553.7380952,1421.142857,9642.333333,604.4166667,476.1071429,1715.464286,13392.7619,1344.797619,1503.583333,1591.416667,5051.595238,1536.011905,383.3571429,2419.833333,9806.619048,403.8214286,547.8095238,467.3571429,10961.61905,394.3928571,127.6666667,1335.892857,9084.72619,1492.833333,781.8333333,2879.27381,7675.369048,818.6666667,275.0357143,1491.916667,6195.22619,853.2142857,441.0714286,1321.821429,4909.035714,742.9404762,173.1547619,3389.5,4115.190476,1349.02381,160.0119048,3285.607143,387.7619048,322.952381,84,12.9161697,8.45383611,0.756048393,0.965517241,0.636363636,-0.663785457
+1225,26590.03167,840.3438914,511.5746606,1090.914027,23469.13575,699.2036199,681.0723982,1529.438914,12617.33937,559.0135747,674.7239819,1769.312217,18518.80995,1329.945701,4712.361991,3686.303167,6526.542986,1321.719457,384.9411765,2545.303167,12147.11765,3209.036199,1101.067873,665.4208145,13886.8733,514.2352941,128.6199095,4050.140271,11263.29864,1672.20362,980.9230769,2828.986425,9428.457014,610.6334842,281.2941176,2004.248869,7499.063348,1037.80543,440.918552,1324.841629,5839.466063,909.9004525,176.2533937,6805.895928,4893.20362,1327.20362,347.5384615,3208.443439,477.0588235,327.321267,221,19.76232447,15.0725805,0.646761048,0.880478088,0.726973684,0.052756079
+1226,33606.61798,1018.05618,557.5617978,1144.865169,28866.65169,822.4719101,628.8539326,1636.044944,15465.4382,642.9775281,543.741573,1766.134831,22972.8764,1573.258427,3935.280899,3454.696629,7890.651685,1501.52809,454.1460674,2462.88764,14143.34831,487.9438202,1008.741573,528.6741573,17391.34831,505.3258427,149.4831461,2259.52809,13748.23596,1717.067416,808.8089888,2820.831461,11499.73034,903.8089888,320.741573,1762.775281,9264.280899,1079.730337,502.3707865,1352.483146,7312.47191,893.7752809,198.1797753,3033.775281,6221.52809,1547.382022,329.5730337,3246.932584,487.6853933,323.5505618,89,12.41802856,9.551136267,0.639086742,0.927083333,0.622377622,-0.305814891
+1227,19376.41584,694.4653465,456.1089109,1045.148515,17073.32673,579.7227723,433.7029703,1494.306931,9389.762376,454.2673267,369.049505,1753.574257,13185.46535,1117.336634,4760.910891,2952.188119,4736.693069,1132.346535,352.2475248,2425.405941,8678.623762,1459.009901,2677.841584,420.8910891,10442.70297,357.6336634,113,5006.079208,8417.742574,1310.178218,785.970297,2791.732673,6872.772277,524.9108911,250.8910891,13821.16832,5524.613861,813.0990099,371.6732673,1349.742574,3981.247525,1457.722772,152.009901,4469.980198,3501.950495,1121.722772,168.8019802,3107.980198,843.4059406,323.970297,101,16.08914106,8.322325203,0.8558262,0.90990991,0.526041667,-1.145544688
+1228,30282.39583,804.6041667,545.5208333,1094.1875,25831,639.1041667,625.8333333,1740.4375,13720.10417,480.875,518.4375,1800.229167,20694.875,1198.625,6319.125,3499.479167,7452.270833,1213.5,364.5208333,2506.625,13518.22917,1970.5,157.375,497.2083333,16338.64583,527.75,127.9166667,6957.854167,13478.83333,1384.375,733.9583333,2828.479167,10846.60417,568.5625,275.1666667,20725.9375,8356.458333,908.125,401.8125,1330.5625,5942.375,959.2708333,163.375,3989.5625,5312.958333,1229.833333,189.7291667,3293.145833,936,321.3541667,48,9.187250156,7.343079971,0.60097405,0.923076923,0.666666667,1.212999271
+1229,40370.5283,895.9056604,547.7735849,1149.037736,36745.93396,799.0660377,824.6226415,1838.924528,19622.38679,592.6132075,1743.830189,1887.056604,28205.36792,1310.018868,7443.330189,4731.632075,10332.82075,1396.462264,408.9433962,3341.745283,20087.26415,527.5849057,148.4150943,1037.04717,24596.06604,444.8584906,440.8490566,5140.915094,19328.18868,1886.971698,683.9622642,2889.113208,15910.38679,611.3962264,321.1509434,4723.650943,10320.83019,981.2641509,455.3962264,1310.537736,8984.5,650.754717,174.4433962,2997.122642,7153.254717,1337.235849,454.1509434,3292.641509,201.0188679,326.0660377,106,15.00556764,9.585903376,0.769353648,0.876033058,0.543589744,-0.461664574
+1230,46310.85088,902.1754386,536.622807,1128.947368,42570.79825,749.4122807,705.4210526,1695.833333,23995.67544,604.9385965,577.6842105,1770.473684,33271.36842,1391.657895,6663.517544,4645.578947,12394.5,1446.991228,427.4122807,2465.587719,23818.38596,447.3947368,134.2894737,547.5438596,28762.57895,507.3596491,143.7719298,4012.719298,22953.00877,1645.377193,823.5789474,2822.307018,19435.87719,671.5526316,331.622807,2268.640351,14398.80702,939.3421053,486.5877193,1310.333333,11706.12281,652.8333333,189.9824561,2396.526316,9327.359649,1421.438596,149.4649123,3374.368421,252.5175439,323.8245614,114,16.40624321,9.863324409,0.799103591,0.826086957,0.647727273,-1.504749181
+1231,17725.51579,1119.526316,568.4105263,1031.494737,15782,794.3894737,653.2,1426.505263,8640.831579,636.5894737,612.7789474,1768.221053,12449.72632,1322.642105,4157.115789,3221.978947,4394.884211,1313.178947,413.1052632,2433.6,8096.052632,397.9789474,2436.178947,733.0210526,9533.084211,625.5368421,119.0105263,2622.873684,7574.221053,1742.589474,814.6315789,2799.852632,6498.778947,776.6421053,250.6947368,1751.578947,5283.273684,895.5157895,419.5368421,1367.252632,4296.168421,1271.821053,168.6842105,5531.368421,3633.284211,1270.284211,198.6105263,3421.821053,396.8631579,324.8210526,95,12.26966995,11.50062108,0.348466743,0.805084746,0.56547619,-0.950843024
+1232,37806.95506,877.6629213,495.4044944,1099.494382,33798.08989,739.7191011,802.5617978,1544.775281,18192.7191,581.752809,977.0674157,1812.640449,26492.65169,1431.797753,3850.460674,3143.202247,9525.213483,1419.573034,419.7191011,2557.921348,17369.82022,460.0561798,720.0898876,1376.865169,20760.93258,490.6741573,145.7078652,2383.235955,16277.96629,1932.707865,760.3707865,2826.449438,13764.80899,690.9775281,306.5505618,1719.438202,11234.13483,1188.606742,472.0786517,1342.089888,8675.191011,830.3146067,184.5168539,3320.022472,7290.606742,1419.640449,600.1573034,3203.494382,506.9775281,324.2696629,89,13.78408146,8.570690907,0.783190526,0.917525773,0.593333333,1.453191697
+1233,35311.48739,862.7394958,480.1512605,1088.966387,30710.93277,718.6890756,637.907563,1558.882353,17499.62185,570.6890756,561.1848739,1764.142857,24422.34454,1371.907563,3788.411765,3993.983193,8999.033613,1357.823529,389.5462185,2491.193277,16893.90756,452.9327731,309.3193277,537.5630252,20123.64706,404.7815126,130.3361345,3162.983193,15790.27731,1579.932773,791.210084,2806.596639,13610.10084,691.2857143,293.5462185,3379.689076,11198.84034,918.302521,464.2605042,1325.420168,8332.840336,712.0504202,176.5042017,2760.352941,7057.504202,1394.504202,591.8067227,3247.310924,575.4705882,323.5630252,119,16.13242363,10.13042425,0.778250242,0.888059701,0.636363636,1.570394928
+1234,32294.31111,879.4111111,592.0666667,1131.711111,25338.62222,692.9888889,613.0333333,1777.688889,15203.31111,547.9111111,647.6555556,1811.133333,21487.43333,1287.011111,5745.033333,3867.188889,7599.511111,1292.3,384.8222222,4024,14149.63333,4024.1,126.1222222,501.6,16300.45556,425.3888889,122.7222222,6465.811111,13915.43333,1501.688889,1039.133333,2801.466667,11518.55556,641.2666667,297.9111111,17870.07778,9174.966667,954.0555556,412.2888889,1375,6826.944444,796.8555556,162.9777778,3824.422222,5724.655556,1303.4,175.5333333,3288.655556,781.1666667,324.4555556,90,13.47205749,9.159382308,0.733323394,0.9,0.532544379,-0.567433038
+1235,12056.07735,689.2596685,467.5524862,1039.348066,10312.92265,555.2486188,462.9281768,1481.220994,5800.839779,451.4585635,499.9281768,1759.607735,8178.98895,1093.320442,4465.524862,2188.955801,3046.629834,1113.707182,362.8287293,2512.132597,5599.906077,1203.872928,778.1381215,595.1712707,6503.165746,586.4640884,112.961326,4903.088398,5525.679558,1272.61326,778.9337017,2799.834254,4576.546961,519.3038674,251.2486188,20335.74586,3764.469613,765.6243094,368.3977901,1358.486188,2788.629834,865.1160221,145.1160221,4040.232044,2440.187845,1117.944751,192.9779006,3157.314917,816.5801105,328.5966851,181,19.22528038,12.47465455,0.760901642,0.937823834,0.696153846,0.140793456
+1236,19773.72085,737.9363958,529.4204947,1083.657244,17747.17668,601.0671378,427.7031802,1634.240283,9604.120141,471.9787986,425.5441696,1787.664311,13854.31802,1124.925795,6259.865724,3168.742049,5006.187279,1146.109541,352.8939929,2472.54417,9134.141343,1961.409894,821.6431095,440.1342756,10986.85512,401.180212,117.5123675,6300.388693,8938.954064,1336.084806,917.4522968,2804.508834,7400.579505,555.9399293,266.7915194,19104.31449,5831.363958,795.6713781,380.4416961,1326.021201,4210.226148,1090.936396,151.3957597,4830.795053,3605.106007,1136.731449,177.0848057,3163.971731,870.2190813,327.434629,283,22.7842552,16.25587308,0.700686201,0.921824104,0.683574879,-1.367613086
+1237,27378.66887,879.1324503,507.4569536,1062.847682,23461.61589,665.8013245,591.5562914,1457.357616,12750.03974,555,588.6688742,1745.801325,18706.97351,1266.218543,4559.754967,3914.966887,6716.417219,1302.278146,378.7748344,2451.874172,12611.08609,409.8476821,506.5364238,528.0662252,14698.13907,427.6821192,122.6953642,3368.89404,11998.31126,1556.821192,977.384106,2788.728477,10038.24503,588.2516556,271.807947,2048.384106,8178.437086,1032.066225,436.4569536,1311.443709,6284.364238,710.4172185,173.4701987,4167.483444,5384.291391,1290.02649,184.6225166,3291.033113,461.794702,326.5165563,151,16.89513338,11.50157911,0.732503887,0.955696203,0.719047619,-0.971969937
+1238,42801.875,1003.375,586.234375,1169.828125,36009.375,829.71875,756.078125,1727.8125,20851.70313,643.546875,667.25,1772.296875,30105.59375,1545.90625,3890.0625,3414.46875,10349.26563,1515.21875,449.796875,2520.1875,20318.75,540.390625,1335.359375,643.5,23108.07813,478.671875,148.3125,3560.765625,19303.3125,1817.4375,1016.71875,2814.296875,16111.26563,800.21875,336.15625,2214.109375,13144.96875,1149.25,513.046875,1342.90625,9761.859375,990.625,207.640625,3842.09375,8480.46875,1514.734375,271.984375,3305.171875,524.453125,323.796875,64,12.15773916,6.909708105,0.822795018,0.955223881,0.666666667,1.20435976
+1239,31286.06173,811.8271605,441.2222222,1087.197531,27145.24691,665.5864198,819.8641975,1601.802469,15776.85185,523.8765432,1514.117284,1803.555556,21904.74691,1268.574074,4876.851852,3520.635802,7784.993827,1270.524691,367.9197531,4271.703704,14262.9321,3173.777778,227.537037,1098.549383,16542.74691,436.691358,166.1049383,3000.141975,13528.79012,1782.469136,718.5061728,2798.938272,11487.25309,747.3950617,255.9444444,2520.814815,9406.067901,1521.660494,403.6666667,1307.432099,7057.074074,667.1481481,161.6358025,3067.537037,5909.364198,1303.907407,1040.703704,3179.561728,650.6358025,325.0493827,162,18.34983878,11.89194926,0.7615822,0.920454545,0.623076923,-1.313808227
+1240,40171.46154,1055.025641,564.5769231,1132.589744,34931.25641,757.5641026,959.6025641,1613.948718,19725.21795,646.4230769,1826.705128,1756.576923,27185.5641,1351.730769,5323.051282,3844.923077,9544.705128,1404.769231,396.7307692,2424.397436,18530.25641,440.7435897,190.8589744,823.8333333,22388.47436,1054.089744,134.5897436,3461.320513,18002.32051,1515.051282,793,2824.858974,15326.83333,616.3205128,293.7820513,1596.307692,11749.12821,1036.846154,452.7820513,1313.846154,9061.153846,654.6538462,179.8974359,3228.807692,7444.705128,1312.935897,190.6538462,3372,288.8717949,326.7948718,78,13.52444862,7.575211726,0.828416604,0.939759036,0.5,0.744499127
+1241,26128.32018,1218.723684,559.5964912,1076.850877,25142.49561,849.4254386,756.745614,1586.666667,11664.27632,627.1842105,550.2017544,1703.635965,16566.28947,1358.201754,4233.267544,2470.565789,5701.27193,1308.671053,376.4385965,2442.934211,7609.583333,315.2324561,461.377193,450.8245614,9633.052632,442.8640351,112.3552632,3341.649123,7961.526316,1406.035088,781.3508772,2797.890351,6649.25,616.4649123,238.9824561,1572.973684,5557.324561,809.9210526,401.495614,1317.315789,4259.609649,721.1666667,160.0131579,3960.815789,3605.885965,1180.97807,179.627193,3325.925439,419.622807,329.3333333,228,20.01365122,14.93951365,0.665423362,0.95,0.670588235,-0.506654043
+1242,15131.78261,972.5,551.7173913,1021.326087,15361.23913,669.173913,797.7391304,1374.195652,7322.195652,571.9782609,736.0434783,1785.304348,10008.80435,1204.304348,6367.869565,2447.434783,4030.065217,1206.652174,357.6956522,2595.326087,6898.369565,365.5652174,2699.695652,834.6521739,7649.5,364.9347826,203.173913,2470.173913,5792.565217,1695.043478,707.9130435,2775.695652,5288.521739,711.0217391,233.3913043,2422.086957,4412.347826,757.6304348,388.5217391,1482.934783,3699.434783,1281.586957,155.7173913,4522.565217,2578.478261,1149.217391,402.9565217,3283.369565,556.7608696,325.5217391,46,9.131442118,6.675614937,0.682315191,0.884615385,0.575,-0.047208076
+1243,17916.5035,726.8181818,558.7062937,1075.111888,15535.48252,593.048951,420.5734266,1591.965035,9096.237762,469.8391608,399.7692308,1802.51049,12981.61538,1125.398601,6559.664336,3812.356643,4694.384615,1132.251748,358.5734266,2474.034965,8606.132867,1380.027972,541.8391608,444.8391608,10116.97902,376.6643357,109.4895105,8585.174825,8331.097902,1303.503497,1202.895105,2805.517483,7058.776224,571.0769231,250.6083916,17458.41259,5661.426573,756.5594406,369.7832168,1320.447552,4300.755245,854.3426573,154.1188811,5549.251748,3646.125874,1138.979021,176.986014,3168.272727,743.006993,327.2447552,143,14.06066935,13.14560171,0.35485842,0.966216216,0.729591837,-0.791149733
+1244,14975.15951,681.4846626,477.601227,1062.196319,12892.26994,545.9754601,513.8466258,1528.128834,7156.453988,440.9141104,507.9693252,1778.361963,10284.16564,1083.257669,6597.693252,2995.920245,3726.889571,1080.171779,336.9447853,3126.01227,6725.116564,1258.030675,1090.055215,446.1165644,7900.239264,357.4171779,113.1472393,8275.02454,6538.141104,1311.601227,955.8282209,2784.797546,5393.656442,519.8282209,234.3006135,14590.83436,4422.631902,769.8650307,367.8282209,1384.815951,3179.343558,987.2515337,148.0920245,4615.226994,2770.613497,1079.674847,149.3803681,3143.484663,827.9263804,329.4233129,163,18.41290872,11.90962614,0.762652441,0.931428571,0.696581197,-0.26334501
+1245,23709.4,791.0581818,526.9563636,1103.338182,20445.76727,646.8436364,745.5672727,1676.72,11172.76,489.3309091,1295.821818,1784.763636,16614.18909,1213.381818,5714.974545,3532.687273,6014.298182,1185.836364,357.3745455,4807.538182,10684.55273,862.9927273,1071.712727,652.2509091,13177.99636,425.9781818,118.4654545,5715.385455,10645.34182,1612.989091,810.3527273,2813.883636,8791.596364,548.5490909,275.9490909,22693.58182,6927.334545,1190.185455,396.3490909,1414.716364,4953.956364,1300.741818,164.9018182,5987.418182,4354.309091,1205.407273,275.3563636,3215.778182,893.2290909,331.2872727,275,21.54974991,17.44250194,0.587249135,0.925925926,0.597826087,-1.471289172
+1246,44633.96491,882.3157895,540.4385965,1121.438596,40392.50877,725.7719298,760.4385965,1661.614035,23498.35088,589.5438596,475.4736842,1788.596491,32357.87719,1318.894737,6071,4230.631579,12054.92982,1432.912281,419.4561404,2415.192982,22502.31579,418.8596491,131.3508772,433.5263158,27584.82456,424.4912281,138.1754386,4522.315789,22191.33333,1499.105263,924.8070175,2804.035088,18560.17544,616.0350877,332.9473684,2122.052632,13965.38596,873.0701754,488.9824561,1311.666667,11049.2807,646.3859649,188.7719298,2024.736842,9084.754386,1409.087719,143.6491228,3322.017544,263.122807,327.6491228,57,11.31134121,7.054944554,0.781659503,0.863636364,0.475,0.560983937
+1247,26664.98204,854.2994012,450.7365269,1056.622754,23593.52096,672.0538922,637.2994012,1428.964072,12769.01198,541.6467066,460.5209581,1733.413174,19063.12575,1294.640719,3019.179641,1940.562874,6828.329341,1311.862275,382.9281437,2452.179641,11663.41916,386.8862275,899.9520958,453.7724551,13913.81437,401.0239521,120.5329341,1481.97006,11269.52096,1476,931.6167665,2849.413174,9693.778443,864.6107784,273.5928144,1580.161677,8010.467066,1163.592814,423.1197605,1319.826347,6117.341317,840.0239521,171.1616766,2546.898204,5265.053892,1334.221557,649.1377246,3227.580838,443.6646707,328.8203593,167,18.69730205,12.30742365,0.752802928,0.888297872,0.521875,1.052431986
+1248,31879.77011,850.6091954,563.8505747,1128.747126,27421.50575,691.2873563,954.7126437,1796.908046,14708.6092,520.9770115,2004.678161,1783.310345,21649.67816,1252.034483,6349.942529,4358.724138,7920.114943,1255,368.7701149,4123.413793,14840.13793,541.1034483,167.3218391,1299.356322,17888.52874,2308.287356,125.8275862,4696.034483,14918.4023,1489.931034,711.6436782,2946.747126,12201.70115,571.1264368,306.6436782,24566.50575,9376.942529,2050.37931,421.1149425,1372.172414,6496.862069,920.6091954,226.1149425,7273.850575,5903.942529,1270.425287,261.4367816,3299.402299,929.4827586,326.9425287,87,11.79099746,9.72707176,0.565194769,0.925531915,0.608391608,-1.539361274
+1249,40382.75735,902.1691176,514.6911765,1109.514706,35572.05147,732.0441176,647.5588235,1639.779412,20178.22794,582.9191176,702.9926471,1779.073529,28042.16912,1346.080882,6941.801471,2812.816176,10183.72794,1428.566176,410.9926471,2465.411765,19790.47794,444.3161765,270.7647059,564.2573529,23469.86765,457.4117647,174.5441176,4293.683824,18568.00735,1662.860294,876.7647059,2819.955882,15908.69853,678.2647059,311.8529412,2236.823529,12599.80882,900.2426471,472.2867647,1315.691176,9886.154412,740.2205882,191.6691176,5749.448529,8311.441176,1415.485294,244.1029412,3295.713235,345.3970588,328.6691176,136,16.51643258,10.98626139,0.746690553,0.844720497,0.581196581,1.183761979
+1250,44818.83562,918.1780822,468.8767123,1092.890411,40364.0274,766.3013699,636.6164384,1630.821918,22943.16438,616.9589041,453.3835616,1758.821918,32133.57534,1409.589041,3690.835616,2616.917808,11434.15068,1506.520548,430.7808219,2423.205479,22272.57534,444.0136986,585.9589041,425.5205479,26347.0411,431.8767123,133.2191781,2694.876712,21203.24658,1579.671233,871.0821918,2827.315068,17942.06849,814.0821918,309.6849315,1755.232877,14413.39726,937.0958904,479.9589041,1312.630137,11014.49315,809.9589041,188.5616438,2501.630137,9251.60274,1500.794521,670.8630137,3207.082192,358.1232877,328.7123288,73,11.14982314,8.628032084,0.633397242,0.948051948,0.561538462,0.270467849
+1251,20540.00699,748.7902098,526.1048951,1084.160839,17941.23077,613.1818182,647.4755245,1579.65035,10337.1049,487.1818182,662.9370629,1812.195804,14835.71329,1211.979021,6106.055944,2674.727273,5281.587413,1172.923077,342.4335664,2727.356643,9853.377622,2988.020979,107.6433566,446.986014,11509.32867,411.8951049,113.2447552,5879.370629,9592.398601,1477.531469,989.972028,2796.083916,7992.342657,679.5244755,252.3636364,9238.370629,6538.923077,803.4195804,383.1818182,1311.832168,4900.342657,634.0699301,152.1328671,5139.006993,4148.818182,1161.517483,248.5874126,3154.181818,691.8391608,329.7762238,143,15.50888188,12.05323364,0.629275104,0.972789116,0.638392857,-1.262464067
+1252,21886.24752,762.0792079,558.6831683,1118.128713,18061.78218,592.0792079,416.2574257,1619.029703,10585.53465,471.2772277,433.8613861,1775.881188,15930.50495,1149.435644,4651.930693,3793.168317,5675.316832,1151.485149,344.4851485,2808.207921,10180.9802,7786.90099,136.8019802,430.2772277,11869.23762,426.2871287,114.3267327,6202.643564,9982.148515,1312,1039.19802,2800.831683,8212.50495,670.2574257,271.3762376,19027.91089,6769.475248,762.7029703,379.2178218,1325.960396,5084.663366,757.1386139,152.5742574,4215,4275.851485,1172.158416,140.1980198,3234.217822,788.7029703,328.9009901,101,13.7428444,9.748389642,0.704863529,0.943925234,0.601190476,-0.916973128
+1253,18964.21176,717.6352941,524.1147059,1059.408824,16512.3,581.6294118,468.1235294,1629.626471,9170.288235,460.75,403.2029412,1805.211765,13340.90588,1110.244118,7068.147059,4167.085294,4863.05,1124.832353,338.6176471,2501.832353,8719.782353,1494.352941,668.6764706,437.6323529,10466.94118,378.3647059,114.5676471,9273.755882,8408.661765,1304.061765,1035.917647,2786.705882,6884.570588,527.8647059,259.5411765,17822.56176,5618.620588,727.8617647,374.1588235,1328.844118,3992.482353,891.4441176,151.7441176,4925.605882,3510.505882,1133.064706,145.4323529,3189.182353,850.6647059,336.9323529,340,26.94918613,16.39831359,0.793561447,0.916442049,0.699588477,-0.190251109
+1254,29951.69149,909.5744681,711.9042553,1186.680851,27188.74468,726.9255319,898.0851064,1864.744681,13895.45745,575.9680851,2037.404255,1877.37234,19873.98936,1291.904255,8980.93617,7145.957447,7182.159574,1339.180851,390.7234043,5495.457447,14123.54255,1382.553191,151.7553191,1156.159574,16713.48936,452.4148936,240.4787234,7553.031915,12951.38298,2272.62766,772.4680851,2855.659574,10694.34043,601.4042553,296.1702128,11770.12766,6606.138298,1094.648936,427.4680851,1327.276596,5702.638298,652.2765957,179.106383,5292.765957,4523.765957,1270.617021,429.8510638,3240,190.4893617,328.9255319,94,11.38137516,10.62270426,0.358991014,0.94,0.712121212,-0.547122478
+1255,24608.96552,798.2068966,433.091954,1092.172414,21940.18391,653.3908046,764.7586207,1514.977011,11745.65517,521.5517241,643.9425287,1769.758621,17187.36782,1238.16092,3616.517241,2237.505747,6325.298851,1312.034483,388.862069,2490.275862,13142.26437,465.7931034,841.8505747,958.6666667,13513.25287,500.4137931,147.4252874,1629.747126,10684.5977,2146.965517,789.5402299,2819.08046,8965.931034,624.0689655,266.954023,1658.436782,7278.390805,1297.862069,435.862069,1334.137931,5672.563218,826.908046,172.7126437,2654.091954,4793.83908,1293.195402,184.7701149,3348.321839,497.2988506,331.2873563,87,15.18138196,7.72922984,0.860692249,0.90625,0.776785714,0.129104879
+1256,26103.28261,948.6014493,511.5724638,1092.34058,23659.15942,737.7246377,771.4492754,1480.949275,12512.5942,582.3695652,650.2898551,1782.797101,17632.52899,1386.123188,3341.326087,3066.398551,6288.210145,1352.695652,395.9347826,2513.318841,11753.18841,669.2536232,1487.695652,645.7391304,13766.27536,597.326087,131.4492754,2330.557971,10887.04348,1628.833333,888.9057971,2805.789855,9345.478261,737.8188406,279.2608696,1751.34058,7810.173913,985.3695652,443.057971,1330.391304,5985.297101,999.4565217,176.5869565,2980.326087,4783.673913,1337.73913,1365.76087,3222.768116,540.6014493,330.5724638,138,17.43558535,12.08116613,0.721030993,0.745945946,0.518796992,1.286937975
+1257,27643.40945,772.9212598,536.2283465,1083.614173,24224.0315,650.1574803,654.8661417,1578.944882,14146.51969,506.0787402,494.8188976,1744.047244,19937.45669,1223.952756,5608.181102,2584.889764,7117.188976,1209.377953,361.7637795,2816.637795,13562.31496,5058.543307,534.5275591,515.6929134,15911.22835,428.4566929,116.1653543,4496.84252,12754.30709,1502.692913,678.7716535,2790.834646,10899.75591,661.3700787,261.8582677,4777.748031,8945.629921,959.4251969,403.6456693,1318.574803,6725.086614,760.0944882,160,5572.094488,5751.102362,1281.84252,1085.913386,3198.543307,661.023622,331.1338583,127,13.65850293,12.49315072,0.404180242,0.947761194,0.604761905,0.014877723
+1258,18166.95652,692.5326087,442.6847826,1040.673913,15533.5,569.25,607.3913043,1579.771739,9009.586957,458.3043478,917.326087,1816.815217,12445.55435,1100.76087,6414.608696,3525.358696,4542.858696,1128.652174,325.7173913,3492.521739,8409.771739,2442.336957,99.35869565,637.0108696,9774.26087,405.5217391,107.9673913,5297.978261,8126.01087,1462.728261,829.8804348,2787.391304,6851.271739,615.8913043,232.1304348,5982.532609,5571.51087,889.1304348,361.3804348,1321.206522,4174.01087,606.2065217,149.25,2393.293478,3474.217391,1134.869565,167.076087,3108.206522,704.0652174,329.8478261,92,11.70759959,10.57756365,0.428633565,0.901960784,0.643356643,-0.421802706
+1259,15200.95652,718.048913,471.7173913,1060.608696,11494.66304,555.2663043,409.2445652,1548.538043,5232.456522,431.3641304,427.3967391,1726.630435,8925.940217,1063.608696,4652.13587,2401.26087,3321.559783,1120.565217,324.6576087,2810.804348,5924.668478,1600.070652,162.8478261,479.8043478,7270.88587,385.7065217,110.3097826,8214,5965.929348,1354.440217,747.3641304,2792.315217,4812.26087,525.3858696,249.1032609,17363.11957,3732.277174,750.8641304,366.6086957,1312.195652,2118.923913,622.375,147.9293478,5036.836957,2153.728261,1064.407609,200.298913,3107.88587,1036.266304,332.7445652,184,15.777526,15.03690213,0.302786848,0.968421053,0.636678201,-0.624424661
+1260,21120.90714,736.3714286,453.3428571,1070.114286,15444.45714,550.8214286,737.2928571,1510.6,6724.864286,426.0214286,1364.928571,1736.7,12048.75714,1067.578571,6465.7,3092.121429,4351.75,1090.192857,324.0714286,5124.65,8055.7,908.5142857,221.4285714,777.4142857,9973.878571,395.15,110.2428571,6303.021429,7998.757143,2027.457143,669.6,2794.114286,6253.342857,580.2285714,234.7142857,8292.471429,4745.3,990.0642857,360.9857143,1282.992857,2477.907143,580.3,144.5428571,5223.035714,2550.978571,1021.421429,292.3428571,3103.628571,1068.635714,329.4714286,140,19.14511039,9.937655315,0.854731642,0.848484848,0.633484163,-1.353643464
+1261,39029.98571,899.2357143,494.6285714,1119.907143,33582.13571,750.5642857,651.85,1617.6,18576.4,595.0857143,669.7285714,1820.578571,26672.03571,1410.157143,4524.778571,3583.714286,9650.928571,1440.75,418.0785714,2525.792857,17375.94286,459.8571429,762.1928571,791.5642857,20909.54286,451.85,145.6142857,3142.5,16751.71429,1685.335714,792.9214286,2813.042857,14016.80714,687.7214286,305.4785714,2542.778571,11472.41429,1036.857143,478.4642857,1325.757143,8850.464286,825.2214286,186.4357143,5737.192857,7349.792857,1414.942857,321.0071429,3322.378571,521.1857143,332.0571429,140,16.01808204,12.15917504,0.650985027,0.828402367,0.625,1.081852345
+1262,29023.59259,859.037037,494.9814815,1059.37037,24933.55556,719.6111111,1123.518519,1430.851852,13868.5,585.7962963,1227.351852,1802.925926,19851.33333,1315.537037,4413.759259,1907.166667,7185.981481,1319.222222,399.1111111,2613.074074,13534.12963,422.3888889,1645.203704,927.2777778,16325.66667,413.7407407,738.5925926,1562.333333,12726.38889,1963.888889,691.5925926,2856.462963,10967.27778,695.6851852,297.4074074,2665.888889,8859.481481,904.037037,456.7777778,1369.12963,6826.907407,1038.222222,173.8703704,4475.703704,5744.907407,1353.018519,551.7222222,3181.12963,564.7592593,328.2592593,54,9.670637177,7.233801557,0.663679503,0.947368421,0.675,1.072435458
+1263,26914.712,887.368,496.504,1080.168,23317.456,707.312,653.304,1525.808,12998.832,550.16,540.92,1750.576,18563.504,1338.376,4302.712,3802.944,6607.752,1294.88,377.048,2460.488,11915.84,644.208,328.104,670.416,13880.056,400.008,123.608,3957.2,11112.84,1568.624,832.72,2797.192,9685.024,684.24,274.56,2982.144,7761.056,884.632,430.296,1321.264,5809.648,691.136,175.632,3526.832,5031.872,1334.328,561.272,3217.896,583.776,330.816,125,15.23611831,10.57034468,0.720197713,0.954198473,0.686813187,-0.996206244
+1264,43390.60294,1000.514706,490.2647059,1125.867647,35138.25,771.0882353,644.2352941,1608.676471,20277.02941,598.0882353,602.8823529,1734.073529,27595.22059,1417.661765,4794.485294,3198.617647,10265.41176,1399.25,408.0441176,2454.558824,19044.69118,837.6911765,121.8382353,684.1764706,22740.02941,410.2941176,140.2647059,3732.235294,18228.42647,1550.147059,684.75,2795.294118,15823.11765,622.2794118,298.8970588,1978.985294,12796.27941,878.7352941,435.4705882,1316.382353,9332.882353,636.3382353,165.4705882,1756.161765,8059.191176,1411.161765,517.8088235,3269.735294,616,329.9117647,68,11.98376106,8.190752883,0.72996206,0.860759494,0.566666667,0.415024522
+1265,18034.84066,699.9945055,457.7142857,1065.489011,15745.20879,576.7472527,610.1428571,1561.28022,8949.626374,466.7912088,445.6978022,1787.423077,12822.83516,1119.945055,3928.131868,2716.423077,4611.653846,1116.873626,370.4725275,2792.631868,8511.142857,5722.879121,908.2142857,468.2472527,9993.93956,409.4175824,107.8296703,5156.527473,8281.472527,1443.346154,928.0054945,2780.203297,7052.472527,624.0054945,243.1428571,9270.340659,5689.225275,786.2637363,369.1648352,1315.967033,4292.362637,868.5824176,147.8736264,4264.598901,3578.021978,1128.895604,165.0934066,3175.225275,753.4065934,334.6318681,182,17.00334542,14.28617493,0.542279915,0.928571429,0.563467492,-0.284781015
+1266,23802.65403,787.6492891,462.014218,1098.507109,8024.706161,402.7393365,195.8293839,1190.829384,3247.104265,366.3744076,259.6303318,1600.331754,5578.530806,826.2890995,1874.345972,867.3601896,2017.492891,854.9146919,264.7962085,2374.890995,3652.616114,1821.772512,233.9668246,393.8625592,4333.279621,270.3981043,92.46445498,1933.900474,3336.791469,1137.71564,555.535545,2756.843602,2588.521327,437.8436019,173.6303318,2247.49763,1846.848341,558.9668246,297.971564,1256.63981,897.478673,525.3838863,120.1895735,813.7061611,909.7251185,788.563981,141.056872,2887.933649,1095.971564,335.0379147,211,18.37828067,14.98511169,0.578939213,0.95045045,0.659375,-0.290555169
+1267,35340.64179,866.8656716,577.9552239,1153.880597,32586.74627,717.0746269,542.8656716,1802.731343,17663.31343,572.7014925,518.9104478,1845.597015,24729.61194,1257.567164,5034.029851,5614.626866,9050.880597,1399.731343,391.2537313,2427.686567,17849.08955,407.6268657,242.6119403,449.9402985,21095.70149,420.7313433,140.5074627,4845.58209,16939.62687,1445.910448,817.358209,2809.940299,14004.74627,593.4029851,306.0447761,6604.328358,9371.029851,814.2238806,437.9402985,1353.119403,7899.671642,660.0746269,176.5671642,2626.492537,6247.402985,1296.686567,207.0895522,3266.507463,208.8507463,330.4179104,67,11.53047837,8.294141175,0.694675509,0.827160494,0.507575758,-0.418833701
+1268,27725.06796,931.9514563,581.9902913,1113.048544,24670.13592,685.3009709,490.3786408,1622.009709,14057,582.5048544,594.407767,1792.126214,19522.73786,1267.84466,7208.38835,4366.475728,7078.601942,1339.456311,382.9417476,2407.786408,13325.27184,866.631068,277.776699,545.631068,16267.39806,536.6601942,127.7961165,5070.135922,13028.70874,1478.912621,1051.213592,2816.417476,10979.3301,599.7281553,298.9902913,2385.504854,8407,893.1941748,446.0097087,1319.543689,6556.650485,677.5339806,179.2524272,4016.941748,5492.728155,1299.533981,208.592233,3338.893204,284.1165049,333.0679612,103,15.80887219,9.127050435,0.816505803,0.895652174,0.565934066,0.534499618
+1269,25929.625,881.375,495.9821429,1097.125,23411.73214,739.75,661.7321429,1514.482143,12094.19643,568,592.0892857,1753.982143,17726.03571,1352.75,4022.714286,2758.696429,6592.053571,1371.982143,392.4642857,2469.767857,11084.375,417.7678571,763.2321429,524.3214286,12868.96429,476.6607143,145.2678571,2666.964286,10097.66071,1796.803571,867.7321429,2796.678571,8639.767857,683.1964286,280.6071429,2196.892857,7025.107143,1078.464286,432.75,1307.821429,5696.803571,815.7857143,181.2321429,4068.660714,4654.821429,1342.232143,217.8214286,3207.767857,490.3571429,332.3392857,56,11.74386333,7.904728666,0.739556574,0.875,0.538461538,-0.090586153
+1270,53096.71277,973.8297872,494.2021277,1140.159574,45225.03191,778.2446809,599.3723404,1741.925532,27463.87234,619.0744681,429.7021277,1740.085106,37352.84043,1502.468085,3959.840426,3306.56383,13284.42553,1441.351064,417.2234043,2442.87234,23033.19149,511.5531915,121.1382979,483.4468085,27436.75532,414.4787234,129.0531915,2821.56383,22035.46809,1509.734043,694.4574468,2817.138298,18742,621.6914894,300.2765957,2028.659574,15447.11702,898.5531915,442.8617021,1293.414894,11255.68085,643.1276596,170.6595745,1675.819149,9305.361702,1434.212766,250.8404255,3244.276596,626.0531915,330.8085106,94,14.50190813,8.612147426,0.804566141,0.921568627,0.5875,-1.247320605
+1271,21306.72,727.728,410.808,1052.728,18371.848,591.704,777.528,1547.296,10463.096,480.984,752.024,1776.184,14635.792,1156.36,4723.432,2344.264,5256.448,1146.32,342.712,3799.712,9859.88,7211.936,233.544,582.28,11501.448,423.504,110.512,3759.272,9303.928,1616.216,692.56,2789.984,7892.72,875.48,237.032,3011.152,6469.992,890.896,380.4,1281.456,4837.296,655.608,153.256,2504.72,4034.936,1134.376,189.992,3142.904,722.216,333.624,125,13.61924028,13.03486794,0.289783744,0.82781457,0.490196078,-0.219385926
+1272,26677.95683,801.9100719,816.9784173,1155.820144,22469.77338,629.8920863,631.4388489,1855.133094,11644.17986,477.9784173,485.9892086,1860.514388,18116.29496,1189.420863,3586.370504,2194.938849,6552.676259,1223.485612,355.794964,2803.032374,11925.84173,3427.694245,199.5899281,513.9640288,14014.03957,533.4172662,122.7733813,3237.866906,11842.48201,1383.607914,720.0791367,2822.125899,9638.820144,562.7158273,280.7086331,18830.89928,7486.158273,917.676259,407.7697842,1347.78777,5144.917266,731.2122302,154.5107914,4033.586331,4638.964029,1202.284173,154.0071942,3250.73741,938.1870504,338.5719424,278,25.74681005,14.25053895,0.832857447,0.888178914,0.617777778,-0.307035957
+1273,21716.58621,771.5,601.6206897,1108.465517,17819.37931,616.4741379,540.3362069,1756.672414,8651.094828,458.8448276,477.9655172,1785.353448,14023.14655,1160.508621,7288.87069,3982.655172,5006.732759,1166.732759,351.8706897,2608.810345,9226.612069,1390.698276,441.5,470.3534483,11386.01724,440.6206897,122.8534483,12053.76724,9353.931034,1496.181034,1213.991379,2817.448276,7482.982759,637.5603448,280.5689655,23401.75862,5806.112069,779.6637931,395.6896552,1314.405172,3502.439655,764.112069,158.2155172,7116.62069,3319.801724,1130.094828,212.0603448,3239.405172,1011.758621,331.7155172,116,15.63048219,11.02718672,0.708717464,0.852941176,0.483333333,-0.927600639
+1274,35090.95489,845.9849624,589.9022556,1105.06015,32372.22556,673.8646617,534.1503759,1632.135338,18004.15038,564.0225564,459.6842105,1788.150376,25616.54135,1254.639098,5787.887218,5810.729323,9308.022556,1368.015038,383.8270677,2415.639098,17540.85714,400.3533835,291.1428571,424.1353383,21664.42105,412.5338346,128.7067669,4919.864662,17207.03008,1439.315789,1046.240602,2811.541353,14556.06015,590.9924812,291.1578947,3525.81203,10983.63158,846.2406015,450.112782,1316.06015,8764.233083,670.8646617,176.4736842,4207.451128,6981.203008,1339.240602,202.5112782,3262.571429,272.7518797,333.6541353,133,16.49830287,11.0571429,0.742181621,0.936619718,0.639423077,-1.195091287
+1275,35229.85915,957.1549296,575.5774648,1113.492958,30807.3662,736.4366197,842.6478873,1619.239437,17632.8169,620.1971831,1462.253521,1820.239437,24193.3662,1352.197183,6464.535211,4214.225352,8422.591549,1397.295775,395.5211268,2541.253521,16894.92958,448.2816901,201.1408451,1050.774648,19597.52113,451.943662,131.9577465,3960.535211,15911.07042,2151.197183,862.028169,2800.873239,13468.30986,653.4366197,297.5211268,1589.521127,10456.04225,1002.394366,460.0704225,1300.295775,7956.211268,670.6901408,179.3380282,3926.704225,6917.56338,1350.507042,387.7183099,3338.014085,334.5915493,331.8309859,71,10.35454657,9.048886867,0.486097299,0.934210526,0.58677686,-1.176148283
+1276,47203.44444,931.2444444,503.9111111,1117.688889,37226.02222,774.2666667,750.9111111,1585.822222,22582.02222,612.4,504.3111111,1721.355556,31975.37778,1443.355556,4224.088889,2995.222222,10897.55556,1452.511111,425.5555556,2569.533333,18876.91111,446.1777778,588.7111111,478.8888889,22337.62222,434.7777778,132.4,3403.444444,18481.77778,1595.577778,813.3333333,2819.644444,15736.35556,646.8444444,312.5333333,2106.666667,12638.82222,911.4222222,474.4444444,1321,8969.488889,767.3111111,173.5333333,2285,8163.733333,1395.155556,563.7333333,3303.177778,552.0888889,331.3111111,45,9.021598768,6.596474189,0.682177266,0.957446809,0.5625,0.331180249
+1277,37261.4011,854.4230769,451.989011,1083.318681,32122.84615,715.1043956,1074.098901,1553.120879,18541.46703,544.3186813,1626.379121,1767,25720.74176,1302.159341,5137.543956,3439.340659,9269.494505,1307.159341,370.8626374,2539.543956,17958.53297,497.3021978,187.1703297,1402.884615,21623.63736,952.2472527,474.7197802,3282.675824,17147.99451,1742.708791,646.2087912,2796.456044,14847.36264,606.9945055,275.3626374,2042.945055,12039.92308,1011.576923,422.6428571,1314.43956,8948.873626,643.5659341,159.9340659,3405.664835,7692.28022,1324.917582,508.8626374,3247.862637,605.6318681,334.9835165,182,17.86608913,14.07177281,0.616155303,0.875,0.631944444,0.246257703
+1278,36760.24051,856.5949367,553.6708861,1108.455696,34070.91139,699.1012658,616.443038,1669.974684,18811.75949,583.4810127,641.3037975,1774.202532,26715.94937,1275.35443,8244.025316,5866.43038,9591.012658,1365.670886,399.164557,2422.35443,18410.43038,410.4177215,197.5063291,445.0506329,22363.26582,878.8607595,134.0126582,6116.974684,17957.49367,1471.139241,748.7848101,2834.544304,14858.74684,605.7721519,311.7848101,4280.291139,10072.5443,847.8481013,442.3544304,1303.898734,8341.531646,654.9367089,182.9493671,3536.113924,6873.886076,1340.822785,170.9493671,3215.329114,216.3037975,333.5949367,79,11.02200716,9.37452963,0.525929193,0.94047619,0.598484848,-0.599324413
+1279,36016.475,839.8625,530.5541667,1111.383333,33180.8125,679.4333333,576.9083333,1645.1125,18493.89583,559.8708333,477.3291667,1772.983333,25845.34167,1251.095833,5931.866667,4086.704167,9504.958333,1336.854167,392.4625,2376.3625,18116.3625,815.2083333,128.7375,432.4416667,21900.70833,410.9333333,129.4916667,4870.095833,17482.67917,1441.8125,901.2958333,2815.725,14957.39167,608.125,301.3041667,4305.495833,10742.125,841.3333333,446.7541667,1309.5875,8832.116667,633.8291667,176.6833333,3320.658333,6998.070833,1313.804167,175.4458333,3210.145833,243.0583333,335.125,240,20.06403385,15.665145,0.624834154,0.926640927,0.75,1.349779701
+1280,36727.21176,989.2058824,611.6294118,1142.411765,32140.07647,744.5588235,761.3941176,1660.611765,18022.78235,622.8117647,855.9705882,1806.011765,25140.11176,1355.270588,6020.252941,5311.782353,8920.311765,1452.894118,405.6411765,2555.147059,17614.90588,456.6588235,170.9058824,751.7529412,20803.88824,563.6470588,140.0588235,4173.788235,16387.61176,1647.352941,998.9294118,2813.064706,14046.59412,618.3941176,305.9058824,2376.3,10974.29412,1094.241176,470.2235294,1315.358824,8564.094118,679.4117647,184.3176471,4831.958824,6912.664706,1371.029412,199.8058824,3385.452941,299.2470588,335.7647059,170,21.67261449,11.22864275,0.855318341,0.837438424,0.497076023,-0.804717792
+1281,41794.00662,907.0529801,492.4701987,1119.781457,36309.55629,760.1059603,814.4569536,1601.986755,20354.90728,592.4238411,825.8211921,1746.284768,29450.07285,1412.337748,4232.443709,3830.450331,10512.96026,1427.569536,412.8807947,2476.092715,20690.41722,520.4437086,485.4834437,1208.933775,23687.47682,498.1854305,234.3708609,2775.397351,19136.58278,1911.039735,835.6688742,2824.384106,16128.39735,650.9735099,319.4039735,1916.569536,13127.11258,1318.860927,481.8543046,1331.02649,9894.993377,872.4768212,194.9139073,3142.933775,8513.688742,1453.562914,247.4039735,3381.178808,508.0529801,334.8211921,151,14.54212474,14.17382424,0.223632477,0.898809524,0.719047619,0.597695407
+1282,22307.43011,723.4677419,473.9946237,1068.602151,18572.15591,589.844086,527.1290323,1597.435484,10420.28495,475.2365591,614.0860215,1810.865591,15225.16129,1129.580645,5053.483871,3143.333333,5556.833333,1144.892473,338.4892473,4459.016129,10023.99462,3249.639785,284.9032258,609.3548387,11700.09677,378.0376344,112.827957,5038.489247,9770.069892,1392.435484,852.1935484,2791.430108,8077.107527,585.1021505,251.2365591,14597.56989,6636.790323,910.0698925,384.8548387,1342.72043,5005.731183,788.5806452,164.5376344,3466.88172,4128.075269,1157.537634,160.2903226,3201.553763,770.8870968,335.516129,186,17.96118599,13.88371614,0.634425058,0.898550725,0.58125,-1.185090192
+1283,36734.37363,887.021978,623.0549451,1135.571429,34241.45055,690.956044,529.2747253,1683.901099,19100.53846,573.5934066,495.6923077,1778.89011,26722.05495,1292.043956,6840.648352,7673.351648,9982.725275,1382.989011,401.7032967,2407.571429,18966.61538,407.2747253,119.3516484,440.4725275,22767.78022,422.4835165,132.010989,5447.450549,18066.73626,1478.769231,1068.395604,2811.285714,15415.65934,615.7472527,311.7362637,3579.43956,11463.31868,897.1098901,461.4285714,1309.197802,9316.637363,638.0659341,179.3956044,3255.472527,7300.043956,1360.10989,157.0989011,3316.978022,257.5384615,334.4175824,91,11.842773,10.17705363,0.511392625,0.947916667,0.631944444,-0.849045764
+1284,35319.63889,925.7777778,536.6805556,1103.694444,31430.31944,757.375,609.0416667,1595.944444,18182.04167,604.8888889,516.75,1753.902778,25447.45833,1426.222222,3434.833333,5118.361111,9248.708333,1436.611111,419.4444444,2489.958333,17674.15278,448.25,993.1666667,494.875,20499.73611,448.375,137.3194444,2888.902778,16620.44444,1624.402778,928.1388889,2801.944444,14079.88889,663.1944444,310.875,2284.597222,11282.31944,912.4166667,475.7222222,1349.25,8662.305556,849.7916667,198.9166667,4355.361111,7472.597222,1501.763889,155.25,3297.111111,392.3611111,332.9444444,72,12.58541819,7.854531728,0.781346238,0.818181818,0.571428571,-1.500344324
+1285,20872.80628,1006.947644,496.5549738,1028.52356,18171.36649,671.2356021,413.1518325,1360.465969,9759.581152,532.7434555,393.565445,1680.298429,14561.49215,1297.795812,2288.376963,1324.371728,5150.848168,1267.685864,364.9947644,2421.04712,10041.46073,387.9005236,428.6492147,424.1884817,11650.52356,368.4816754,122.8115183,1155.837696,9609.031414,1397.356021,724.7853403,2829.691099,8186.748691,846.8272251,266.5549738,1465.157068,6780.748691,801.0890052,426.052356,1314.554974,5156.549738,712.6020942,172.7905759,2186.251309,4575.413613,1420.675393,4369.518325,3102.125654,432.486911,336.6963351,191,17.84790296,14.06474858,0.615632135,0.931707317,0.624183007,-1.053114607
+1286,18855.69312,710.1164021,498.4391534,1079.978836,15556.36508,573.6719577,379.6455026,1556.238095,8991.386243,456.1640212,383.6825397,1811.910053,13491.26984,1098.878307,5373.624339,3184.798942,4803.243386,1116.952381,329.4285714,2455.333333,8698.359788,7935.285714,122.9417989,423.6031746,10168.85714,430.8677249,111.7671958,6629.492063,8607.47619,1274.021164,982.4391534,2789.608466,7112.216931,1109.978836,249.015873,13132.96825,5880.529101,713.1587302,374.8201058,1324.21164,4385.640212,697.9047619,152.1534392,4237.465608,3710.10582,1137.497354,153.1375661,3232.915344,800.5238095,336.6931217,189,17.80547963,13.71629931,0.637631573,0.969230769,0.694852941,0.523692436
+1287,17072.46154,717.3426573,512.6013986,1049.265734,14939.45455,581.6923077,547.3566434,1613.776224,8258.48951,458.027972,756.958042,1840.034965,11941.52448,1121.482517,7998.811189,4421.93007,4365.496503,1134.972028,344.1048951,4025.314685,7919.818182,586.1048951,896.2657343,520.7622378,9411.636364,374.4965035,114.8671329,8900.846154,7645.230769,1381.097902,996.3986014,2784,6299.699301,535.5734266,255.1048951,16659.01399,5155.72028,883.6363636,374.5384615,1378.867133,3747.076923,913.8671329,147.2867133,4621.503497,3262.916084,1136.125874,166.1608392,3143.615385,837.4755245,337.1888112,143,17.50270013,11.40046551,0.758773412,0.882716049,0.567460317,0.233016154
+1288,16614.24561,1044.745614,592.6578947,1062.964912,14395.17544,778.6929825,602.4824561,1466.570175,8355.578947,618.9035088,589.0263158,1843.745614,11737.74561,1305.54386,8260.017544,3411.570175,4173.201754,1324.535088,448.4298246,2446.526316,8194.333333,405.0526316,3471.640351,520.8070175,8675.675439,423.0964912,120.9736842,3723.807018,6791.482456,1966.22807,768.2368421,2815.657895,5769.640351,876.9385965,265.5087719,1868.04386,4734.035088,830,419.0614035,1420.5,3898.377193,1707.929825,168.0701754,6230.754386,3330.508772,1294.377193,236.2105263,3393.026316,407.5877193,336.6491228,114,14.24122528,10.2635357,0.693255498,0.94214876,0.74025974,0.251692477
+1289,31755.84,822.0266667,521.6133333,1101.453333,27120.66667,693.6533333,630.56,1560.4,15545.16,555.96,557.9066667,1775.52,21857.18667,1301.573333,4469.226667,4049.04,7750.493333,1328.666667,405.92,2557.933333,14438.84,408.3333333,827.6533333,604.1466667,16968.64,416.64,140.5333333,3747.866667,13732.94667,1666.08,1009.973333,2824.266667,11933.24,601.2,284.7066667,2042.72,9552.266667,884.8933333,439.2533333,1331.533333,7114.8,860.7866667,175.8,4197.96,6012.066667,1306.853333,216.8933333,3226.586667,558.3466667,335.5333333,75,13.43983511,7.489784813,0.830322963,0.925925926,0.480769231,-0.84405128
+1290,27456.50685,754.260274,406.0136986,1072.821918,24385.23288,622.9315068,578.6438356,1497.547945,13239.23288,484.8356164,544.5890411,1778.767123,19175.80822,1172.616438,2861.438356,2742.246575,7257.315068,1248.712329,344.5616438,2495.054795,14209.42466,6652.191781,134.9315068,730.8082192,16159.46575,456.6027397,149.0410959,3052.452055,12348.54795,1495.726027,795.0821918,2792.383562,10626.41096,607.7534247,253.6027397,2176.369863,8620.60274,838.3424658,399.7808219,1302.054795,6662.109589,642.2739726,149.8082192,2026.30137,5377.657534,1231.452055,259.4520548,3170.246575,593.7945205,335.5205479,73,11.08467603,8.802769385,0.607736657,0.901234568,0.561538462,0.042592559
+1291,13352.30952,673.5,444.0595238,1040.857143,11600.72619,550.3333333,378.952381,1565.357143,5400.071429,412.5238095,360.5238095,1744.97619,8767.428571,1069.02381,4822.02381,2043.107143,3224.690476,1073.595238,311.2142857,2442.095238,5834.107143,2675.797619,160.047619,413.7261905,7064.154762,411.9404762,112.2619048,5390.107143,5903.309524,1253.547619,818.0714286,2780.166667,4787.595238,1105.678571,238.1071429,11633.40476,3705.380952,736.7738095,371.6904762,1315.559524,2286.690476,611.3809524,147.8928571,5040.083333,2154.392857,1051.75,182.4642857,3144.095238,1003.452381,337.0952381,84,15.12102769,7.272372467,0.876751137,0.923076923,0.666666667,0.289406724
+1292,23252.23423,841.8468468,659.9279279,1119.882883,19722.72072,657.4414414,591.7927928,1794.387387,10413.73874,479.9279279,481.981982,1779.738739,15546.54054,1200.072072,3616.720721,2281.036036,5674.072072,1269.495495,365.5855856,2562.414414,10634.7027,598.8918919,1048.918919,477.2072072,12587.10811,489.7837838,118.5495495,3026.036036,10633.72072,1422.477477,669.1081081,2821.963964,8616.900901,567.4054054,302.3783784,21979.38739,6663.702703,1075.504505,418.5495495,1379.855856,4660.648649,1068,167.2252252,5904,4231.81982,1225.864865,205,3227.990991,926.5855856,337.6846847,111,13.13455913,10.91204269,0.556588011,0.932773109,0.660714286,0.088098998
+1293,19387.56667,750.7733333,547.3133333,1118.526667,16449.39333,602.2866667,651.7733333,1760.58,8290.113333,447.3266667,446.9,1809.673333,12957.85333,1150.533333,7209.686667,3548.286667,4817.773333,1143.246667,336.24,2644.766667,8650.653333,869.54,163.9733333,462.0266667,10372.03333,430.96,118.3133333,9021.973333,8636.68,1371.306667,1003.393333,2805.693333,6916.993333,602.4733333,252.5533333,12500.79333,5460.753333,806.72,386.4333333,1324.846667,3537.813333,611.4733333,150,5300.226667,3201.88,1126.086667,171.5266667,3210.166667,971.6066667,340.3466667,150,18.8389841,10.40261774,0.833721144,0.909090909,0.625,0.023553597
+1294,19190.66139,808.2626582,713.1044304,1150.81962,13007.27848,571.1075949,552.6329114,1648.458861,6074.768987,430.5917722,441.7373418,1767.5,10213.98101,1111.601266,6208.642405,2412.044304,3689.873418,1115.547468,325.0316456,2636.971519,6609.620253,484.6139241,760.2816456,470.2943038,7991.471519,402.3481013,112.7753165,9067.044304,6706.981013,1422.300633,797.3955696,2795.825949,5347.990506,541.6582278,251.5696203,17793.56962,4126.879747,806.193038,371.3512658,1311.93038,2449.553797,864.8702532,148.3607595,6292.10443,2371.572785,1056.794304,181.0221519,3131.563291,1018.408228,342.9525316,316,26.57610825,15.67293623,0.807594762,0.94047619,0.574545455,-0.66101547
+1295,38866.11299,857.8644068,524.7514124,1139.440678,37073.34463,689.0508475,531.9943503,1698,19873.13559,558.6553672,488.0621469,1796.757062,28649.84746,1284.80791,4671.19774,3735.954802,10441.28249,1376.740113,395.0338983,2394.954802,19835.70056,420.819209,192.9717514,435.5932203,24009.51412,429.4463277,133.9548023,4302.644068,19154.11864,1489.887006,695.3163842,2862.423729,16220.24859,620.9152542,304.8361582,4670.084746,11276.48023,819.6610169,451.9096045,1311.870056,9445.881356,657.9152542,175.3389831,2616.163842,7456.322034,1313.451977,181.6158192,3227.084746,226.2259887,339.3107345,177,17.64181628,13.08416027,0.670780338,0.917098446,0.614583333,-0.923024623
+1296,30611.72989,959.7758621,454.5172414,1053.632184,26655.2931,716.5229885,610.2413793,1467.856322,14835.70115,560.8390805,413.7816092,1725.132184,21382.02874,1314.465517,3200.045977,3105.844828,7575.327586,1266.270115,369.6091954,2472.971264,12922.43103,430.7586207,108.6436782,474.6034483,15400.1092,361.8850575,116.2758621,2335.689655,12388.37356,1390.637931,667.7298851,2778.45977,10468.72989,571.4827586,249.8045977,1874.942529,8563.091954,807.5,389.4942529,1284.321839,6522.551724,595.0632184,148.5804598,1456.465517,5435.488506,1247.597701,553.454023,3252.718391,630.7298851,339.6206897,174,18.35940596,12.80681546,0.716524878,0.887755102,0.58,-1.528861154
+1297,19980.35897,800,408.8205128,1038.012821,18030.66667,662.3205128,456.7051282,1379.576923,10160.64103,521.2564103,366.7051282,1639.025641,14625.69231,1328.448718,1521.435897,1159.269231,5238.076923,1219.384615,363.8076923,2543.846154,9669.397436,482.4358974,140.3076923,449.6282051,11446.01282,354.2051282,117.9487179,1234.666667,9241.141026,1319.192308,557.1282051,2796.5,7939,568.0384615,257.1025641,1867.217949,6724.423077,817.1410256,402.9230769,1291.923077,5179.307692,619.9871795,161.2564103,2187.717949,4406.051282,1338.538462,784.4102564,3027.551282,649.3589744,336.5641026,78,11.55639889,8.99082407,0.628270091,0.876404494,0.590909091,1.159326063
+1298,18937.20301,814.0526316,833.7819549,1191.240602,15732.6015,631.8345865,622.7669173,1858.300752,8065.774436,479.2706767,447.4210526,1853.556391,13018.96992,1250.150376,7188.075188,3168.451128,4585.451128,1201.458647,361.0601504,2479.345865,8598.06015,566.3383459,159.4511278,442.924812,10394.13534,407.6691729,123.2781955,8575.766917,8780.082707,1371.533835,950.0827068,2808.135338,7043.451128,581.6390977,279.0902256,23176.79699,5588.721805,859.5112782,398.7293233,1343.646617,3566.165414,606.2932331,158.4285714,6458.082707,3397.691729,1182.887218,192.8796992,3218.488722,981.9924812,338.3308271,133,15.15455758,11.69734742,0.635780464,0.93006993,0.863636364,0.19030204
+1299,24102.84892,857.1007194,763.6258993,1158.323741,18873.17266,681.2805755,989.4964029,1841.482014,9270.798561,493.1007194,438.6330935,1814.107914,14708.04317,1249.870504,4175.805755,2216.244604,5258.294964,1277.510791,359.2877698,2477.640288,9720.417266,663.4532374,188.5107914,448.2446043,11829.19424,494.323741,122.0719424,5401.611511,9724.410072,1463.381295,763.9856115,2821.820144,7753.755396,609.8417266,276.4532374,9048.460432,5940.410072,908.7841727,411.2374101,1322.107914,3692.517986,632.8561151,155.647482,4420.848921,3450.388489,1181.143885,164.9856115,3284.467626,993.6043165,339.2805755,139,15.84982232,11.4494745,0.69150422,0.896774194,0.668269231,-0.295299528
+1300,22228.47945,770.0410959,500.6232877,1068.376712,11558.85616,487.7260274,344.0958904,1260.253425,4949.979452,371.2534247,1277.410959,1667.664384,8976.376712,936.0547945,4312.171233,1809.972603,3193.410959,948.890411,284.1986301,3482.958904,5791.657534,320.3630137,852.7191781,742.5410959,7123.143836,291.5136986,98.64383562,3833.164384,5755.986301,1599.308219,592.8356164,2776.438356,4492.568493,463.9863014,199.0410959,4750.643836,3431.349315,763.5136986,318.7465753,1274.226027,1711.986301,677.1369863,129.7945205,3456.431507,1797.753425,882.1506849,218.369863,2946.452055,1079.020548,339.4041096,146,17.34961544,10.96638621,0.774901198,0.948051948,0.760416667,-0.338187008
+1301,30785.70968,767.983871,531.5645161,1103.032258,28234.75806,710.3548387,497.2419355,1653.967742,14777.80645,519.3064516,1149.403226,1856.290323,21889.74194,1171.403226,6309.774194,4987.096774,8091.274194,1265.951613,378.4032258,2491.241935,15681.90323,399.1935484,380.0806452,654.6935484,19019.09677,414.1935484,183.0806452,4806.370968,14608.30645,1691.790323,896.4677419,2816.596774,12141.85484,561.3387097,268.8870968,3817.048387,8067.467742,803.2903226,407.5483871,1311.629032,7102.322581,685.8064516,170.0967742,3126.483871,5447.709677,1218.548387,266.3387097,3239.645161,202.7580645,336.5967742,62,12.24422891,6.803147264,0.831435877,0.911764706,0.596153846,1.25993859
+1302,32265.42529,849.4367816,484.9655172,1070.678161,29952.4023,727.4022989,678.0574713,1569.011494,16609.73563,570.0114943,1059.770115,1826.436782,23638.73563,1292.609195,5090.54023,3283.356322,8359.793103,1380.91954,392.5747126,2505.643678,15894.01149,412.4137931,850.2758621,737.3448276,19331.27586,427.7586207,319.2643678,3225.747126,15068.02299,1749.390805,918.2643678,2798.804598,13019.44828,803.5402299,292.6896552,2022.321839,10281.51724,918.0229885,448.6666667,1321.011494,8108.494253,854.1954023,178.4137931,4729.643678,6765.528736,1394.827586,582.9310345,3204.344828,351.908046,337.6551724,87,13.53129676,8.483494004,0.779056671,0.887755102,0.608391608,-1.290260635
+1303,15932.36923,815.8564103,441.6205128,1030.533333,14420.15897,661.8564103,526.1384615,1413.887179,7982.189744,524.8307692,420.9794872,1707.092308,11569.74872,1245.102564,2136.810256,1306.517949,4252.882051,1272.153846,379.1435897,2398.851282,8158.564103,391.8512821,812.9025641,444.1589744,9353.430769,386.8923077,120.974359,898.225641,7438.364103,1416.707692,777.3589744,2816.564103,6344.748718,603.5692308,260.1282051,1516.54359,5225.717949,868.5538462,421.2410256,1325.425641,4263.020513,1257.733333,174.1692308,2520.312821,3671.897436,1843.405128,1626.369231,3125.825641,370.425641,341.1897436,195,17.45522599,14.646057,0.544032259,0.942028986,0.819327731,-0.139891389
+1304,37320.09626,974.1657754,521.3850267,1107.550802,33341.48663,769.8663102,596.2994652,1669.058824,18445.7754,615.1336898,623.6256684,1774.470588,25693.49733,1384.919786,5223.882353,3537.40107,9126.882353,1401.208556,413.1122995,2488.967914,17967.00535,453.1925134,1429.31016,562.3208556,19981.39572,448.7807487,136.0534759,3340.459893,16133.42781,1672.342246,859.0588235,2807.550802,13806.79679,675.144385,294.1229947,1827.946524,11036.39037,905.7272727,463.1336898,1339.283422,8621,916.171123,179.6631016,4117.085561,7170.470588,1417.42246,165.8609626,3329.406417,396.2727273,341.9090909,187,19.03738295,14.43921848,0.651711951,0.806034483,0.55,1.311003903
+1305,24657.90678,830.1101695,569.5169492,1084.516949,21379.90678,676.1186441,571.1864407,1508.305085,12047.51695,544.559322,457.940678,1763.991525,17149.27966,1295.016949,5568.550847,3121.118644,6078.923729,1297.483051,388.6864407,2489.237288,11291.92373,411.5423729,1737.262712,444.4830508,13468.58475,425.1271186,126.6101695,4114.872881,10568.62712,1551.601695,824.4152542,2809.254237,9174.127119,606.6864407,265.1101695,2601.90678,7364.754237,826.8135593,429.7372881,1343.144068,5726.974576,1087.161017,168.1271186,4802.059322,4682.644068,1286.805085,319.9830508,3194.381356,565.2627119,340.4237288,118,15.72024345,9.970225793,0.773145692,0.936507937,0.561904762,-0.631547318
+1306,35657.54237,802.440678,435.8813559,1090.372881,29964.44068,663.779661,1348.949153,1642.847458,18275.15254,552.8644068,1420.847458,1738.237288,24033.83051,1278.661017,6507.932203,2769.135593,8475.457627,1295.237288,378.6610169,5125.355932,16595.30508,1213.864407,171,1023,19216.64407,451.0847458,119.8813559,3091.694915,16062.64407,1685.084746,643.3050847,2835.338983,13518.01695,625.4745763,276.3389831,3996.152542,10814.18644,1023.40678,418.8135593,1304.745763,8010.355932,652.2881356,163.3728814,2272.186441,6810.559322,1251.508475,212.1525424,3212.101695,709.7288136,336.4745763,59,10.86138791,7.08992005,0.75756156,0.936507937,0.614583333,-1.376017177
+1307,35736.48696,880.6869565,609.7826087,1131.191304,32148.35652,701.3304348,802.7043478,1730.417391,16918.1913,574.6695652,1219.904348,1834.313043,24434.63478,1267.391304,7000.930435,4779.843478,8918.513043,1348.417391,396.6086957,4055.547826,17080.01739,428.6347826,431.7826087,766.9652174,20651.93043,430.6,134.2695652,6080.991304,16068.63478,1751.269565,748.4086957,2810.13913,13367.94783,584.5652174,296.9652174,5457.06087,8396.434783,1028,436.4086957,1321.904348,7228.756522,723.7565217,171.9304348,3230.33913,5834.147826,1283.782609,275.9565217,3264.86087,194.9304348,341.4086957,115,16.31011135,9.445259819,0.815253281,0.884615385,0.58974359,0.511266511
+1308,30426.35135,870.6891892,551.3378378,1111.689189,27173.25676,700.8243243,1375.243243,1623.040541,15258.93243,576.8918919,1558.932432,1852.581081,21235.94595,1295.756757,6428.72973,4676.135135,7691.594595,1388.391892,388.6486486,2850.108108,15099.85135,937.6081081,338.7432432,1384.891892,17590.27027,500.5405405,151.8243243,4518.824324,14003.78378,1817.648649,889.0675676,2810.175676,12010.85135,625.2297297,297.7432432,2198.581081,9384.837838,1290.864865,456.4594595,1321.297297,7380.945946,692.7027027,175.1756757,5169.22973,6062.094595,1343.22973,330.1351351,3333.824324,307.1081081,339.1081081,74,13.31779057,7.410202931,0.830905316,0.880952381,0.517482517,-0.913941
+1309,15369.11538,1230.980769,616.0192308,1062.769231,14413.76923,775.7884615,514.0192308,1422.769231,7434.961538,647.8653846,691.1153846,1765.557692,9583.307692,1259.461538,7879.288462,2972.596154,3435.096154,1233.019231,342.3653846,2459.75,7359.923077,477.0576923,330.1538462,574.1538462,7222.807692,372.7307692,153.3076923,6164.230769,5766.076923,1440.807692,904.0769231,2798.365385,5076.884615,544.0384615,239.3269231,1493.019231,3941.173077,732.2307692,387.1730769,1300.096154,3202.673077,608.2692308,154.0961538,3857.519231,2433.442308,1076.230769,153.25,3469.115385,340.3653846,338.0384615,52,9.171431425,7.413221401,0.588777825,0.928571429,0.577777778,-1.217957885
+1310,33528.52215,845.5221519,474.9651899,1086.708861,29382.18671,717.3544304,726.8924051,1519.727848,16058.71203,562.6360759,1007.155063,1762.639241,23102.41456,1351.151899,3547.64557,3249.335443,8313.908228,1362.962025,396.9398734,2609.417722,15424.95253,446.2405063,1339.537975,766.4398734,18233.17722,523.056962,131.4651899,2205.553797,14460.75633,1799.844937,736.9208861,2819.443038,12205.81646,672.9398734,285.7816456,1909.946203,10022.74684,1159.544304,453.6740506,1353.458861,7768.531646,961.6360759,178.0727848,4895.14557,6376.39557,1367.338608,509.7468354,3162.275316,529.4968354,345.7974684,316,22.6464361,18.3068483,0.588665715,0.93768546,0.601904762,-0.404622786
+1311,22881.94118,786.9215686,426.1372549,1036.196078,19320.10784,677.0392157,735.4117647,1406.519608,11086.69608,530.4117647,1298.205882,1778.147059,16007.2549,1250.098039,5861.27451,3020.980392,5751.480392,1287.470588,382.8431373,2531.235294,10960.15686,403.0588235,1633.039216,1301.980392,12900.35294,527.6078431,122.8627451,1463.137255,10584.12745,2025.568627,813.754902,2812.607843,9031.72549,898.4215686,263.1078431,1517.460784,7430.892157,1220.186275,428.6764706,1357.607843,5555.460784,1021.058824,163.7058824,3734.254902,4798.745098,1319.666667,591.9117647,3248.117647,544.4313725,340.1470588,102,12.37005507,10.55571439,0.521374452,0.971428571,0.708333333,1.064000228
+1312,17049.97222,701.2986111,495.4375,1053.608796,14757.2963,571.4467593,532.1828704,1612.733796,8216.648148,452.7962963,551.1064815,1801.030093,12152.88426,1100.50463,5582.439815,3502.395833,4379.344907,1108.337963,333.1805556,2903.465278,7915.840278,3445.747685,437.650463,473.6805556,9423.423611,410.6458333,113.9097222,6797.930556,7781.020833,1397.412037,929.2824074,2800.201389,6374.243056,579.2962963,245.775463,13905.63194,5161.766204,828.8518519,376.625,1322.347222,3672.777778,759.412037,147.4189815,4532.898148,3231.31713,1108.844907,134.3333333,3202.768519,867.4606481,345.9722222,432,27.08099696,21.39204333,0.61319934,0.87804878,0.642857143,-1.145057668
+1313,30472.80451,827.7293233,523.8120301,1097.233083,14331.36842,544.1428571,573.2481203,1523.067669,6132.496241,407.0526316,933.4135338,1758.518797,10677.30827,1022.135338,6759.578947,2955.225564,3866.300752,1049.796992,314.2030075,5330.421053,7025.511278,657.9097744,401.4887218,591.3458647,8603.225564,357.2556391,110.593985,6174.729323,6900.285714,2004.691729,635.0827068,2786.285714,5331.488722,606.7669173,211.4511278,6333.766917,4009.458647,852.9398496,342.0601504,1286.323308,2076.781955,586.7218045,148.5413534,4959.323308,2079.56391,954.7744361,239.4210526,3048.56391,1067.87218,340.7593985,133,14.86525787,12.16560279,0.574660875,0.917241379,0.678571429,-0.584275471
+1314,34656.18947,916.9263158,523.8,1123.168421,30370.12632,790.1368421,1062.378947,1618.084211,16440.75789,598.5157895,2114.978947,1816.631579,23669.62105,1440.389474,4304.021053,4952.368421,8417.368421,1416.336842,413.1368421,2549.336842,16381,486.1894737,639.2526316,1445.873684,18248.23158,615.0947368,520.1684211,2992.084211,14621.05263,2309.031579,868.2631579,2819.284211,12303.64211,673.7789474,308.0421053,1982.284211,9890.063158,1492.284211,474.4631579,1324.842105,7721.884211,807.1052632,190.3473684,5254.536842,6487.421053,1438.705263,358,3244.431579,485.5684211,340.9157895,95,13.95097026,10.27633766,0.676324513,0.805084746,0.527777778,-0.595444504
+1315,14678.31538,638.5769231,411.6307692,1015.6,12315.21538,533.0230769,355.0538462,1408.146154,7230.638462,433.7384615,368.6692308,1751.207692,10316.15385,1050.946154,4749.892308,2393.938462,3738.792308,1086.969231,350.4230769,3138.107692,6911.923077,1001.938462,1640.069231,434.8230769,7902.261538,325.3846154,105.0538462,4291.046154,6544.515385,1318.561538,641.8461538,2779.5,5501.576923,681.3538462,223.7615385,11174.64615,4541.1,761.8384615,352.4923077,1341.030769,3375.338462,1113.115385,141.9,3590.615385,2859.715385,1059.284615,190.0076923,3050.330769,731.1923077,340.9615385,130,14.78132678,11.32343018,0.642765281,0.948905109,0.666666667,-1.054052023
+1316,24787.232,706.208,428.144,1047.392,20059.32,581.512,807.208,1487.512,11715.344,471.944,1208.44,1789.744,16564.288,1117.32,5359.16,3376.96,6089.664,1150.336,344.832,10542.752,11171.36,657.912,449.8,1224.864,12879.096,359,112.776,3446.848,10919.664,1619.296,749.256,2807,9067.04,563.168,248.872,7349.592,7440.128,1228.304,382.2,1393.6,5576.552,739.512,149.288,3255.144,4730.424,1148.408,193.4,3136.488,780.8,341.464,125,17.19926986,9.927959521,0.816580584,0.919117647,0.555555556,-0.600456786
+1317,16727.7541,689.5163934,492.442623,1054.893443,14204.69672,570.5901639,419.647541,1544.147541,7860.590164,448.9016393,426.1229508,1805.745902,11462.57377,1086.860656,5232.434426,3703.360656,4248.754098,1103.02459,322.2868852,3009.565574,7586.02459,4090.516393,220.5409836,466.4918033,8610.040984,376.4344262,108.5081967,6298.778689,7364.147541,1334.262295,1197.606557,2778.434426,6137.57377,814.6229508,233.4508197,9301.934426,5057.622951,731.704918,365.0655738,1295.598361,3764.237705,728.2377049,144.6885246,4430.270492,3132.491803,1113.254098,133.647541,3141.311475,790.852459,343.3442623,122,14.14787726,11.81633607,0.549943214,0.903703704,0.580952381,0.120749369
+1318,40556.26667,937.6666667,557.7916667,1094.991667,36254.28333,757.15,1149.891667,1645.4,20378.33333,623.275,2328.483333,1822.016667,28636.46667,1353.633333,6320.525,5802.75,10197.1,1418.191667,405.35,2685.591667,20428.48333,441.825,209.1666667,1729.991667,23691.86667,448,247.3666667,2815.991667,19213.73333,2116.441667,837.7833333,2818.1,16321.04167,633.4666667,306.2833333,1735.1,12655.54167,1461.7,475.1333333,1310.866667,9931.733333,674.025,180.5166667,3581.675,8235.266667,1404.05,252.7583333,3342.541667,316.6833333,341.225,120,15.99873845,9.846789164,0.788158087,0.930232558,0.625,-1.089322482
+1319,21575.98089,787,501.8216561,1100,19473.02548,618.2101911,519.4394904,1551.025478,10947.29299,526.7324841,647.8980892,1824.878981,15247.12102,1175.808917,7476.789809,3118.267516,5509.566879,1259.401274,360.2675159,2503.216561,10803.71338,4496.649682,273.0955414,526.5414013,12493.4586,434.7707006,124.1847134,5727.700637,10011.21019,1485.44586,976.4522293,2853.898089,8455.592357,595.7197452,260.5350318,1800.433121,6661.33121,833.0828025,416.5159236,1303.917197,5077.910828,676.7770701,162.7961783,5362.961783,4385.133758,1229.375796,153.2675159,3313.191083,333.4904459,344.4968153,157,18.13771999,11.68764769,0.764702485,0.897142857,0.659663866,0.554221714
+1320,32569.46429,826.0595238,451.6309524,1071.821429,28421.21429,710.9404762,549.4761905,1529.964286,16206.2381,527.6071429,667.3928571,1733.119048,22260.78571,1312.190476,3426.928571,3083.380952,8597.857143,1320.916667,376.5714286,2502.369048,15387.13095,453.0357143,361.25,776.9761905,18251,477.7261905,131.297619,2723.47619,14329.42857,1484.178571,697.0595238,2814.571429,12222.85714,583.9404762,264.8928571,2203.035714,9836.047619,833.8214286,404.25,1301.27381,7501.607143,682.5,160.5714286,2259.702381,6053.785714,1333.72619,671.7261905,3164.892857,615.3928571,341.3333333,84,11.35549381,9.717234301,0.517422971,0.884210526,0.636363636,-1.498821355
+1321,26274.72353,736.3941176,481.3411765,1039.976471,23173.15294,617.6941176,1021.958824,1566.452941,13126.02353,507.2764706,2257.311765,1915.976471,18580.40588,1231.576471,7205.817647,3947.5,6662.858824,1184.452941,341.1411765,7089.823529,12784.47647,1019.688235,320.0941176,1667.947059,14751.27059,393.3705882,124.8764706,3413.4,12148.87059,2239.952941,824.2764706,2804.247059,10187.98824,621.2470588,254.0117647,3433.194118,8347.6,1635.888235,389.2588235,1315.158824,6282.111765,674.1058824,154.0941176,5696.941176,5294.052941,1207.394118,706.7117647,3160.923529,680.2470588,343.1176471,170,19.00195208,11.66132833,0.789546242,0.918918919,0.674603175,-1.13904327
+1322,24588.795,737.6425,455.52,1048.7025,21590.345,632.705,534.1225,1453.26,12022.86,491.155,604.89,1750.5475,16962.8225,1192.655,4678.3675,3103.9575,6167.6475,1229.025,347.23,2507.9675,11885.3575,403.8225,890.68,772.25,13913.85,389.7975,249.675,3156.495,11125.5425,1506.7125,768.48,2825.2175,9697.5925,713.7725,257.4275,2589.225,7737.405,799.77,410.4325,1321.78,5959.3975,839.8125,161.555,3540.4375,4876.96,1237.6,376.455,3153.575,577.1175,350.755,400,25.74127753,20.33532225,0.613121208,0.934579439,0.644122383,0.279926729
+1323,43431.76119,852.8358209,485.1343284,1134.462687,37239.14925,710.6865672,525.0597015,1586.701493,21533.86567,556.6567164,399.0149254,1694.358209,29988.47761,1332.402985,4847.029851,3611.567164,10740.1791,1362.074627,385.4029851,2427.671642,20659.65672,1866.029851,161.5074627,450.7910448,24384.8209,407.1641791,127.1641791,3275.38806,19535.77612,1493.955224,875.641791,2809.179104,17007.07463,623.2089552,301.8059701,2078.80597,13643.68657,889.7761194,454.2686567,1313.880597,9962.402985,650.5522388,164.8059701,2113.104478,8637.955224,1373.522388,151.0298507,3215.41791,586.6119403,340.4477612,67,12.05544463,7.441594335,0.786742926,0.957142857,0.572649573,1.116048326
+1324,30603.04839,894.2258065,459.4193548,1062.145161,26615.20968,696.2419355,463.7580645,1470.354839,15685.83871,543.7741935,395.5322581,1693.725806,22066.16129,1411.596774,1532.467742,1231.870968,7783.274194,1291.548387,386.1935484,2495.290323,13734.24194,514.9516129,313.2903226,435.1129032,15989.37097,368.1935484,120.0645161,1274.5,13104.6129,1423.290323,559.3064516,2783.629032,11233.54839,602.016129,263.0967742,1761.951613,9043.16129,909.9516129,416.8387097,1274.274194,6783.758065,684.4193548,172.1129032,1470.774194,5823.677419,1379.951613,1053.080645,3058.209677,657.8870968,341.4032258,62,9.717534734,8.21031479,0.53492921,1,0.688888889,-0.097821701
+1325,26498.88119,748.3663366,425.990099,1036.811881,22949.64356,647.8316832,781.2277228,1490.70297,13211.34653,506.3564356,1064.940594,1770.663366,18542.39604,1205.465347,5424.772277,3028.514851,6634.316832,1204.50495,354.950495,3899.633663,12771.70297,850.5544554,408.0990099,814.0891089,14992.12871,369.0693069,116.5643564,2298.287129,12166.08911,1737.247525,674.4455446,2796.514851,10363.93069,678.3960396,255.3663366,3303.514851,8375.633663,1029.534653,394.1881188,1293.643564,6323.70297,691.7029703,152.5940594,3252.287129,5410.049505,1265.188119,1535.29703,3100.09901,667.3366337,342.3663366,101,13.7558284,9.581591099,0.717510456,0.943925234,0.701388889,-0.608639771
+1326,21987.8,670.3809524,413.9809524,1026.285714,18751.97143,567.8190476,445.6190476,1455.485714,11021.62857,457.152381,566.3238095,1744.342857,14955.92381,1127.52381,4454.647619,1945.247619,5369.742857,1135.914286,322.2571429,3070.628571,10270.49524,15952.26667,177.447619,521.247619,11774.62857,451.5714286,113.647619,5441.904762,9891.542857,1423.27619,833.1047619,2772.92381,8126.019048,1069.752381,233.1333333,4070.180952,6561.72381,860.1619048,365.4761905,1282.942857,4958.466667,646.4761905,148.2952381,3177.819048,4145.72381,1107.590476,202.4857143,3081.457143,702.352381,343.047619,105,13.06161458,10.48262714,0.596581942,0.921052632,0.673076923,0.784394341
+1327,15503.15646,622.9931973,414.9319728,1005.326531,13637.05442,534.2653061,438.3537415,1442.088435,7628.734694,433.292517,551.585034,1782.462585,11092.26531,1024.421769,5682.244898,2593.095238,3998.401361,1083.115646,321.9047619,3452.972789,7401.401361,4648.945578,882.122449,496.4353741,8434.544218,356.5578231,106.5170068,5768.163265,7066.47619,1380.217687,744.1088435,2766.829932,5972.945578,709.122449,214.1088435,5282.394558,4888.761905,800.4285714,343.8639456,1316.319728,3702.911565,856.6734694,143.8231293,3084.959184,3096.489796,1032.29932,193.9931973,3059.129252,715.2244898,344.8639456,147,15.11756716,12.61961246,0.550606738,0.960784314,0.7,-0.632461409
+1328,42941,892.9787234,567.0851064,1143.489362,39299.29787,724.787234,637.5957447,1695.808511,22534.48936,601.0851064,444.6170213,1799.06383,31793.97872,1343.510638,8341.085106,6197.425532,11407.68085,1430.829787,405.5319149,2369.957447,21779.87234,420.1276596,134.7446809,432.7446809,26485.97872,409,141.5957447,5522.680851,21557.21277,1504.744681,971.0851064,2811.340426,18226.76596,615.212766,319.7234043,2181.723404,13633.6383,894.5106383,479.0212766,1314.170213,10831.65957,640.4255319,177.7446809,2916.255319,8816.659574,1399.489362,125.5319149,3323.340426,262.4893617,341.212766,47,9.706196294,6.62360504,0.73096966,0.854545455,0.534090909,1.488553161
+1329,14577.96078,750.3529412,521.372549,1050.45098,15512.45098,619.4313725,837.4901961,1496.470588,7224.529412,478.3921569,912.745098,1805.156863,10885.66667,1161.666667,8745.529412,6224.627451,4261.745098,1178.196078,316.0980392,2488.823529,7926.117647,828.5882353,598.5490196,604.6078431,9187.529412,1562.196078,118.8627451,5275.666667,6936.137255,1372.960784,882.0588235,2783.411765,6169.313725,589.9607843,244.5098039,3439.333333,5075.235294,946.3333333,389.8235294,1319.352941,4127.196078,750.2352941,146.9803922,5704.019608,3200.392157,1217.098039,451.4117647,3100.921569,598.8431373,343.3137255,51,10.54142463,6.374588872,0.79643969,0.910714286,0.579545455,0.073750206
+1330,19670.31016,693.8770053,453.0106952,1037.860963,17209.1016,578.0588235,437.6096257,1523.486631,9901.695187,463.315508,363.7486631,1779.128342,13211.41176,1109.379679,4586.411765,2348.117647,4914.064171,1131.42246,338.0588235,2488.433155,9196.695187,5415.15508,578.5508021,425.9358289,10612.09091,387.5347594,109.2139037,5393.074866,8798.165775,1324.561497,713.6256684,2790.379679,7528.582888,692.1176471,245.0213904,9578.673797,5965.57754,742.5668449,366.6363636,1309.486631,4572.946524,856.2673797,149.0213904,3107.010695,3822.812834,1128.438503,165.3796791,3074.727273,743.0641711,347.2834225,187,19.41789617,12.68417464,0.757167433,0.921182266,0.55,-0.508490462
+1331,22252.5419,749.8659218,570.2458101,1101.413408,21385.30726,650.6927374,905.7653631,1766.385475,10547.53073,531.9106145,1406.044693,1907.290503,15428.54749,1170.189944,9323.837989,4887.586592,5704.782123,1239.692737,369.5027933,5190.72067,10731.4581,463.3743017,842.0055866,991.0391061,12899.85475,427.2122905,121.6703911,7340.458101,9824.178771,2163.206704,722.3687151,2832.98324,8344.424581,605.9664804,274.9162011,11692.3352,5081.905028,1025.804469,398.877095,1334.24581,4377.340782,772.0111732,160.2513966,3796.201117,3581.173184,1169.72067,363.0614525,3257.173184,185.1284916,348.3296089,179,18.02145265,12.84615479,0.70134122,0.962365591,0.628070175,-0.405292764
+1332,29322.51572,906.7798742,583.4716981,1097.327044,27173.16352,695.8238994,606.7610063,1595.566038,14890.58491,575.490566,486.7924528,1761.295597,21148.08805,1284.113208,8374.18239,4435.383648,7795.515723,1355.012579,384.5974843,2413.075472,14505.71069,420.1320755,178.4716981,434.2641509,17847.8805,432.3647799,129.4025157,6040,14260.37736,1458.899371,1153.880503,2826.748428,11991.89308,595.0628931,288.6100629,2828.289308,9164.792453,827.0188679,440.4842767,1312.415094,7349.679245,643.3584906,176.3144654,3826.534591,5996.031447,1327.45283,250.6603774,3320.63522,275.3773585,344.1698113,159,18.86695742,11.17229454,0.805818968,0.888268156,0.6625,1.568266325
+1333,28515.83133,1052.096386,528.5662651,1079.048193,24756.74699,776.9638554,938.8313253,1532.819277,13354.25301,625.4698795,1681.939759,1768.843373,18800.15663,1402.542169,6514.518072,3305.036145,6650.939759,1350.879518,392.686747,2442.819277,12844.48193,459.939759,560.9879518,1179.373494,14542.56627,1320.518072,134.7710843,2431.277108,11703,1648.975904,740.9879518,2824.855422,9936.13253,619.6144578,289.5662651,1635.698795,7992.759036,1543.156627,439.313253,1317.722892,6142.46988,732.8072289,172.9036145,2766.385542,5071.975904,1309.289157,189.6506024,3350.578313,497.1445783,342.9277108,83,12.07590411,9.012455913,0.665590352,0.965116279,0.691666667,-0.934869655
+1334,35868.52174,871.7391304,479.4057971,1101.898551,31491.49275,765.2753623,842.0289855,1598.028986,17360.65217,561.4347826,785.2173913,1782.869565,24759.36232,1373.724638,4304.710145,3278.318841,9095.869565,1404.26087,400.9130435,2510.347826,16793.30435,531.9130435,295.8115942,1053.797101,19889.02899,503.4057971,131.5942029,2952.434783,15900.24638,1683.347826,774.2898551,2850.550725,13454.56522,644.3188406,291.3043478,2346.637681,11032.81159,1011.681159,464.3478261,1316.637681,8608.782609,703.7246377,182.5942029,4882.521739,7102.594203,1398.173913,206.5942029,3248.043478,515.8405797,342.6086957,69,12.08277445,8.201582831,0.734338841,0.896103896,0.530769231,-1.062738573
+1335,10955.50463,785.6666667,444.6111111,1061.828704,9231.12037,619.7268519,496.6111111,1488.069444,4999.421296,472.8101852,397.7777778,1726.657407,7603.453704,1144.365741,2811.865741,1860.134259,2728.490741,1147.912037,370.6342593,2513.509259,5165.194444,636.162037,4141.967593,529.8796296,6042.134259,389.8981481,122.3101852,1774.555556,5045.550926,1472.884259,646.6296296,2807.398148,4189.990741,588.6203704,253.7777778,12624.89352,3409.861111,901.6342593,386.0462963,1468.685185,2350.907407,1853.490741,152.3287037,5502.393519,2210.560185,1180.726852,233.9537037,3181.583333,912.9444444,346.5277778,216,21.15360431,13.19442783,0.781628922,0.939130435,0.654545455,1.457009341
+1336,34615.47445,868.5912409,603.7810219,1142.518248,32112.62044,694.2481752,591.9489051,1715.343066,17090.57664,559.4160584,614.1605839,1805.737226,24267.37956,1263.080292,6882.729927,6287.583942,9009.240876,1388.751825,406.4890511,2536.175182,17313.48175,423.7956204,1295.912409,448.6642336,20681.86861,673.8175182,131.6350365,5032.087591,16255.62774,1594.708029,749.9051095,2818.058394,13640.65693,590.3138686,294.3868613,5119.328467,9102.474453,840.9416058,433.6350365,1317.036496,7746.372263,917.810219,173.1459854,3331.824818,5996.686131,1290.59854,186.9270073,3206.386861,208.1240876,345.5328467,137,15.23262282,11.67047241,0.642661913,0.925675676,0.761111111,-1.450127883
+1337,28855.46218,901.4201681,518.8571429,1088.428571,25573.53782,709.5294118,713.7983193,1553.218487,13629.82353,567.7310924,876.0084034,1767.848739,19622.18487,1342.310924,4651.773109,4251.033613,6989.369748,1345.932773,383.4201681,2479.647059,13448.82353,436.6638655,397.8655462,1008.655462,15721.41176,1049.07563,142.2016807,3874.033613,12337.67227,1616.983193,915.4621849,2813.033613,10438.68908,607.9579832,290.9495798,2559.159664,8330.92437,1175.092437,441.9831933,1326.521008,6602.092437,720.8907563,174.789916,8293.336134,5554.92437,1331.168067,244.9159664,3274.840336,475.6470588,346.3193277,119,14.34343366,11.77317691,0.571207015,0.856115108,0.566666667,0.240315173
+1338,19184.1828,714.5268817,493.2365591,1048.526882,16365.83871,588.3548387,669.4516129,1621.354839,9365.537634,468.5376344,393.0860215,1801.849462,13561.13978,1125.333333,6685.88172,3203.591398,4845.473118,1135.139785,336.8924731,2522.688172,8952.731183,2151.752688,115.0645161,441.2903226,10490.09677,387.6989247,108.6021505,5696.913978,8786.483871,1282.505376,863.1397849,2796.021505,7386.709677,743.8494624,255.9569892,15784.31183,6014.827957,769.827957,379.8387097,1293.333333,4520.903226,888.0107527,153.9784946,3822.193548,3840.602151,1157.451613,171.8602151,3215.268817,761.688172,345.3655914,93,11.91473144,10.16322347,0.521916735,0.978947368,0.65034965,-0.207917261
+1339,33456.40385,861.2884615,575.75,1115.519231,30051.84615,706.5576923,506.75,1663.288462,17008.03846,563.2307692,614.9038462,1788.096154,22640.36538,1273.269231,8019.269231,4352.807692,8259.730769,1355.673077,382.9038462,2455.192308,16019.69231,464.4807692,1248.730769,515.7115385,18689.23077,413.6538462,149.0961538,4429.076923,14683.23077,1492.269231,1091.5,2827.038462,12634.40385,607.3269231,286.5576923,1756.865385,10059.55769,885.9615385,440.7115385,1310.134615,7783.480769,896.4807692,179.7307692,4609.692308,6629.769231,1332.865385,172.9230769,3259.634615,345.0576923,344.8846154,52,9.420623956,7.435944082,0.61397423,0.945454545,0.641975309,-0.866315098
+1340,30150.65517,855.9586207,487.4965517,1061.8,21286.71034,657.4758621,486.6965517,1463.22069,11816.55862,529.337931,964.7793103,1738.289655,17030.37931,1202.255172,6824.02069,2995.958621,6055.993103,1281.875862,367.8206897,2549.724138,11854.24138,379.7931034,2670.089655,560.2275862,13897.6069,481.9034483,127.2896552,2038.668966,10710.73103,1628,851.0551724,2792.689655,9245.303448,769.9034483,261.8758621,1388.131034,7467.124138,1090.917241,425.7103448,1362.958621,6013.8,1248.675862,168.3793103,3400.862069,4967.77931,1329.862069,1029.717241,3161.655172,353.0965517,348.5034483,145,18.3796145,10.55424791,0.818689374,0.900621118,0.533088235,-0.823057171
+1341,18485.01767,701.8975265,479.7420495,1063.074205,15813.0318,577.7279152,553.360424,1590.957597,8867.996466,460.2826855,499.335689,1772.007067,12675.69965,1104.957597,6078.30742,3630.250883,4666.710247,1136.014134,329.8021201,3108.85159,8542.833922,1519.816254,314.4063604,466.7844523,9921.194346,379.4134276,116.4381625,7563.745583,8177.388693,1402.473498,847.9293286,2785.416961,6725.353357,548.6113074,248.6501767,18854.55124,5542.34629,844.9151943,375.590106,1336.897527,4033.80212,733.6537102,150.7561837,3536.289753,3432.64311,1117.229682,157.4805654,3190.939929,829.1024735,349.6254417,283,20.37567453,18.12877236,0.456494482,0.943333333,0.673809524,0.950351749
+1342,15678.28467,754.1167883,497.4671533,1061.875912,13817.51825,613.1021898,737.7591241,1550.963504,7369.364964,476,1322.19708,1771.49635,10979.67153,1158.051095,4062.452555,2302.642336,4021.656934,1155.839416,361.7883212,3469.80292,7386.131387,437.8248175,1702.693431,751.4744526,9097.372263,386.7883212,159.6350365,2783.576642,7125.080292,1575.445255,639.8905109,2812.364964,6001.50365,559.0510949,270.9927007,22590.08029,4880.109489,1623.583942,395.8540146,1433.832117,3454.145985,1193.686131,159.6715328,5823.364964,3135.211679,1175.313869,222.0656934,3174.693431,893.0072993,347.080292,137,14.60053893,12.18730818,0.550680178,0.958041958,0.698979592,-0.855065498
+1343,22399.57692,897.5096154,490.5096154,1064.019231,19092.58654,651.0769231,451.8461538,1463.615385,10870.18269,508.875,369.0288462,1739.096154,15686.85577,1198.826923,4138.375,3587.971154,5564.346154,1209.009615,337.4038462,2407.163462,10735.50962,435.1153846,103.7596154,424.6346154,12406.51923,374.4519231,113.8846154,3674.317308,10090.09615,1293.125,824.4038462,2771.394231,8624.375,566.3653846,241.7115385,2614.509615,7063.019231,760.75,377.5480769,1293.846154,5340.461538,613.25,152.2211538,4581.894231,4455.75,1219.269231,398.0769231,3257.644231,647.8365385,346.2403846,104,13.59325982,10.00125305,0.677252261,0.945454545,0.63030303,1.384857232
+1344,17419.97561,722.9756098,566.6910569,1080.349593,8051.121951,433.6178862,247.5121951,1320.430894,3573.471545,342.8130081,250.7723577,1663.926829,5860.878049,875.5609756,4114.081301,1883.95935,2148.300813,906.6585366,264.0081301,2396.365854,3904.398374,835.601626,97.67479675,370.1869919,4761.284553,284.7642276,97.02439024,6429.162602,3708.227642,1113.211382,633.3821138,2772.788618,2934.739837,464.5528455,183.0569106,4503.723577,2186.861789,577.1219512,309.2357724,1255.113821,1176.463415,501.804878,121.9268293,1504.593496,1154.829268,841.8699187,100.300813,2909.747967,1054.02439,347.2764228,123,13.25485994,11.80272255,0.455091051,0.968503937,0.788461538,1.11725804
+1345,40249.11189,892.4615385,580.5664336,1131.583916,36437.40909,731.4335664,646.0559441,1721.643357,20569.48951,590.6993007,657.5244755,1814.681818,28802.26573,1331.202797,6643.108392,5046.909091,10614.3042,1403.006993,407.5699301,2428.283217,20316.81818,424.7902098,129.534965,663.3916084,24438.72378,429.0559441,180.6713287,5173.863636,19947.68881,1599.545455,880.006993,2815.486014,17054.48601,620.3391608,314.0909091,3210.79021,12661.41259,880.5244755,472.3636364,1315.895105,10199.26923,659.0174825,181.451049,3428.094406,8241.72028,1394.884615,194.979021,3276.122378,257.9055944,352.0944056,286,21.95593008,17.47090028,0.605657026,0.882716049,0.544761905,1.559232265
+1346,42799.71875,1109.5,584.6875,1140.75,35638.17188,777.53125,573.765625,1684.171875,20828.17188,674.1875,489.6875,1797.78125,28028.32813,1414.71875,5691.609375,4451.34375,9967.453125,1470.265625,409.46875,2445.859375,19724.29688,448.265625,141.0625,430.6875,23323.29688,440.34375,138.140625,3978.3125,18552.98438,1538.078125,911.859375,2797.484375,15740.67188,608.21875,322.53125,2190.4375,11992.71875,864.09375,476.40625,1307.96875,9402.28125,673.78125,172.78125,2696.984375,7743.09375,1369.140625,125.703125,3573,292.59375,348.40625,64,11.06293889,7.604612615,0.72628345,1,0.592592593,0.521622263
+1347,14983.09184,1319.653061,664.6122449,1065.438776,13432.2551,784.9489796,543.7857143,1457.081633,6699.55102,658.244898,756,1733.459184,9021.714286,1301.316327,6240.081633,3123.163265,3264.204082,1390.642857,355.9795918,2458.377551,6868.020408,399.7755102,148.9591837,646.0306122,7279.091837,407.7040816,115.7959184,4342.153061,5557.214286,1503.755102,773.744898,2791.489796,4886.44898,563.6122449,256.8469388,2006.05102,3678.602041,874.1938776,395.4795918,1303.836735,3255.020408,580.5102041,154.122449,3169.428571,2329.010204,1084.091837,173.5816327,3582.357143,303.9183673,348.3673469,98,15.90609758,8.893687879,0.829075269,0.837606838,0.556818182,1.553952
+1348,29548.03226,1075.991935,629.7822581,1104.645161,22657.96774,784.233871,585.766129,1588.870968,14443.91129,670.233871,799.5,1832.346774,20492.95968,1539.056452,5020.596774,4025.879032,7207.032258,1512.419355,449.6854839,2516.217742,11429.49194,427.6129032,1543.137097,531.8064516,13378.3871,501.3709677,136.2983871,4541.08871,10671.77419,1726.225806,978.2983871,2809.935484,9205.862903,764.5241935,309.8387097,1796.991935,7608.564516,994.4516129,471.0887097,1363.612903,6051.427419,1031.08871,193.6612903,4514.653226,5176.153226,1458.604839,159.8225806,3259.314516,409.483871,349.1451613,124,15.90925796,10.13963828,0.770581064,0.939393939,0.596153846,-0.919018491
+1349,24114.1962,862.2848101,469.8734177,1069.329114,21477.22785,679.1898734,513.8544304,1472.670886,11794.51266,545.7974684,604.8101266,1761.208861,16644.01899,1278.689873,4090.272152,2505.78481,6138.481013,1344.436709,366.1518987,2546.886076,11646.17722,441.0886076,229.9177215,628.3607595,13560.6519,418.9620253,129.4556962,2866.78481,10735.70886,1508.746835,746.4556962,2847.651899,9183.772152,844.1708861,264.835443,1641.120253,7447.132911,913.5316456,431.5189873,1296.101266,5838.063291,657.1075949,167.5063291,2334.677215,4870.620253,1315.113924,472.1455696,3310.803797,502.7405063,353.7531646,158,20.50411303,11.32310284,0.833688042,0.778325123,0.501587302,0.175796395
+1350,35322.63265,793.5102041,477.9183673,1082.306122,29035.32653,666.2040816,906.8979592,1555.469388,17106.65306,519.0816327,794.755102,1784.122449,23491.81633,1260.591837,4828.326531,3753.591837,8728.510204,1281.204082,352.3469388,2528.204082,16895.40816,827.122449,231.4489796,930.4693878,19584.22449,412.0816327,121.5306122,3170.755102,15667.20408,1715.795918,761.7959184,2806.081633,13466.32653,656.877551,269.122449,3071.387755,10787.46939,930.3877551,423.1632653,1315.061224,8172.244898,661.244898,159.8367347,3672.020408,6716.469388,1296.081633,467.9795918,3180.918367,592.7755102,347.4489796,49,9.11010295,7.96900138,0.484586613,0.803278689,0.544444444,1.204947918
+1351,20809.60127,756.8164557,527.0696203,1095.670886,17525.05696,621.8987342,584.278481,1762.658228,8962.670886,457.0949367,474.6518987,1801.563291,13816.87342,1161.246835,5683.955696,2794.21519,4997.759494,1156.113924,342.1455696,2527.259494,9396.493671,5796.974684,478.3860759,485.5316456,11125.41139,425.0506329,118.9936709,4977.93038,9207.28481,1393.993671,817.7151899,2801.987342,7633.71519,649.6962025,279.2088608,29548.72785,5990.189873,790.9810127,381.1265823,1361.803797,4044.936709,937.7721519,160.0253165,6290.898734,3702.601266,1159.753165,200.4113924,3248.303797,946.2025316,350.2848101,158,17.997984,11.41581927,0.773100767,0.946107784,0.619607843,-0.901868812
+1352,11960.25362,769.3188406,648.6304348,1098.057971,9543.398551,520.442029,491.2463768,1538.369565,4644.413043,397.2826087,338.5217391,1711.905797,7745.905797,1028.963768,6633.07971,1823.152174,2813.615942,1099.956522,309.3695652,2413.905797,5070.130435,3170.898551,480.0144928,425.0434783,6131.144928,407.4710145,107.9275362,8254.557971,5155.84058,1295.92029,766.3913043,2780.188406,4151.971014,517.5289855,231.1231884,11533.65942,3264.985507,657.673913,351.4347826,1298.65942,1992.550725,658.0144928,140.7608696,5429.231884,1957.746377,1011.362319,162.7391304,3110.775362,1001.528986,349.3695652,138,14.84682814,11.92897869,0.595345454,0.958333333,0.707692308,1.432478121
+1353,33629.97436,816.5726496,559.5726496,1111.564103,31448.20513,660.7863248,560.965812,1605.111111,16875.63248,551.3333333,475.9230769,1783.333333,24273.41026,1242.529915,6419.290598,3965.307692,9151.74359,1322.760684,385.1111111,2400.213675,17174.57265,396.7692308,115.6410256,436.0769231,21112.91453,402.042735,128.982906,5396.974359,16628.04274,1428.529915,737.6752137,2819.25641,14351.65812,605.6410256,294.3162393,5290.666667,10110.09402,790.017094,432.974359,1319.128205,8501.042735,639.4188034,170.0683761,3652.735043,6774.222222,1295.991453,185.7179487,3225.564103,233.7777778,349.3760684,117,13.37477234,11.40749222,0.522056128,0.921259843,0.65,1.277134134
+1354,30963.27419,852.6935484,563.1935484,1143.790323,28806.66129,729.0806452,610.7419355,1708.983871,15603.09677,561.7258065,1016.177419,1904.403226,21934.91935,1254.193548,6407.241935,4761.451613,8298.209677,1330.645161,388.4032258,2563.983871,15571.54839,423.1451613,117.9677419,1170.16129,18951.01613,424.0322581,187.3548387,4035.177419,14905.83871,1687.064516,802.2580645,2797.967742,13165.37097,596.8548387,287.6451613,4478.645161,9353.758065,849.7258065,443.1612903,1312.967742,7834.564516,625.1290323,179.5645161,4990.903226,6140.919355,1325.887097,257.516129,3254.806452,244.516129,347.7741935,62,10.485646,9.204081684,0.479065468,0.815789474,0.563636364,-0.532617944
+1355,34306.95215,1014.291866,568.0861244,1120.239234,27063.04306,710.8516746,476.1339713,1642.08134,15768.57895,588.9856459,805.6028708,1766.578947,22474.88038,1368.77512,6819.392344,2925.799043,8489.277512,1452.38756,411.4688995,2569.684211,16436.50718,485.3732057,1079.784689,808.3732057,18047.82297,452.2296651,138.5741627,3385.76555,14417.11005,1837.77512,909.645933,2817.492823,12296.04306,663.3349282,300.4354067,1751.717703,9939.971292,995.2631579,470.0909091,1334.172249,7646.799043,990.430622,190.6889952,3228.799043,6327.54067,1425.741627,463.5311005,3299.004785,391.1626794,352.7559809,209,21.1870004,14.07950506,0.747257067,0.856557377,0.580555556,1.242123814
+1356,50767.61832,951.2824427,511.3664122,1135.068702,44491.34351,812.0458015,828.5419847,1643.29771,25332.72519,636.6717557,1421.633588,1757.870229,35180.0916,1518.793893,4160.480916,3788.969466,12721.9542,1508.801527,430.480916,2562.549618,23308.16794,535.6259542,300.9847328,1212.267176,28154.65649,517.1603053,261.7328244,2512.038168,22312.78626,2035.427481,780.5267176,2854.839695,18924.91603,684.6030534,336.7862595,1753.450382,15439.80153,1527.740458,500.1526718,1336.664122,11893.29008,737.610687,196.9618321,3249.381679,10107.03053,1524.679389,185.6564885,3307.51145,513.2748092,351.3587786,131,18.30198716,9.895557742,0.841226969,0.885135135,0.584821429,1.064504367
+1357,29341.54615,750.9846154,467.6307692,1067.692308,24304.76923,641.7846154,567.8769231,1603.469231,14002.9,483.9538462,816.5230769,1870.984615,20291.50769,1167.376923,4907.561538,3491,7145.246154,1180.584615,347.6230769,3126.130769,13361.37692,7567.661538,132.7923077,967.1923077,15283.58462,417.2615385,127.4923077,4761.023077,13099.21538,1621.692308,930.9076923,2791.953846,10816.14615,688.8769231,260.8923077,6892.223077,8805.753846,958.0153846,388.5923077,1307.261538,6408.730769,664.8538462,150.3692308,3212.384615,5488.984615,1184.861538,159.4230769,3218.930769,802.9,350.3692308,130,16.65084991,10.66014375,0.768194783,0.866666667,0.677083333,-1.43898552
+1358,35054.49333,916.1866667,577.3533333,1092.24,32653.09333,734.4066667,687.28,1617.313333,18013.60667,605.42,963.54,1824.693333,25440.94667,1329.16,7027.346667,5410.146667,9087.473333,1399.466667,391.1133333,2441.993333,18211.7,442.8,218.98,832.1533333,21000.5,450.6133333,144.0866667,4923.34,17112.13333,1851.2,1043.866667,2816.126667,14454.42,650.0066667,296.74,2274.866667,11212.14,1104.266667,462.0066667,1303.446667,8828.346667,691.3,183.9333333,5453.866667,7309.38,1386.866667,238.86,3367.633333,320.2266667,351.3733333,150,16.47849698,11.73798883,0.701853248,0.931677019,0.678733032,-1.233417553
+1359,31280.97049,866.9180328,480.3377049,1086.92459,27468.6918,708.2360656,644.4786885,1517.422951,14842.9082,589.252459,697.4360656,1762.754098,21504.51148,1337.380328,4393.429508,3135.452459,7652.140984,1354.672131,385.704918,2460.84918,14396.69508,443.1606557,672.3081967,781.2819672,16609.68197,454.3016393,133.3245902,1894.87541,13537.57705,1745.390164,840.1409836,2813.377049,11636.47541,656.8163934,285.3639344,1752.144262,9394.603279,1111.019672,447.1868852,1327.534426,7178.052459,782.7639344,176.0819672,2986.872131,6339.15082,1411.32459,428.8295082,3212.731148,459.0131148,353.8885246,305,26.14011442,16.38014747,0.779317906,0.876436782,0.602766798,-0.718948156
+1360,30996.76471,947.4852941,636.3970588,1104.411765,26673.13235,751.2352941,761.9705882,1593.397059,14942.16176,581.4558824,963.4558824,1779.323529,21729.30882,1405.544118,5574.279412,4440.823529,7738.705882,1397.588235,405.7647059,2470.882353,14233.04412,466.1764706,1169.426471,590.8823529,16517.13235,479.6323529,137.9558824,2608.838235,13254.72059,1756.132353,1007.852941,2819.058824,11218.67647,760.5882353,299.7647059,1896.220588,8980.617647,1662.044118,465.4705882,1363.191176,7077.970588,908.6323529,175.5294118,3864.558824,6027.75,1430.529412,348.7647059,3311.514706,488.1911765,349.2205882,68,9.801677262,9.021492696,0.390971104,0.944444444,0.618181818,-0.711617277
+1361,27173.52174,783.2173913,531.9021739,1064.271739,23022.04348,646.6956522,580.423913,1514.282609,13224.51087,510.3586957,557.6195652,1775.869565,18192.28261,1237.119565,7740.086957,5068.293478,6747.173913,1235.619565,360.1195652,2490.054348,13146.03261,435.1630435,1181.402174,563.9565217,15469.81522,477.7717391,117.9782609,5409.076087,12301.42391,1535.73913,889.5652174,2793.858696,10634.34783,661.9456522,256.1630435,3260.913043,8609.782609,879.2934783,397.1086957,1335.858696,6657.391304,951.3586957,153.0869565,4381.076087,5588.48913,1274.130435,378.3369565,3194.315217,603.1630435,350.9347826,92,15.78031858,8.217763692,0.85370293,0.836363636,0.505494505,-0.734014377
+1362,28784.3641,745.6358974,463.4358974,1055.276923,25451.34359,708.9589744,733.9025641,1480.487179,14263.75897,506.6923077,895.774359,1871.605128,19948.6,1215.820513,5354.215385,3087.815385,7336.671795,1260.297436,345.3948718,2464.897436,14062.91282,429.025641,288.9487179,951.7230769,16704.09744,392.0410256,115.7025641,2673.015385,13470.45641,1656.148718,732.3333333,2788.861538,11440.64103,810.2358974,252.9384615,2685.169231,9196.671795,916.3384615,384.6410256,1304.661538,7109.564103,663.0051282,153.3076923,3226.758974,5866.635897,1254.912821,832.0564103,3168.035897,619.6769231,355.8564103,195,22.64895085,12.36286627,0.837884742,0.78313253,0.619047619,-0.082634652
+1363,20897.80861,681.2105263,426.8947368,1044.818182,17825.38278,573.8660287,442.6028708,1521.066986,10320.7177,454.1148325,371.4784689,1745.923445,14548.22967,1102.287081,3492.76555,1969.253589,5241.440191,1134.62201,328.4258373,2464.177033,9723.172249,4971.334928,121.7942584,417.0143541,11270.38756,388.2583732,108.5311005,4300.818182,9425.502392,1252.282297,722.3157895,2812.315789,8038.483254,811.9138756,238.2009569,7789.555024,6509.444976,699.5933014,364.4976077,1291.210526,4880.669856,752.1722488,145.2870813,2638.535885,4087.08134,1115.320574,131.2392344,3160.602871,751.062201,355.9521531,209,22.12558923,12.68257888,0.819409456,0.908695652,0.552910053,-0.455564167
+1364,25661.63673,855.277551,512.1102041,1077.640816,22007.63265,692.4367347,561.322449,1519.710204,12124.67347,559.8408163,717.4653061,1813.971429,17150.37143,1309.020408,5515.902041,3109.689796,6245.620408,1314.653061,385.3877551,2546.816327,11192.52245,426.9346939,739.3061224,807.4326531,12994.6,410.5020408,123.6040816,3231.065306,10172.97959,1653.489796,823.4244898,2808.346939,8929.028571,716.9020408,276.8489796,2173.261224,7079.310204,944.8938776,431.8897959,1337.391837,5478.706122,780.1469388,168.8122449,3834.17551,4526.171429,1309.840816,969.8367347,3197.346939,556.4653061,353.7183673,245,20.66408149,15.59491211,0.65608509,0.921052632,0.644736842,1.03824735
+1365,35333.8046,840.3793103,469.5977011,1092.321839,30751.22989,689.9655172,609.1264368,1529.425287,17558.64368,530.3218391,400.6436782,1729.689655,25183.31034,1272.425287,4197.264368,3366.712644,8849.333333,1257.091954,364.183908,2412.712644,17424.65517,442.0574713,109.2068966,462.6666667,20200.86207,394.9310345,124.5172414,3072.54023,16416.88506,1384.977011,943,2790.793103,13860.64368,650.4712644,269.4597701,2350,11272.10345,817.1149425,411.8045977,1282.609195,8520.425287,608.8390805,161.8390805,3700.793103,7097.172414,1306.770115,1142.597701,3319.816092,635.6206897,350.6551724,87,11.83878298,9.685020321,0.575110596,0.945652174,0.719008264,-0.502400777
+1366,20763.86145,710.126506,419.2650602,1059.60241,18330.3494,579.9698795,597.6686747,1581.939759,10069.51205,466.4939759,828.5542169,1835.204819,14019.76506,1107.993976,5258.771084,3053.795181,5191.289157,1131.957831,324.3313253,4413.692771,9592.795181,851.126506,150.6626506,628.4156627,11110.12651,356.9759036,110.4518072,4388.024096,9121.096386,1424.271084,657.373494,2779.024096,7636.168675,544.0963855,246.2891566,11982.33133,6351.042169,943.4036145,368.3253012,1299.722892,4735.53012,654.0060241,149.7108434,2953.403614,3932.096386,1122.006024,185.1385542,3132.626506,770.8975904,352.2951807,166,17.83134975,12.38339719,0.719518427,0.927374302,0.58245614,-1.220122107
+1367,17842.45714,734.4,567.7028571,1095.668571,14581.65143,580.0857143,452.76,1693.445714,7431.622857,435.8171429,443.1485714,1826.994286,11904.26857,1100.451429,5926.577143,2715.205714,4312.211429,1118.685714,355.0628571,2666.554286,7840.274286,498.08,1200.508571,451.4342857,9192.308571,376.2171429,112.1371429,5522.502857,7881.891429,1341.274286,829.52,2839.982857,6301.074286,522.0342857,256.84,17859.30857,4925.828571,775.3028571,370.4457143,1326.211429,3166.942857,836.0685714,157.5542857,5526.211429,2900.051429,1084.868571,204.5771429,3273.708571,979.9028571,351.9314286,175,19.76467347,11.44177956,0.815398184,0.961538462,0.657894737,-1.144698112
+1368,20231.39881,1049.488095,640.9642857,1121.113095,18986.96429,747.1964286,562.5833333,1620.672619,9905.386905,607.6488095,992.5119048,1837.095238,13424.52381,1304.458333,7411.470238,5599.934524,5063.190476,1315.821429,373.5059524,2645.952381,9443.267857,404.4285714,174.9880952,936.4166667,10436.54762,447.547619,147.5357143,5890.220238,8532.077381,1730.60119,907.6547619,2813.571429,7299.011905,570.9047619,273.3809524,2733.541667,5464.053571,987.25,430.5833333,1303.809524,4461.880952,617.9285714,170.4702381,3821.255952,3442.232143,1246.380952,239.2916667,3358.440476,273.6130952,355.9107143,168,25.7068922,9.000776072,0.936700799,0.827586207,0.405797101,-1.029739143
+1369,16635.86047,1059.364341,536.9767442,1043.379845,14361.08527,640.4186047,477,1435.209302,7568.124031,536.1550388,425.9302326,1779.953488,11261.05426,1235.046512,4714.813953,2079.426357,4094.457364,1351.837209,356.0620155,2421.356589,7053.286822,400.2325581,1250.232558,447.2945736,8262.550388,370.5116279,118.7131783,1278.55814,6630.689922,1457.503876,711.124031,2800.635659,5706.139535,814.4031008,247.1627907,1356.767442,4703.899225,904.8604651,407.1007752,1345.604651,3727.744186,2296.674419,164.0775194,2633.883721,3302.410853,1926.992248,246.5503876,3182.852713,424.8992248,354.5581395,129,15.67326896,10.68761386,0.731444712,0.928057554,0.661538462,-0.433237809
+1370,31618.64286,788.0357143,517.5238095,1073.654762,26277.7381,725.9166667,547.6309524,1522.071429,15224.11905,510.3571429,651.4285714,1806.321429,20434.77381,1241.595238,6370.809524,3908.702381,7726.428571,1250.821429,359.3214286,2443.833333,14799.2381,429.6190476,914.7738095,647.0238095,17326.64286,389.3690476,115.5952381,3818.940476,13804.29762,1715.107143,1014.02381,2803.571429,11797.80952,711.3452381,255.9166667,3130.452381,9454.428571,891.7380952,393.7261905,1356.535714,7309.75,891.0595238,162.4404762,3693.964286,5911.261905,1263.869048,320.5595238,3156.821429,610.3452381,353.5119048,84,14.30397391,7.657015761,0.844657644,0.943820225,0.587412587,-0.510832589
+1371,32437.5503,798.2248521,473.5976331,1071.60355,28503.76331,672.9408284,1146.278107,1566.710059,16233.54438,531.9940828,2400.254438,1809.059172,23104.28402,1281.497041,6392.08284,3750.852071,8180.674556,1238.852071,359.9526627,5326.266272,15876.19527,596.2426036,724.0177515,1600.64497,18208.65089,390.0828402,140.5976331,2461.112426,14917.18935,2194.005917,646.2662722,2821.420118,12530.33136,630.0295858,267.852071,2377.60355,10204.64497,2320.366864,406.9289941,1338.923077,7654.733728,823.8047337,163.147929,4848.023669,6487.964497,1276.60355,1048.319527,3210.656805,681.964497,354.112426,169,18.51857677,13.53276658,0.682626875,0.824390244,0.586805556,-1.195752778
+1372,38246.31452,848.4516129,521.5645161,1134.790323,36348.03226,693.6935484,907.7419355,1678.153226,19077.25,568.1290323,1671.5,1804.943548,27304.6129,1255.024194,6349.701613,5703.233871,10178.65323,1354.072581,404.5645161,3157.395161,19335.14516,418.6048387,868.9677419,617.9112903,23285.59677,1294.451613,135.6854839,3116.524194,18463.04839,1782.919355,754.5080645,2833.306452,15702.46774,595.3306452,309,3409.008065,10739.96774,1001.403226,449.016129,1322.451613,8983.741935,828.3870968,173.6209677,2592.564516,6997.403226,1300.467742,282.7258065,3191.532258,219.0080645,353.1612903,124,19.52186586,9.313299322,0.878865223,0.843537415,0.521008403,-0.968343351
+1373,33337.48322,1030.966443,517.4630872,1083.845638,31849.08725,774.2751678,625.9463087,1632.872483,15842.89933,601.6174497,619.9328859,1744.416107,22654.15436,1390.852349,3443.255034,2385.966443,7922.006711,1420.295302,392.8993289,2450.711409,14621.44966,428.7114094,786.6375839,549.0402685,16887.78523,461.1610738,144.3624161,1991.469799,13433.2953,1703,775.6577181,2830.436242,11623.24832,850.033557,288.1610738,1503.348993,9416.449664,931.6912752,454.9865772,1382.395973,7259.187919,878.5302013,173.4630872,4079.812081,6169.201342,1376.04698,155.8657718,3309.852349,412.7315436,357.557047,149,21.96826753,10.8869473,0.868564549,0.764102564,0.515570934,-0.875622889
+1374,28901.34375,763.75,493.84375,1049.140625,26078.125,637.625,532.5,1479.875,14696.57813,503.234375,410.515625,1721.828125,21613.96875,1198.28125,8017.765625,3220.859375,7766.734375,1223.59375,358.109375,2435.4375,14816.21875,439.9375,111.671875,448.578125,17624.8125,391.015625,117.9375,6098.0625,14308.32813,1351.296875,1185.84375,2776.59375,11931.23438,603.703125,254.53125,2442.21875,9792.015625,786.34375,385.65625,1300.265625,7566.9375,626.40625,154.765625,3772.140625,6318.109375,1266.859375,614.3125,3172.875,627.75,353.8125,64,12.09200121,7.051312415,0.812372696,0.927536232,0.592592593,0.306397683
+1375,30476.25294,748.5529412,469.8647059,1040.417647,26348.44706,644.8176471,900.5882353,1524.994118,15516.02353,503.1235294,2055.141176,1781.188235,21428.31765,1229.435294,8106.864706,3074.094118,7631.205882,1207.188235,349.6,4500.676471,14909.98824,1052.629412,494.0823529,1008.605882,16821.17059,376.1176471,118.4882353,4029.005882,14388.07059,1953.917647,744.7058824,2811.929412,11940.79412,629.2529412,255.2470588,3050.552941,9865.376471,1308.141176,389.8411765,1309.494118,7218.535294,736.9470588,154.6352941,3625.817647,6125.394118,1203.117647,592.7529412,3173.947059,697.3470588,353.7823529,170,18.38020987,12.0078577,0.757096015,0.939226519,0.745614035,-1.460467964
+1376,14615.35789,670.5263158,499.6315789,1052.778947,13137.47368,553.5894737,424.8526316,1545.389474,6928.221053,438.0526316,506.5263158,1781.126316,10470.46316,1068.052632,6175.473684,4016.989474,3882.463158,1090.073684,335.2736842,3456.884211,7019.094737,4961.084211,818.7157895,483.8736842,7989.915789,363.2315789,107.6736842,7067.263158,6670.968421,1380.515789,987.7684211,2793.294737,5567.178947,613.0736842,237.2947368,13574.58947,4713.631579,805.8947368,363.9684211,1313.673684,3514.778947,790.3473684,148.0526316,4403.631579,2930.947368,1094.031579,160.5789474,3131.936842,787.3789474,353.3368421,95,14.07645704,9.112935918,0.762160203,0.871559633,0.616883117,1.332311393
+1377,15380.8,747.6235294,424.2117647,1036.247059,13669.54118,616.3176471,436.4117647,1509.2,7492.435294,467.1294118,404.9647059,1719.294118,11415.74118,1172.176471,2718.623529,1154.094118,4119.941176,1155.458824,351.9882353,2480.929412,7628.176471,727.9294118,1741.317647,497.0470588,9105.247059,378.4470588,117.7764706,1381.011765,7436.623529,1347.682353,562.8117647,2822.988235,6228.588235,566.8,250.1764706,15120.75294,5112.164706,809.1647059,385.7529412,1366.364706,3540.764706,1133.411765,159.2941176,3976.529412,3200.741176,1201.729412,178.4470588,3148.847059,901.5764706,353.5411765,85,13.35102582,8.964308639,0.741065989,0.923913043,0.566666667,1.372414081
+1378,42233.7037,951.8888889,557.1111111,1143.574074,38014.66667,747.8703704,709.2777778,1706.592593,21881.2963,635.2962963,674.6666667,1791.37037,29449.31481,1379.018519,7908.537037,4581.574074,11044.5,1467.074074,423.1111111,2460.277778,21604.48148,447.3518519,143.2222222,535.9259259,25497.05556,439.6481481,180.9444444,4523.981481,20746.68519,1615.722222,813.1111111,2816.833333,17527.12963,620.962963,315.4814815,1928.537037,13646.44444,897.0185185,492.2407407,1302.814815,10390.62963,705.8703704,191.0185185,5966.555556,8888.814815,1475.074074,299.0925926,3392.722222,287.4074074,353.9444444,54,9.522310705,7.771634395,0.577840021,0.931034483,0.545454545,-0.177699019
+1379,19236.93056,829.5069444,429.7083333,1054.659722,17158.19444,643.0833333,447.8194444,1625.652778,9808.618056,522.125,428.4583333,1809.465278,13885.61806,1239.826389,2898.465278,1402.208333,4958.055556,1269.270833,361.2569444,2399.694444,10133.61111,388.4652778,376.3263889,436.9236111,11455.07639,398.7152778,119.6180556,863.8194444,9040.104167,1406.520833,737.5416667,2806.631944,7706.138889,690.4861111,261.6527778,1370.152778,6270.409722,982.0208333,421.7152778,1304.743056,5013.854167,2163.861111,175.375,2309,4302.166667,4257.875,1630.041667,3181.194444,369.5763889,355.4930556,144,15.44531246,13.10696882,0.529027046,0.872727273,0.64,-0.573741975
+1380,33879.78333,797.3166667,414.55,1060.6,29394.65,664.5,686.5833333,1457.716667,17460.63333,514.2833333,369.7666667,1716.9,24123.35,1224.466667,3410.666667,1891.083333,8514.883333,1250.65,345.8,2416.583333,17201.9,440.2166667,105.2,450.0833333,19707.23333,381.4,111.9,2676.916667,16501.38333,1320.383333,676.9666667,2792.833333,13978.4,606.0333333,259.8833333,1976.883333,11424.65,772.8666667,393.0166667,1298.983333,8453.7,624.6833333,161.7,2905.05,7465.283333,1261.7,441.0166667,3241.85,644.0333333,354.1333333,60,10.7028448,7.92129351,0.672484692,0.857142857,0.5,1.478997214
+1381,28429.55828,1004.184049,567.1840491,1082.693252,22873.22086,605.2453988,659.190184,1420.441718,12450.10429,500.7423313,1099.02454,1799.484663,17112.04908,1147.171779,8265.343558,2835.969325,6194.398773,1248.95092,352.1840491,2459.460123,12368.20859,558.7484663,496.1779141,972.5398773,14156.00613,442.3312883,120.0429448,3767.889571,11343.56442,1634.496933,877.4110429,2801.374233,9687.466258,592.9631902,254.8773006,1450.852761,7678.478528,1011.822086,414.6319018,1307.325153,6112.730061,688.9815951,162.3558282,3763.723926,5114.343558,1220.766871,192.6380368,3199.552147,340.1779141,357.1717791,163,18.5707365,11.3813736,0.79018683,0.947674419,0.659919028,1.37678121
+1382,20133.54264,795.627907,560.9457364,1066.054264,18101.34884,628.620155,752.6666667,1485.395349,9814.271318,510.4108527,1336.550388,1779.666667,14408.97674,1224.403101,7026.914729,5004.403101,5213.899225,1260.069767,358.1085271,4244.20155,9772.899225,395.5426357,1140.48062,943.7906977,11507.84496,402.4418605,123.0542636,4066,8933.131783,1905.550388,1017.75969,2808.844961,7696.023256,606.9612403,258.4263566,2349.612403,6371.209302,1494.891473,421.9457364,1403.03876,4936.24031,882.5503876,162.2403101,5410.302326,4218.387597,1261.922481,256.9457364,3249.372093,484.751938,358.7286822,129,16.93967112,9.898785158,0.811497987,0.928057554,0.573333333,0.802650249
+1383,29909.05714,894.3428571,658.7857143,1088.014286,25498.92857,699.9285714,834.5,1579.3,14757.42857,553.9714286,485.7428571,1781.642857,20997.02857,1333.428571,2538.4,1660.714286,7589.171429,1374.385714,381.8285714,2499.014286,14495.8,492.8571429,407.5571429,456.1428571,17119.28571,423.6,135.7142857,1749,13461.48571,1536.771429,752.6714286,2877.214286,11512.41429,817.3857143,278.1857143,1561.971429,9264.514286,870.9714286,454.1428571,1338.485714,7151.3,719.9857143,180.1285714,2206.1,6312.657143,1394.185714,267.7,3241.042857,494.3285714,357.1142857,70,12.48764135,7.410970718,0.804860232,0.909090909,0.598290598,0.198326734
+1384,22131.52518,736.1726619,474.1510791,1046.273381,18812.58993,630.618705,452.5971223,1452.669065,10520.07914,481.7122302,515.3669065,1757.676259,14578.32374,1168.546763,4816.302158,3368.064748,5468.071942,1202.719424,361.2517986,2486.848921,10336.23022,413.0935252,2159.510791,578.3165468,11940.17266,402.8417266,115.9064748,2874.877698,9539.179856,1619.208633,753.7697842,2790.18705,8254.553957,668.4028777,253.2158273,2661.942446,6679.661871,801.1870504,395.0359712,1358.316547,5195.143885,1187.388489,151.5467626,5247.956835,4244.978417,1221.122302,399.2446043,3103.345324,592.028777,358.1438849,139,14.56843168,12.42498819,0.522122215,0.932885906,0.763736264,-0.131987463
+1385,35580.12121,896.9515152,488.1878788,1073.381818,30175,727.6181818,557.1151515,1546.939394,17647.16364,541.4,667,1757.163636,23591.69697,1293.969697,5331.175758,2738.975758,8362.248485,1267.551515,367.2969697,2504.466667,16884.81212,483.2969697,130.9090909,891.2848485,19524.35152,389.1090909,185.5030303,2954.975758,15761.66667,1615.315152,604.0666667,2786.836364,13407.42424,605.3636364,264.8484848,1784.551515,10848.92727,864.9515152,403.3515152,1289.248485,8036.945455,624.3212121,157,3083.181818,6935.593939,1294.818182,463.5272727,3290.163636,657.3575758,358.3090909,165,18.98727754,11.3449958,0.801865086,0.9375,0.606617647,-0.788465858
+1386,16207.72892,655.7951807,422.0301205,1024.427711,14617.3012,551.1204819,424.1626506,1500.89759,8135.843373,444.2831325,531.8493976,1802.403614,10941.68072,1056.656627,3853.060241,2148.253012,4114.415663,1088.46988,331.2289157,3570.337349,7812.409639,5718.945783,630.2650602,468.3855422,8773.512048,368.9879518,107.6144578,4601.987952,7266.048193,1380.975904,714.3373494,2788.180723,6292.421687,830.9457831,227.1746988,5112.174699,5111.903614,796.4939759,354.5421687,1322.554217,3775.313253,791.0240964,145.6024096,2806.319277,3188.993976,1068.445783,286.9457831,3119.271084,726.5060241,357.1144578,166,16.74817065,12.69520019,0.652248526,0.959537572,0.697478992,1.26996502
+1387,13620.60887,691.1532258,464.4032258,1061.927419,11869.77823,571.2137097,583.0040323,1542.149194,6475.572581,452.2983871,563.1572581,1752.866935,9163.16129,1092.375,4981.879032,2341.133065,3415.229839,1114.217742,348.3991935,3385.693548,6359.322581,460.8548387,981.8991935,544.6854839,7374.100806,356.8145161,112.2379032,4741.157258,6058.709677,1489.693548,699.5080645,2845.846774,5020.907258,529.1129032,257.2620968,22069.94355,4113.842742,982.2459677,373.9435484,1395.358871,2945.745968,855.3225806,150.6814516,4304.770161,2563.471774,1098.048387,182.3104839,3157.399194,845.4879032,358.7217742,248,23.24186487,14.17155203,0.792599598,0.911764706,0.574074074,-1.090503594
+1388,46050.79032,990.0806452,654.8064516,1169.080645,41117.80645,793.3870968,870.6290323,1801.241935,22758.51613,619.3225806,882.7419355,1784.612903,32227.45161,1541.854839,5447.387097,6165.33871,12053.32258,1513.919355,462.5322581,3144.435484,22865.58065,1115.806452,1434.080645,615.6451613,27951.54839,670.5806452,151.7741935,4548.774194,22236.6129,2036.693548,661.3064516,2863.629032,18684.93548,731.6935484,354.4516129,2568.887097,12707.6129,1023.177419,515.6129032,1329.306452,10469.45161,990.5,198.5806452,2838.064516,8485.145161,1455.887097,185.5322581,3265.903226,207.483871,354.9354839,62,11.48755078,6.999833967,0.792908398,0.939393939,0.805194805,-1.435188627
+1389,35275.39189,974.7162162,682.7027027,1140.054054,33764.04054,747.7162162,689.3243243,1782.689189,18354.71622,622.5675676,619.1216216,1823.527027,25346.77027,1382.27027,7126.22973,4915.27027,9377.932432,1426.797297,406.3513514,2454.243243,18745.55405,472.8918919,266.3648649,543.8108108,22061.78378,440.1891892,138.7972973,5689.662162,17238.81081,1617.932432,910.972973,2813.540541,14803.22973,704.972973,316.0135135,3004.878378,11614.72973,1059.864865,472.8513514,1316.040541,9490.459459,1684.797297,181.3243243,3773.135135,7666.689189,1621.040541,188.8783784,3324.972973,306.1081081,356.7972973,74,14.12384729,7.089930907,0.864877501,0.902439024,0.560606061,-0.679686015
+1390,16521.52941,822.2794118,424.9705882,1055.198529,14373.41912,700.6176471,411.9338235,1502.595588,8043.338235,530.1691176,469.25,1770.213235,11386.44853,1229.794118,3614.485294,1280.257353,4084.191176,1293,465.6323529,2402,8094.904412,380.9926471,1345.191176,446.8970588,9369.654412,403.3823529,125.0735294,1034.029412,7303.323529,1680.727941,791.4044118,2822.625,6274.382353,886.0882353,260.5808824,1354.875,5112.536765,782.5294118,417.9411765,1336.448529,4150.477941,963.4264706,165.25,2205.897059,3549.242647,1339.654412,1903.544118,3195.764706,357.9264706,359.625,136,14.77188874,12.44453947,0.538778577,0.918918919,0.604444444,0.680043217
+1391,15401.11382,810.5284553,423.2276423,1011.617886,14400.42276,630.6178862,381.0325203,1364.211382,8109.504065,512.504065,408.5609756,1747.642276,11762.43089,1256.430894,3369.03252,1429.699187,4249.186992,1297.804878,369.5934959,2409.585366,8430.487805,372.1544715,1580.691057,418.1300813,9477.739837,363.3821138,122.796748,1253.593496,7595.894309,1455.96748,764.0731707,2813.569106,6518.414634,643.9837398,247.1382114,1362.861789,5312.544715,761.796748,419.7398374,1387.99187,4268.390244,886.3495935,178,3343.593496,3686.089431,1318.422764,585.9430894,3131.292683,379.4715447,359.8373984,123,14.4797999,11.04375171,0.646751755,0.938931298,0.683333333,-0.039449557
+1392,20473.47841,772.0299003,561.0265781,1108.182724,17413.35548,633.0963455,783.1495017,1743.362126,8902.07309,477.4352159,865.923588,1784.318937,13889.6113,1191.239203,6199.471761,2571.900332,4988.395349,1191.27907,357.1162791,2874.983389,9433.79402,512.4950166,1521.222591,662.5149502,11122.37209,420.4651163,160.9634551,5691.717608,9190.049834,1614.289037,774.3488372,2811.322259,7634.883721,567.5747508,281.2126246,21294.23256,5941.754153,1389,396.0033223,1378.953488,4009.368771,1330.016611,159.6843854,6029.913621,3652.282392,1185.063123,329.3853821,3249.428571,954.9435216,363.641196,301,22.93033788,17.65173474,0.638287242,0.931888545,0.621900826,0.789714733
+1393,44418.2963,886.8703704,527.537037,1142.037037,39595.5,703.9074074,781.8703704,1732.962963,22588.44444,588.3888889,881.7037037,1833.981481,32059.44444,1367.518519,5912.185185,4449.833333,11675.40741,1424.111111,409.537037,2896.222222,22118.09259,586.6666667,129.2777778,752.5740741,27429.22222,436.1851852,140.1851852,4737.314815,22293.85185,1772.907407,777.1851852,2849.203704,19081.12963,797.4259259,322.2777778,2147.87037,13504.38889,919.7407407,471.1296296,1319.259259,10955.7037,663.4074074,183.7962963,2988.851852,9016.962963,1384.814815,161.6296296,3256.425926,241.6666667,356.7962963,54,10.68256086,6.790276807,0.77198455,0.870967742,0.5,1.329139795
+1394,52674.90244,977.1707317,569,1156.121951,46342.73171,798.8780488,501.7073171,1760.707317,26995.07317,657.3658537,471.0487805,1786.463415,37342.80488,1447.560976,4184.536585,3149.073171,13819.68293,1564.853659,436.7317073,2439.707317,27201.04878,460.195122,158.8780488,477.902439,31987.09756,464.3902439,153.3414634,3132.585366,26131.60976,1631.609756,847.5365854,2807.609756,22228.41463,642.5365854,348.6097561,1935.390244,17284.97561,978.8292683,501.9268293,1332.04878,13273.39024,757.6585366,196.3902439,2608,11732.26829,1543.707317,126.9512195,3417.170732,298.5609756,356.6097561,41,8.13021192,6.565884401,0.58974324,0.891304348,0.640625,0.57876622
+1395,29998.92308,862.6923077,520.0076923,1075.376923,27055.27692,693.4,651.2615385,1486.230769,14909.49231,553.2,1588.661538,1811.007692,21809.19231,1285.869231,4816.2,3787.530769,7632.115385,1361.015385,380.9,2598.253846,14852.01538,415.5615385,694.0615385,1193.830769,16797.7,513.2538462,371,3459.138462,13895.1,2130.253846,801.5769231,2810.376923,11883.24615,654.9461538,275.2769231,1671.715385,9596.9,1404.5,437.2461538,1326.007692,7308.276923,762.2384615,168.0692308,3844.223077,6375.915385,1344.215385,331.7769231,3259.792308,470.1615385,359.0769231,130,16.96426827,10.13492957,0.801922524,0.909090909,0.677083333,-1.278737391
+1396,28290.49065,746.2242991,437.5373832,1059.11215,23271.08411,612.7149533,594.7383178,1607.64486,13265.13084,482.2056075,879.5186916,1802.476636,18904.47196,1153.61215,5158.761682,3657.546729,6677.149533,1162.023364,356.7943925,3938.780374,12391.64019,2753.233645,656.2009346,763.0654206,14151.78037,423.8130841,127.9859813,4968.280374,11830.5,1624.299065,749.2102804,2786.691589,9735.35514,529.1214953,248.1261682,6733.397196,7887.985981,967.2336449,387.0607477,1336.850467,5645.593458,783.4579439,160.046729,3364.046729,4803.663551,1158.551402,185.0093458,3170.233645,825.3224299,363.7990654,214,21.9897898,13.30482159,0.796190957,0.914529915,0.566137566,0.789592552
+1397,18453.59238,735.1055718,543.0205279,1105.865103,15847.57771,565.9472141,471.6451613,1625.284457,7600.205279,467.2316716,640.9501466,1844.577713,10949.52493,1058.609971,4955.997067,2522.105572,4029.865103,1110.697947,328.0117302,2871.926686,7633.105572,3930.222874,459.3108504,529.6099707,8875.266862,416.7888563,112.085044,7265.950147,6677.205279,1520.43695,662.1348974,2832.416422,5574.982405,605.3020528,243.3049853,10449.85044,3190.343109,748.71261,364.8152493,1296.609971,2665.240469,627.5601173,147.7331378,3058.313783,2189.645161,1045.674487,195.1085044,3161.920821,169.2756598,363.8504399,341,23.07481176,19.09591171,0.561369579,0.936813187,0.738095238,1.373295044
+1398,36468.03797,826.6329114,492.9240506,1079.202532,33515.25316,686.9873418,420.7721519,1579.037975,18583.4557,561.443038,484.3291139,1745.037975,25471.13924,1274.974684,6104.202532,4030.126582,9421.949367,1378.696203,386.5316456,2412.632911,18605.83544,418,180.9240506,459.3037975,21894.4557,413.6962025,134.3417722,4024.670886,17069.94937,1450.177215,926.6582278,2789.873418,14420.02532,598.5316456,302.9240506,1754.468354,11355.67089,838.6202532,444.6835443,1291.64557,9157.063291,679.5696203,173.8734177,4870.417722,7453.683544,1338.075949,146.443038,3194.544304,326.0759494,359.9620253,79,11.96263875,8.908545696,0.66740229,0.877777778,0.548611111,-0.856585582
+1399,22716.84615,753.0946746,508.9230769,1088.177515,19148.44379,617.0650888,743.5621302,1629.39645,11021.25444,492.0118343,1237.887574,1855.775148,15330.56213,1162.224852,7089.869822,4127.076923,5640.319527,1176.662722,341.3491124,5394.715976,10282.49112,1169.272189,112.9289941,915.2307692,11857.51479,386.6035503,126.852071,6015.946746,9921.952663,1874.236686,882.2130178,2789.053254,8298.514793,570.6094675,260.9822485,12634.18935,6654.266272,1120.366864,385.8224852,1345.307692,4926.473373,683.852071,176.3727811,4927.254438,4187.775148,1160.923077,265.6331361,3178.04142,812.4260355,363.6449704,169,19.94770692,11.20899305,0.827192346,0.89893617,0.619047619,0.099251808
+1400,42709.86441,911.6949153,529.6779661,1127.677966,38540.67797,742.9322034,531.5254237,1692.864407,21737.69492,613.1525424,536.0338983,1819.372881,29723.9322,1366.847458,5922.372881,4073.355932,11139.54237,1427.135593,424.7966102,2406.220339,22161.37288,439.0338983,140.8644068,510.1864407,25755.54237,445.2372881,138.4237288,3368.694915,20669.18644,1604.677966,813.440678,2812.288136,17685.88136,616.0508475,317.5084746,2051.186441,13919.47458,889.2033898,477.7627119,1318.135593,10762.55932,675.220339,192.7118644,5598.745763,8980.966102,1463.644068,240.8813559,3358.305085,291.3220339,360.220339,59,11.08147682,7.54997206,0.731990711,0.830985915,0.487603306,-0.916189846
+1401,31781.10625,874.46875,468.25625,1093.09375,27285.725,720.925,685.98125,1533.5125,15483.4125,551.45,928.7625,1802.41875,21619.58125,1325.14375,4158.34375,3031.325,7694.20625,1338.11875,387.0125,2577.85,14598.8875,3219.15625,476.93125,1161.7,17396.275,462.29375,558.18125,2746.99375,13788.51875,1834.06875,763,2833.76875,11755.53125,669.275,282.8375,1823.5125,9522.69375,1177.425,447.15625,1321.95,7386.30625,730.00625,177.01875,4952.43125,6235.79375,1343.84375,311.04375,3204.66875,518.8875,361.51875,160,19.98058342,10.69430507,0.844703278,0.864864865,0.571428571,-1.320865382
+1402,29729.40306,766.244898,476.6173469,1066.80102,25457.53061,642.1989796,714.1632653,1577.311224,14600.38776,506.9183673,1402.091837,1815.341837,20017.07653,1214.494898,6051.204082,3282.852041,7308.683673,1217.397959,350.1020408,3552.418367,14409.45408,1575.484694,466.1581633,929.6836735,16421.36735,387.8673469,134.0510204,4260.295918,13590.93367,1812.193878,783.0969388,2801.326531,11564.27041,656.0255102,269.1173469,3213.22449,9417.954082,1160.938776,393.7244898,1299.760204,7043.571429,724.3571429,163.8214286,3395.969388,5917.163265,1250.566327,1167.612245,3176.806122,709.5816327,362.3061224,196,17.68651277,14.2438545,0.592797963,0.951456311,0.725925926,-1.166613452
+1403,25804.89109,767.8910891,475.7821782,1090.851485,21988.58416,623.1386139,727.6138614,1620.762376,12458.50495,486.9405941,1913.732673,1785.554455,17486.61386,1178.980198,6770.118812,3846.455446,6350.524752,1177.178218,351.7128713,6652.683168,11985.62376,1159.445545,113.7227723,691.4653465,13718.94059,383.2376238,114.3465347,4283.594059,11470.78218,1625.693069,717.6534653,2784.910891,9455.326733,578.0891089,263.4752475,15155.43564,7733.049505,1156.831683,383.029703,1329.336634,5823.386139,646.6732673,158.3861386,3786.257426,4933.683168,1190.435644,249.5049505,3141.049505,776.2673267,360.8019802,101,14.41147291,9.238534678,0.767495643,0.926605505,0.601190476,-0.936429128
+1404,14210.639,730.373444,480.5352697,1069.419087,8967.103734,570.1742739,414.3526971,1514.763485,4608.307054,435.8630705,402.5020747,1746.053942,7198.497925,1077.431535,3905.921162,1767.954357,2655.717842,1109.539419,379.7883817,2711.838174,5104.941909,644.4273859,2011.253112,490.9709544,5854.892116,378.0497925,110.2738589,4042.360996,5063.60166,1427.755187,661.5975104,2797.008299,4176.020747,552.6473029,251.253112,21720.3195,3378.767635,713.8589212,366.879668,1399.087137,2338.780083,1541.585062,149.2365145,5215.311203,2196.556017,1100.497925,223.9502075,3143.804979,934.4273859,362.2074689,241,20.18719956,15.3093473,0.651825427,0.960159363,0.753125,1.310048111
+1405,17325.23729,752.5381356,530.0254237,1071.173729,13422.48305,575.7542373,789.4067797,1576.394068,6705.173729,431.0677966,1526.745763,1754.34322,10675.16949,1141.783898,6510.385593,3263.029661,3948.838983,1147.661017,346.1398305,4433.834746,7698.449153,396.440678,2078.165254,886.690678,8570.15678,397.309322,113.2372881,4012.991525,7255.783898,1691.631356,745.4237288,2786.360169,5770.474576,541.3177966,240.2457627,11730.16102,4508.427966,1163.309322,365.8728814,1374.521186,2857.635593,1108.682203,144.4576271,4966.021186,2663.677966,1053.923729,263.0338983,3162.805085,988.3135593,363.9661017,236,18.44745953,16.6498764,0.430571224,0.940239044,0.69005848,-0.99634761
+1406,39847.51316,866.9736842,571.6776316,1141.881579,38537.93421,717.5526316,610.6644737,1698.078947,19943.16447,580.1184211,1002.144737,1817.75,28852.29605,1278.973684,6636.506579,6735.335526,10815.33553,1386.289474,399.9210526,2613.177632,20675.23684,542.8552632,130.6052632,623.1447368,24812.50658,913.3289474,360.7763158,4656.960526,19418.02632,1573.690789,801.0328947,2826.973684,16688.94737,615.5855263,307.4671053,4620.013158,11826.34868,941.8618421,451.7828947,1308.342105,9834.690789,642.0723684,179.0328947,3828.776316,7687.532895,1342.480263,217.5657895,3235.381579,223.5592105,363.1776316,152,16.85952492,12.1973122,0.690358823,0.888888889,0.638655462,0.009248168
+1407,46794.86567,916.9701493,578.4179104,1155.880597,42684.14925,740,520.5522388,1708.074627,23732.23881,594.238806,494.8507463,1768.955224,34035.46269,1365.358209,6298.059701,4253.820896,12593.31343,1454.985075,419.9104478,2407.253731,23694.43284,643.4626866,123.2238806,435.4626866,28906.55224,440.880597,134.6567164,5230.731343,23319.55224,1506.373134,824.7313433,2820.014925,19834.58209,708.0597015,316.1492537,3037.940299,14096.04478,866.8656716,473.5373134,1311.179104,11303.92537,672.7014925,182.6119403,3287.850746,9353.656716,1421.880597,133.4925373,3265.537313,233.1940299,360.1791045,67,10.28449955,8.67884833,0.536537337,0.957142857,0.67,0.459363204
+1408,34920.85235,912.7852349,607.4563758,1115.395973,32336.26174,729.5838926,636.0872483,1703.42953,18054.99329,597.2147651,634.3489933,1838.375839,24655.43624,1343.885906,5793.724832,3928.503356,9021.147651,1402.315436,401.9597315,2425.214765,17902.58389,527.1677852,268.4832215,504.8791946,21124.61745,497.966443,136.295302,3701.838926,16798.7047,1559.375839,1037.288591,2856.543624,14134.3557,739.5637584,306.7651007,2860.677852,10950.03356,1057.536913,475.9261745,1314.657718,8792.308725,1728.288591,182.0134228,3844.409396,7268.879195,1614.033557,224.6577181,3302.557047,312.3825503,363.3221477,149,17.76959131,11.24340427,0.774370152,0.871345029,0.591269841,-1.298755571
+1409,24863.42188,765.9609375,472.0390625,1037.148438,22722.84375,646.25,606.3203125,1479.328125,12673.57031,488.1953125,531.4296875,1745.1875,18040.19531,1184.09375,5660.242188,2908.476563,6486.664063,1207.265625,343.9609375,2457.953125,12634.57031,423.90625,119.84375,521.6484375,14455.72656,371.53125,121.96875,4189.359375,11842.02344,1388.515625,700.140625,2796.75,9979.179688,625.75,245.359375,2924.359375,8217.085938,788.671875,385.3515625,1291.929688,6357.46875,621.015625,160.4453125,5189,5381.75,1244.273438,1009.242188,3149.046875,643.3125,362.234375,128,17.85830797,11.36395311,0.771408834,0.766467066,0.571428571,1.219427938
+1410,27598.04255,763.5212766,478.8510638,1070.606383,22968.14894,621.8510638,900.0744681,1581.425532,13148.54255,491.0106383,1366.5,1795.797872,19259.40426,1184.255319,7176.734043,3661.180851,6789.829787,1188.37234,346.212766,8398.212766,12723.81915,1248.829787,153.3085106,1232.755319,14547.1383,384.287234,116.5425532,4766,12420.24468,1710.234043,711.1170213,2799.43617,10340,590.8404255,275.5,17010.88298,8433.212766,1456.893617,393.712766,1368.989362,6293.882979,661.0744681,215.9893617,4273.414894,5422.287234,1210.414894,222.287234,3236.574468,801.606383,360.7446809,94,14.74864106,9.247098066,0.77903562,0.862385321,0.556213018,0.590001008
+1411,23982.96166,786.8785942,525.7444089,1121.974441,20667.80831,629.8083067,441.1214058,1720.881789,11122.45048,477.0798722,449.2587859,1795.811502,16707.88818,1182.511182,4949.447284,2620.738019,5967.495208,1211.370607,348.7028754,2549.808307,11072.63259,4137.306709,176.1948882,484.4824281,13277.83706,420.6677316,119.284345,4943.766773,10757.46326,1394.955272,758.7955272,2808.341853,8742.693291,571.9456869,271.313099,18719.46326,7105.015974,780.5271565,391.2619808,1325.642173,5023.428115,720.4952077,155.4920128,3372.667732,4362.715655,1185.530351,149.4153355,3228.565495,897.5910543,365.8210863,313,21.66021666,18.96436308,0.483147564,0.909883721,0.618577075,-1.274720017
+1412,35637.85393,827.6516854,531.0449438,1117.808989,31280.40449,683.8988764,469.3483146,1664.101124,17895.73034,559.1235955,719.9662921,1790.876404,24953.68539,1275.292135,4847.168539,4937.269663,9253.224719,1339.269663,382.8314607,2629.966292,17698.34831,580.6966292,118.4269663,575.741573,21528.96629,425.3820225,131.2359551,4399.168539,17473.74157,1675.741573,870.3707865,2824.831461,15044.1573,1007.52809,300.3258427,2361.089888,10886.93258,878.8651685,440.5842697,1301.910112,8767.460674,630.1685393,174.5168539,3675.168539,7228.089888,1329.393258,145.988764,3243.426966,250.2921348,362.7977528,89,12.27273878,9.970199583,0.583120225,0.927083333,0.622377622,1.320924662
+1413,31318.048,869.144,576.368,1101.88,29199.12,698.856,711.4,1640.784,15933.6,568.408,1058.344,1804.504,22259.392,1300.352,7738.096,6728.328,8135.432,1360.272,386.992,2932.512,16110.336,417.808,166.64,1017.216,19195.272,429.368,235.104,5997.024,15152.664,1824.768,806.32,2827.32,12925.576,603.584,298.128,2440.712,10113.608,997.84,454.752,1299.528,8070.44,666.448,183.408,7333,6693.88,1388.792,261.112,3274.696,281.696,363.984,125,14.72297932,11.62028949,0.614056469,0.862068966,0.555555556,0.748154701
+1414,33712.65806,811.9548387,464.3612903,1082.174194,29018.87097,671.7677419,643.6774194,1573.290323,16917.07742,522.0258065,1209.587097,1797.316129,23338.41935,1267.851613,6262.025806,3066.083871,8427.858065,1286.522581,363.0322581,3047.722581,16650.90323,472.2774194,109.0451613,1102.890323,19076.23226,393.0129032,147.083871,2763.090323,15501.14194,1808.806452,596.3870968,2816.03871,13225.74194,652.2322581,262.7677419,1982.23871,10889.06452,1138.03871,399.8709677,1297.2,8084.432258,633.4387097,162.3870968,3029.090323,6992.432258,1306.232258,1196.335484,3223.187097,672.6258065,363.4967742,155,16.04964054,13.12031755,0.57595191,0.939393939,0.569852941,0.895956725
+1415,25601.43478,740.7913043,458.5043478,1089.452174,21787.26957,591.8956522,472,1587.304348,12174.70435,471.8869565,507.5913043,1780.695652,17275.4,1137.53913,4057.6,3213.608696,6331.852174,1163.356522,336.1478261,3744.121739,11683.84348,2510.895652,253.573913,505.6521739,13294.71304,391.0173913,115.4086957,4652.713043,11134.68696,1407.26087,825.0695652,2786.4,9225.495652,622.626087,249.8956522,9490.373913,7675.817391,841.2608696,372.5304348,1312.373913,5691.904348,665.0695652,154.0869565,2708.565217,4834.469565,1163.808696,143.6956522,3192.095652,789.4869565,362.2869565,115,18.37635299,8.86702918,0.875882814,0.827338129,0.605263158,-1.534745658
+1416,37219.96907,855.3195876,571.628866,1150.350515,33286.73196,691.0927835,575.3814433,1722.329897,18279.4433,553.3917526,545.2268041,1782.597938,25633.52577,1279.360825,5798.546392,4174.608247,9723.154639,1362.659794,389.7628866,2523.360825,18229.50515,9326.412371,276.9175258,434.7010309,22117.21649,483.4123711,136.0515464,4857.505155,17518.98969,1496.402062,750.2061856,2822.061856,14965.74227,644.9587629,311.0927835,3092.298969,10120.50515,825.742268,441.5257732,1312.793814,8271.113402,676.2371134,172.8556701,2377.876289,6830.886598,1310.020619,160.8865979,3240.226804,205.3402062,363.4226804,97,12.82933034,9.945053283,0.631739185,0.932692308,0.678321678,1.558110009
+1417,23396.25424,764.2824859,459.3615819,1054.20339,20742.48588,635.6779661,477.0508475,1443.225989,11705.74011,690.3502825,728.9378531,1785.480226,16703.23729,1228.502825,3766.694915,2564.033898,6026.610169,1476.621469,397.5367232,2558.265537,11847.50282,413.8587571,520.6497175,806.3559322,13768.81356,396.4350282,120.8870056,2446.288136,10943.56497,1613.129944,788.9887006,2864.841808,9519.118644,713.2485876,263.5988701,1833.853107,7716.887006,907.7288136,423.2768362,1341.853107,6019.468927,753.8418079,163.6836158,2503.531073,4984.700565,1282.717514,336.7966102,3141.570621,567.180791,365.6497175,177,16.3249391,14.0645829,0.50769023,0.956756757,0.650735294,-0.982554664
+1418,24152.12545,736.437276,461.8028674,1073.677419,20983.90323,595.1218638,532.4444444,1566.537634,11814.77778,480.3046595,561.2795699,1777.971326,16854.62724,1208.172043,4670.566308,2297.405018,6136.74552,1162.544803,331.5412186,2764.326165,11518.10394,10250.25448,150.1111111,555.9032258,13083.27599,449.8637993,135.3799283,4319.017921,11030.05735,1470.827957,726.6917563,2788.401434,9379.810036,1278.637993,249.4623656,3702.340502,7590.78853,803.9498208,382.7132616,1298.053763,5784.573477,647.8530466,158.5304659,3481.817204,4837.609319,1178.032258,535.1971326,3204.408602,741.7383513,371.0250896,279,26.43337197,14.10811103,0.845659067,0.891373802,0.587368421,0.428629621
+1419,19397.45139,744.9166667,509.6458333,1100.722222,17018.97917,602.5208333,452.5486111,1654.729167,9348.993056,470.7361111,440.2222222,1749.138889,13598.89583,1130.916667,5405.854167,2574.027778,4926.645833,1140.236111,338.9583333,2607.819444,9200.847222,4881.173611,534.8472222,455.3333333,10846.63194,421.5972222,115.4166667,4988.409722,8837.180556,1378.152778,798.6805556,2797.506944,7282.555556,586.0486111,273.2986111,24664.78472,5933.215278,738.3402778,384.4861111,1337.986111,4257.291667,778.1319444,155.1805556,4007.736111,3646.791667,1157.895833,138.8888889,3264.430556,869.1805556,364.3888889,144,15.29073329,13.10330347,0.515409384,0.929032258,0.6,-1.004397713
+1420,36322.44872,1256.923077,662.6025641,1160.551282,30855.88462,778.6923077,667.7692308,1842.102564,21790.10256,663.7692308,1594.858974,1840.179487,33273.38462,1804.294872,5178.141026,3574.961538,11055.19231,1581.820513,451.5128205,2570.538462,20423.10256,757.0769231,444.1666667,666.3461538,24320.48718,721.6666667,273.7435897,3417.692308,18954.5,2193.115385,830.0384615,2838.641026,16235.17949,770.5384615,351.6794872,1569.935897,12768.08974,1325.884615,525.3333333,1332.935897,9876.307692,796.2820513,196.9230769,4007.564103,7923.128205,1520.230769,1134.897436,3370.307692,397.1153846,362.4615385,78,11.39494661,9.107367704,0.601003762,0.987341772,0.6,-1.455385843
+1421,28004.01818,782.1454545,485.6454545,1052.736364,25482.54545,653.1363636,587.1454545,1529.227273,14249.29091,508.2636364,431.3090909,1761.7,19615.44545,1248.109091,6096.845455,3351.372727,7215.890909,1250.190909,347.5727273,2426.445455,14192.31818,435.9363636,142.7181818,458.3181818,16471.84545,392,119.9727273,3635.018182,13409.79091,1373.890909,717.7454545,2773.236364,11382.21818,740.6090909,259.5272727,3156.209091,9262.518182,802.7727273,387.1545455,1294.272727,7148.463636,623.2181818,150.8090909,3863.918182,5982.918182,1270.227273,658.7727273,3184.118182,630.9363636,365.8818182,110,12.87200039,11.24219631,0.487032625,0.93220339,0.654761905,-0.961266922
+1422,31619.70647,784.60199,463.9054726,1075.616915,27448.74129,699.3383085,690.2835821,1585.60199,15987.00995,522.5323383,1273.189055,1808.208955,22453.34826,1270.950249,5777,3754.661692,8130.776119,1259.995025,362.9402985,2901.134328,15623.47264,822.3233831,175.5472637,1120.676617,18132.16418,385.0298507,219.6567164,3212.756219,14814.14925,1754.179104,795.60199,2806.248756,12459.32836,676.9054726,267.1044776,2278.935323,10194.87065,994.6119403,410.2089552,1291.676617,7702.975124,636.9751244,157.6567164,3825.60199,6440.049751,1305.606965,1527.129353,3167.507463,693.2089552,367.7562189,201,18.22549528,15.33807304,0.540144393,0.877729258,0.738970588,-0.74517652
+1423,18999.39604,747.3712871,526.2722772,1075.752475,16546.14851,598.7722772,544.9405941,1665.321782,8944.059406,474.009901,480.6336634,1799.490099,13217.22772,1132.237624,6801.668317,3858.980198,4776.727723,1137.222772,332.4356436,2750.019802,8726.193069,1365.450495,239.6188119,457.0594059,10360.54455,402.7029703,114.9009901,8024.158416,8424.633663,1343.782178,1001.668317,2797.069307,6863.019802,541.519802,259.4356436,21366.90594,5706.683168,756.9653465,381.7277228,1350.366337,4059.623762,669.7227723,149.6633663,3938.539604,3451.336634,1143.386139,152.019802,3210.366337,855.9405941,367.7376238,202,18.74570544,15.53772183,0.559443713,0.901785714,0.594117647,1.270930038
+1424,38591.14737,844.7105263,520.0368421,1118.094737,36217.52105,689.1894737,454.3052632,1651.757895,19619.33158,563.9263158,519.8947368,1795.026316,28167.85789,1260.726316,4924.952632,3895.721053,10367.77368,1345.331579,387.6315789,2411.736842,19928.19474,1976.457895,149.9842105,442.4315789,24131.49474,437.8052632,140.5421053,3674.326316,19133.04737,1459.842105,765.7526316,2813.384211,16426.58421,777.1526316,295.8894737,2657.110526,11788.11579,836.2473684,437.7526316,1299.894737,9490.010526,644.7,176.7263158,4124.168421,7665.689474,1321.121053,137.7421053,3278.852632,234.6157895,370.0157895,190,24.37684881,10.58863347,0.900733316,0.887850467,0.502645503,-0.975628818
+1425,34976.94737,932.5,513.6315789,1082.789474,32626.65789,646.0526316,468.0657895,1531.289474,17553.34211,541.3815789,599.3947368,1768.315789,24641.84211,1242.592105,7471.960526,3119.763158,8976.618421,1328.263158,378.1315789,2428.210526,17911.61842,392.6052632,146.6052632,534.7368421,20610.46053,396.5921053,127.6315789,3205.513158,16509.31579,1539.236842,916.8684211,2819.368421,14040.96053,581.0921053,286.9210526,1460.394737,11109.56579,856.1315789,436.75,1306.776316,8851.657895,625.9736842,156.0657895,2352.868421,7351.263158,1297.078947,123.1710526,3200.328947,333.4342105,365.3289474,76,14.22740638,7.077862885,0.867474932,0.926829268,0.633333333,-1.489088999
+1426,37883.39344,987,540.3770492,1109.918033,20056.52459,605.1639344,344.4754098,1511.442623,11715.5082,476.0819672,465.8032787,1773.377049,15883.80328,1088.360656,6157.442623,3285.639344,5993.393443,1217.016393,362.0655738,2446.934426,12166.31148,362.8688525,3201.885246,460.0819672,13798.70492,489.6557377,119.7213115,2917.983607,10951.13115,1660.213115,883.442623,2801.557377,9334.409836,731.1967213,254.8852459,1551.918033,7474.344262,798.3934426,412.9180328,1348.803279,5990.901639,1344.721311,166.5245902,5813.196721,5129.327869,1272.803279,278.9180328,3226.196721,351.5409836,366.147541,61,11.22737105,7.283294664,0.761036702,0.924242424,0.504132231,0.871100003
+1427,19213.15709,806.6130268,489.137931,1061.739464,16338.00383,632.6743295,611.0996169,1459.076628,8987.693487,511.8697318,855.1034483,1776.655172,12792.57088,1196.628352,4817.532567,3304.440613,4648.203065,1222.888889,348.1226054,2557.034483,8850.727969,2214.176245,541.1954023,825.0038314,10168.76245,460.7547893,170.2375479,4667.693487,8032.823755,1642.609195,789.2068966,2803.226054,6970.934866,733.5747126,244.6168582,2002.145594,5676.681992,884.6704981,408.1072797,1319.37931,4456.636015,710.1111111,159.8084291,4973.758621,3755.122605,1227.249042,308.5862069,3209.800766,523.3678161,370.7624521,261,28.71470019,12.879044,0.893774077,0.847402597,0.501923077,-1.059821148
+1428,21512.82524,751.2330097,473.9029126,1066.271845,18524.26214,628.6699029,442.0194175,1494.223301,10598.23301,483.038835,434.5728155,1774.281553,14849.97087,1187.893204,5316.135922,2654.728155,5243.932039,1211.203883,338.8252427,2413.330097,10431.19417,418.7669903,2678.592233,516.5048544,12048.5534,383.8834951,115.1941748,2853.126214,9860.475728,1575.543689,720.9708738,2783.349515,8635.932039,764.5533981,242.7378641,2708.174757,6980.466019,793.7864078,388.4951456,1389.951456,5216.669903,1402.796117,158.2718447,5211.631068,4618.737864,1234.883495,599.5533981,3145.281553,609.7184466,365.6213592,103,14.4750179,9.109844577,0.777122428,0.962616822,0.668831169,1.096380543
+1429,16133.21795,734.0512821,456.9230769,1042.192308,15631.48718,607.8589744,479.8205128,1443.461538,7858.179487,466.9871795,610.7435897,1749.179487,12506.30769,1154.923077,8418.448718,2993.025641,4571.410256,1163.512821,330.525641,2535.653846,8569.717949,425.4615385,659.025641,649.9871795,9914.589744,370.7307692,115.9871795,3838.230769,7873.679487,1581.666667,662.3333333,2785.064103,6659.730769,690.6153846,243.7564103,2226.089744,5705.487179,825.025641,372.7307692,1295.5,4560.641026,785.4871795,146.6025641,4531.166667,3755.435897,1246.75641,2704.730769,3165.653846,662.5512821,366.9358974,78,11.57148294,9.852404874,0.524454629,0.866666667,0.5,0.969472115
+1430,45201.16667,897.8666667,565.85,1142.916667,42176.51667,731.7833333,559.4166667,1746.5,22470.88333,590,810.05,1835.066667,31897.23333,1307.8,5815.1,5389.383333,11835.31667,1405.9,408.2666667,2520.7,22303.13333,511.2,138.95,684.3,26837.06667,464.3666667,172.6833333,4158.733333,21418.33333,1723.716667,875.5666667,2841.75,18256.43333,616.1166667,320.55,3975.333333,12547.55,923.3166667,472.3833333,1307.933333,10247.18333,628.05,184.0166667,3119.616667,8233.583333,1345.916667,211.6666667,3235.166667,214.5666667,366.7833333,60,10.71965038,7.589480008,0.706215469,0.895522388,0.6,-0.528975315
+1431,38633.955,893.27,558.275,1134.88,34764.85,722.85,702.24,1710.525,19633.7,597.035,917.49,1816.26,27014.34,1347.355,6813.155,5186.145,9951.97,1423.24,408.375,2465.47,19699.66,451.29,199.805,605.61,23005.295,1350.12,140.365,3989.995,18422.985,1540.81,855.83,2825.62,15855.185,643.375,314.74,2389.96,12242.66,1055.375,476,1319.915,9579.485,958.715,187.115,4242.275,8195.635,1436.445,185.285,3272.36,299.38,370.38,200,20.26288847,13.0902464,0.763319848,0.925925926,0.588235294,0.936848577
+1432,26653.25234,1421.616822,678.5327103,1101.093458,20644.23364,671.5700935,485.2149533,1639.439252,14973.31776,589.5794393,766.953271,1792.775701,21601.27103,1424.327103,4055.803738,2404.028037,7903.654206,1580.429907,400.8878505,2470.336449,15991.33645,4314.953271,675.3925234,631.4953271,18418.28037,685.6728972,170.7476636,3756.803738,14223.92523,1717.728972,806.2897196,2830.719626,12158.48598,857.9345794,302.1869159,1696.457944,9767.056075,1004.17757,488.3457944,1419.224299,7468.598131,857.5514019,184.9906542,4411.439252,6505.383178,1386.813084,241.2990654,3431.186916,389.5140187,369.1121495,107,12.66962046,11.24683449,0.460420429,0.946902655,0.548717949,-0.111521678
+1433,33177.78431,811.7058824,459.8431373,1072.980392,29004.26471,720.3039216,768.6176471,1574.04902,16617.32353,535.8529412,1329.156863,1792.019608,23359.0098,1269.205882,5788.823529,2815.931373,8286.333333,1267.911765,364.7254902,2947.078431,16322.72549,522.2647059,203.1470588,1847.352941,18666.03922,387.7843137,350.3627451,2528.303922,15409.65686,1794.627451,631.7352941,2840.803922,13074.08824,753.3529412,259.0490196,1899.392157,10621.15686,1021.823529,396.6764706,1300.754902,7950.666667,641.872549,156.1372549,3464.27451,6884.813725,1290.990196,1660.460784,3225.205882,681.2254902,369.5196078,102,17.75735272,7.991041204,0.893021958,0.879310345,0.453333333,-0.669060026
+1434,31904.95775,827.3661972,526.2394366,1096.887324,27269.1831,668.8873239,494.915493,1663.732394,15697.5493,518.8028169,615.9577465,1827.830986,21943.70423,1301.43662,6974.943662,4244.323944,8019.394366,1269.859155,363.2112676,2925.746479,15737.23944,667.7042254,154.6901408,540.3239437,17878.04225,387.5352113,124.8169014,5031.84507,14589.16901,1507.929577,1002.464789,2838.478873,12634.04225,681.5070423,285.0704225,3836.957746,10220.94366,888.4788732,403.2957746,1298.028169,7588.295775,657.4929577,156.056338,3930.915493,6444.704225,1298.323944,1947.028169,3219.422535,720.3661972,367.1830986,71,12.64725956,8.04643398,0.771508046,0.788888889,0.455128205,-0.909585446
+1435,37265.75806,1004.61828,592.2526882,1121.33871,34748.16667,687.7526882,538.4301075,1629.11828,19219.33871,567.8817204,568.4247312,1793.55914,26831.34409,1289.102151,7552.548387,5622.66129,9970.763441,1356.709677,389.811828,2416.413978,19269.94086,493.2634409,142.9301075,476.0107527,23018.96774,406.8763441,133.7204301,5856.752688,18377.1129,1521.580645,875.0376344,2805.021505,15831.3172,615.2204301,305.1666667,2450.370968,11834.85484,844.2365591,459.6774194,1299.639785,9564.908602,635.4784946,176.1021505,2608.645161,7800.704301,1352.102151,127.7526882,3227.22043,260.8387097,372.172043,186,23.77172709,13.13757293,0.83340988,0.771784232,0.402597403,-0.739602036
+1436,33491.63158,923,535.2368421,1104.657895,31340.97368,671.8684211,816.5526316,1611.684211,17231.78947,577.0263158,859.8157895,1755.736842,24082.5,1246.263158,7279.447368,5086.710526,8955.526316,1364.842105,372.3684211,3169.578947,17411.31579,417.1842105,147.8684211,1710.447368,20719.18421,408.8684211,143.9473684,3923.947368,16734.28947,1757.421053,884.0263158,2816.105263,14170.23684,592.5789474,286.4210526,2368.973684,10910.84211,967.4210526,466.7368421,1309.684211,8712.552632,642.4210526,176.8157895,3477.815789,7281.236842,1369.394737,217.5263158,3228.473684,271.0789474,365.5,38,7.666103779,6.639163975,0.499972129,0.926829268,0.678571429,-1.282861673
+1437,43766.30159,1364.15873,692.5555556,1131.52381,41151.1746,935.8571429,813.4285714,2054.793651,22271.07937,708.4603175,1222.111111,1901.333333,30394.52381,2480.365079,6428.333333,3629.507937,10562.15873,1512.31746,416.6825397,2482.507937,18765.65079,3784.714286,439.952381,820.3015873,22344.90476,561.8730159,242.5714286,6101.507937,17165.47619,2003.809524,939.4761905,2842.68254,14981.34921,750.0634921,314.3333333,1772.269841,11726.09524,1027.936508,488.6825397,1321.539683,9278.968254,784.5238095,187.7619048,6296.555556,7903.952381,1471.539683,329.2380952,3409.904762,401.952381,369.4761905,63,10.47543716,9.021888273,0.508194764,0.887323944,0.572727273,-1.352714765
+1438,30872.42,883.3,498.39,1075.51,29034.43,746.78,779.41,1591.45,14646.26,553.87,711.47,1719.78,21340.9,1306.24,4931.43,3648.7,7625.74,1341.37,378.27,2511.53,14528.11,602.18,786.34,701.05,17440.97,424.24,254.11,3246.59,13326.21,1751.14,849.77,2797.01,11659.31,964.67,280.42,1730.97,9462.7,907,453.98,1366.09,7421.15,822.3,176.25,6613.15,6356.91,1381.53,208.97,3291.82,412.11,368.72,100,12.2060447,11.01836979,0.430275108,0.925925926,0.641025641,-0.94356779
+1439,36691.37209,841.7209302,513.3255814,1100.918605,31990.76744,688.8255814,598.3255814,1538.546512,17605.82558,560.8023256,480.2209302,1743.918605,25145.88372,1313.77907,5755.162791,3061.186047,8889.325581,1365.604651,380.6046512,2447.534884,17518.9186,444.5930233,484.7093023,495.755814,20541.46512,409.4186047,131.6860465,3289.395349,16484.81395,1666.197674,949.2093023,2832.569767,14174.39535,695.0581395,296.4186047,1758.44186,11499.4186,963.4418605,466.6511628,1312.674419,8735.127907,737.8953488,174.4418605,2788.593023,7555.476744,1444.116279,325.9534884,3263.511628,460.2209302,370.1046512,86,12.0579246,9.600098424,0.605079479,0.955555556,0.661538462,-0.263651081
+1440,26597.9708,893.3138686,544.0145985,1090.664234,24437.53285,733.189781,630.6642336,1563.883212,12943.73723,599.8759124,507.3065693,1753.372263,18657.46715,1407.50365,6821.591241,2533.729927,6639.459854,1381.562044,406.1532847,2509.927007,11990.75182,490.3941606,857.4087591,486.3065693,13954.68613,526.1970803,129.4744526,4843.751825,10719.9854,1613.737226,784.7810219,2822.40146,9383.532847,820.2262774,280.6131387,1863.226277,7500.50365,885.3284672,439.8394161,1323.087591,6065.620438,843.7664234,177.9781022,4475.058394,4862.693431,1364.861314,1104.445255,3169.321168,545.9708029,370.270073,137,15.93341536,11.12160647,0.716092709,0.944827586,0.658653846,1.060523402
+1441,28642.71875,754.5546875,476.265625,1101.890625,24612.04688,615.4765625,647.921875,1666,13530.46094,468.0859375,550.234375,1799.882813,19753.08594,1147.710938,3941.109375,2855.75,7090.601563,1186.554688,339.4609375,3528.945313,13171.11719,2631.929688,122.4296875,569.9765625,15670.9375,404.0703125,116.5390625,4250.875,12969.85938,1486.945313,799.0546875,2793.125,10655.25,574.015625,271.2265625,16869.04688,8478.632813,899.578125,393.3515625,1336.648438,6094.023438,634.84375,154.765625,3473.921875,5177.65625,1166.765625,166.03125,3193.6875,878.3203125,370.5546875,128,16.66251283,10.57337283,0.772873175,0.941176471,0.62745098,-1.317609112
+1442,30668.39506,849.8024691,517.7777778,1072.839506,27109.2963,670.2716049,619.0987654,1521.012346,14690.1358,559.3703704,1117.864198,1798.864198,21470.75309,1274.716049,5622.666667,3785.333333,7566.530864,1310.358025,361.6049383,2533.851852,14696.11111,381.382716,385.8148148,717.1851852,17395.20988,768.3703704,133.382716,4432.580247,13794.54321,1673.469136,814.9259259,2807.419753,11915.7037,618.308642,264,1580.753086,9563.790123,1148.975309,414.9012346,1312.222222,7448.123457,700.9506173,176.5925926,3426.493827,6465.592593,1291.222222,247.654321,3203.481481,468.7777778,369.8148148,81,13.69555302,8.081783795,0.807328136,0.931034483,0.675,-0.42954669
+1443,25182.248,859.288,487.968,1042.752,22391.552,694.976,589.52,1459.92,11963.112,541.12,574.744,1771.512,17229.848,1275.952,5853.032,2714.72,6348.56,1301.968,393.504,2606.984,11576.8,401,1139.496,605.544,13600.84,412.84,127.456,3708.688,10587.592,1652.528,764.76,2813.32,9210.688,601.456,274.792,1788.792,7235.704,849.064,428.264,1371.944,5663.768,886.608,169.632,4267.456,4787.592,1283.68,184.016,3240.008,482.76,370.192,125,14.13690797,11.63083871,0.568434364,0.961538462,0.686813187,0.967185122
+1444,26844.9375,802.3020833,508.5104167,1070.6875,24588.65625,678.3020833,428.0208333,1515.395833,13481.52083,526.8333333,784.0104167,1759.354167,19289.14583,1287.625,4817.208333,3170.875,6500.90625,1267.229167,373.65625,2461.53125,13325.22917,438.8020833,1733.0625,662.1875,15451.08333,402.1666667,138.65625,2338.020833,12588.53125,1756.28125,924.5,2836.572917,11128.6875,630.5416667,273.0625,1778.322917,8716.041667,1024.458333,426.3541667,1359.229167,6823.875,1045.520833,167.2604167,3130.302083,5790.875,1326.104167,286.2395833,3147.635417,579.46875,370.3645833,96,11.54601152,10.74153574,0.36673777,0.932038835,0.666666667,-0.184553227
+1445,24850.28994,766.8343195,485.7514793,1044.431953,22995.24852,656.4852071,513.6331361,1491.792899,12363.15976,506.3017751,733.6213018,1779.816568,17953.55621,1220.242604,5801.106509,3276.650888,6217.715976,1235.366864,358,2494.372781,12530.6213,440.852071,2011.159763,719.6508876,14612.86982,483.7633136,157.8343195,2802.171598,11661.09467,1670.076923,697.9171598,2791.426036,10280.73373,712.3254438,260.3254438,1923.763314,8357.485207,982.9053254,407.9763314,1342.668639,6344.201183,1181.059172,156.3254438,5167.35503,5581.236686,1277.485207,394.8994083,3155.615385,593.6213018,370.3786982,169,21.08158357,11.50127881,0.838071456,0.789719626,0.65,-1.376779967
+1446,41873.98667,881.0533333,499.1333333,1114.453333,35723.4,727.84,626.4533333,1683.333333,21270.68,555.1466667,746.6,1806.346667,28601.10667,1349.186667,6165.12,2827.52,10421.26667,1348.533333,389.2,2547.32,20494.96,1524.986667,134.0666667,796.9466667,23275.68,421.0666667,283.7466667,3520.2,19262.89333,1665.32,704.5466667,2820.88,16597.76,699,286.88,2571.493333,13559.90667,884.0266667,432.8133333,1306.36,9790.693333,635.72,165.24,3424.573333,8430.986667,1400.293333,2693.413333,3284.546667,727.92,369.6666667,75,16.00131314,6.912630957,0.901871699,0.833333333,0.487012987,-0.986900716
+1447,20183.16129,718.5322581,463.4677419,1066.217742,17882.58065,590.0564516,457.9677419,1548.935484,10022.56452,476.9677419,407.5564516,1768.822581,14020.98387,1123.08871,5526.443548,2989.83871,5082.290323,1128.048387,320.2580645,2586.701613,9531.540323,9466.024194,307.7580645,444.9596774,10961.17742,428.6693548,110.6209677,5495.467742,9253.032258,1323.016129,919.0403226,2781.379032,7696.153226,603.5080645,247.3629032,6806.540323,6283.233871,770.4516129,382.5645161,1306.580645,4702.282258,727.9596774,149.8548387,3210.637097,3962.443548,1147.41129,168.2580645,3200.387097,767.5241935,371.5,124,14.05621543,12.04670577,0.515253797,0.932330827,0.635897436,0.530934628
+1448,32317.18634,772.0993789,516.3664596,1119.354037,30086.90062,629.3850932,493.0124224,1619.006211,15470.04969,505.2608696,552.1677019,1780.21118,22196.74534,1173.086957,5575.341615,2998.826087,8482.645963,1247.84472,361.5652174,2600.931677,16343.36025,2849.124224,135.8074534,459.9751553,19651.5528,421.9006211,124.0434783,5409.559006,14891.17391,1505.695652,768.4906832,2945.341615,13224.32919,606.6521739,274.3291925,4371.236025,8481.627329,781.2732919,405.6645963,1291.024845,7297.360248,609.5465839,159.3975155,2799.006211,5855.913043,1210.024845,155.552795,3138.993789,192.6459627,371.515528,161,16.38777124,12.79229447,0.625030893,0.947058824,0.676470588,1.201494226
+1449,36449.10569,874.2764228,514.6910569,1085.215447,33103.72358,704.8821138,615.1910569,1599.678862,18586.54065,578.4471545,1004.357724,1811.743902,25553.12602,1304.51626,6263.54065,4213.272358,9380.313008,1391.463415,383.5691057,2451.910569,18644.30081,416.3373984,209.5243902,615.101626,21536.93902,505.3170732,130.8780488,4101.869919,16996.67886,1669.780488,938.3414634,2827.48374,14380.00813,616.8902439,300.2601626,1903.715447,11497.73171,1022.634146,454.4065041,1304.654472,9063.97561,673.1829268,176.3943089,4386.841463,7570.337398,1373.605691,150.597561,3279.178862,329.0813008,373.4146341,246,27.06183161,12.67046198,0.88362032,0.845360825,0.683333333,1.439188885
+1450,22090.34328,749.4626866,475.7164179,1072.671642,19059.82836,607.7985075,645.4925373,1545.723881,10937.22388,482.1343284,606.9029851,1767.574627,14798.64925,1202.149254,5384.910448,2485.932836,5489.5,1161.761194,337.9776119,2708.291045,10226.98507,6727.007463,147.8134328,577.8432836,11693.64925,415.5149254,115.1119403,5434.970149,10007.55224,1496.373134,863.7089552,2781.455224,8348.768657,923.761194,254.2238806,5226.201493,6745.552239,853.858209,384.2089552,1291.80597,5085.649254,672.7835821,150.7164179,4308,4250.470149,1195.843284,228.1940299,3157,756.8432836,373.5373134,134,15.50321101,11.85028442,0.644770605,0.887417219,0.644230769,-0.043931967
+1451,17650.37302,727.5079365,517.1984127,1057.142857,15842.8254,582.7936508,554.5,1578.420635,8369.936508,461.3809524,706.6349206,1811.857143,12103.4127,1117.793651,6721.039683,4709.515873,4502.952381,1135.984127,325.9920635,4396.515873,8332.52381,1938.071429,673.2063492,592.9444444,9457.325397,390.6507937,109.4603175,6986.095238,7873.833333,1610.111111,918.1428571,2784.365079,6592.277778,575.984127,250.8412698,12351.46032,5484.285714,1015.18254,376.3492063,1328.769841,4128.563492,827.1825397,151.3730159,4526.103175,3442.373016,1132.087302,267.8888889,3180.18254,785.5634921,371.2460317,126,16.01043326,10.83049804,0.736474764,0.893617021,0.570135747,1.228088145
+1452,31673.2451,803.0098039,492.9607843,1086.235294,25622.77451,645.8039216,865.3627451,1668.656863,15361.57843,507.1862745,770.4509804,1823.54902,22084.48039,1282.029412,6201.803922,3732.911765,7806.166667,1232.431373,356.9705882,4714.117647,14675,2201.313725,117.3137255,847.9705882,16480.05882,422.2843137,120.6470588,5099.745098,14175.76471,1779,830.9803922,2804.941176,11961.19608,632.5294118,272.372549,9377.490196,9773.45098,1027.588235,400.6470588,1315.27451,7077.990196,648.5294118,154.754902,3081.529412,6060.392157,1241.686275,272.3431373,3213.598039,798.9019608,371.5,102,13.37251545,9.945068959,0.668519396,0.944444444,0.653846154,0.84394298
+1453,14353.15254,860.9152542,791.4830508,1141.067797,9138.881356,493.9745763,472,1419.923729,4361.59322,379.5423729,304,1715.966102,7158.491525,992.5847458,3408.669492,1560.042373,2630.432203,994.1440678,294.5254237,2408,4813.525424,341.1949153,1005.788136,381.9661017,5761.872881,329.9491525,101.5169492,3654.754237,4926.067797,1258.084746,672.0762712,2788.347458,3902.889831,495.5423729,214,4770.813559,3041.90678,636.3050847,337.0169492,1267.237288,1866.711864,794.0677966,132.0508475,2452.177966,1794.771186,935.0084746,104.7288136,3094.949153,1000.525424,372.0508475,118,12.85704492,11.94339511,0.370235806,0.959349593,0.698224852,-0.521120014
+1454,28008.99213,846.519685,717.1732283,1182.055118,9726.80315,475.2362205,260.2362205,1380.433071,4357.88189,364.0393701,302.5275591,1670.92126,7118.015748,908.9133858,2952.062992,1214.653543,2587.716535,917.6456693,279.3543307,2485.614173,4732.818898,358.3543307,90.37795276,414.5826772,5644.322835,297.6850394,99.14173228,4002.448819,4557.708661,1152.133858,617.7952756,2768.354331,3583.330709,445.015748,190.9055118,5924.834646,2642.748031,595.3228346,320.6614173,1258.086614,1376.818898,516.3149606,131.2440945,2417.952756,1358.377953,854.8188976,107.1968504,2944.141732,1054.748031,371.9448819,127,14.55036043,11.15716971,0.641889927,0.947761194,0.705555556,1.542999763
+1455,29462.51724,959.2183908,564.5402299,1062.264368,20705.58621,583.091954,601.3908046,1399.436782,11737.11494,484.3678161,1131.482759,1727.045977,16053.34483,1096.804598,7858.494253,3495.724138,5834.114943,1198.977011,333.4022989,2500.126437,11645.81609,344.1494253,592.0229885,545.2413793,13306.88506,923.0804598,116.8045977,4250.597701,10815.3908,1513.54023,812.3793103,2796.494253,9095.068966,565.7471264,249.9310345,1512.275862,7494.701149,866.954023,390.6321839,1296.735632,5790.333333,687.5057471,163.8390805,4203.793103,5015.448276,1187.206897,223.9885057,3196.494253,347.4712644,373.3793103,87,12.3652613,9.104944937,0.676619768,0.966666667,0.669230769,0.632201072
+1456,28038.87619,957.3428571,492.3333333,1070.333333,24713.74286,787.2095238,670.0666667,1519.6,13403.6,596.9428571,549.4095238,1736.466667,19020.3619,1366.704762,4070.257143,2634.285714,6701.933333,1347.638095,382.6095238,2437.171429,12852.26667,502.8285714,1882.819048,549.0190476,15507.46667,445.7428571,131.4285714,1857.209524,12011.14286,1651.057143,750.8761905,2804.666667,10290.15238,837.4666667,277.8952381,1677.895238,8300.257143,936.7619048,439.5714286,1356.057143,6504.72381,1094.238095,179.9619048,4349.371429,5482.504762,1360.857143,357.2,3230.72381,423.9428571,371.8571429,105,12.2599626,11.00044452,0.441490857,0.92920354,0.673076923,0.929916667
+1457,27110.83568,1015.882629,504.286385,1080.065728,23503.10798,766.0140845,423.7840376,1488.29108,12806.86854,591.3474178,410.4225352,1693.239437,18341.47418,1468.375587,1891.295775,1794.215962,6487.788732,1363.652582,402.8826291,2396.962441,11877.19718,426.1643192,318.6244131,433.0892019,14038.99531,391.6384977,136.4178404,2442.638498,11246.58685,1471.225352,744.9389671,2810.422535,9581.41784,789.8403756,286.5305164,1488.58216,7934.126761,846.1267606,465,1313.446009,6207.995305,699.4507042,184.2018779,2182.953052,5332.661972,1465.915493,1115.638498,3135.906103,439.2535211,374.8028169,213,19.50438857,14.30892246,0.679553678,0.938325991,0.622807018,-0.877984829
+1458,28966.98276,785.7931034,489.8103448,1055.603448,25010.7069,650.6206897,1063.655172,1512.896552,14498.51724,499.8448276,1588,1787.103448,20459.7931,1210.465517,4275.982759,2924.344828,7351.155172,1234.086207,343.8965517,2546.189655,14195.82759,444.5344828,348.0172414,1232.103448,16206.7069,397.4310345,539.1034483,2322.862069,13470.68966,1833.637931,649.1724138,2791.413793,11309.46552,780.5344828,250.4482759,3276.224138,9177.982759,1117.534483,399.3448276,1301.568966,7084.103448,690.3965517,162.0172414,3652.551724,6047.017241,1252.603448,814.9482759,3176.982759,640.3793103,370.8448276,58,9.399662097,8.452327137,0.437504827,0.950819672,0.58,0.105399348
+1459,49747.7234,1071.879433,668.5106383,1231.978723,12673.80851,456.6950355,283.0212766,1292.134752,4529.503546,372.5744681,435.6241135,1611.765957,8905.588652,919.4893617,1554.085106,1303.425532,3145.297872,948.4042553,279.2411348,2358.950355,5600.198582,290.2765957,207.8368794,484.1631206,6770.652482,557.2340426,96.40425532,1495.638298,5050.283688,1337.170213,528.3829787,2771.780142,3976.184397,483.8297872,185.6312057,1192.22695,2736.319149,658.7092199,316.5886525,1275.659574,1233.652482,522.8439716,129.248227,916.5886525,1380.007092,843.8652482,96.58156028,2879.425532,1119.801418,373.9148936,141,15.52223843,11.86274075,0.644930024,0.933774834,0.677884615,-0.018554939
+1460,22118.61111,732.9027778,535.8194444,1113.861111,19569.70833,589.4444444,447.7916667,1643.097222,10175.59722,492.5555556,608.8333333,1811.208333,14505.47222,1114.736111,7752.569444,3264,5587.902778,1165.319444,343.75,2630.597222,10732.22222,652.0694444,138.75,423.375,12561.13889,398.6805556,120.4861111,7608.694444,9449.027778,1379.430556,689.2916667,2817.319444,8306.819444,560,263.0138889,11349.36111,5237.263889,740.9583333,392.5,1295.25,4455.861111,605.1111111,158.4583333,3568.347222,3564.013889,1117.305556,222.1805556,3153.861111,181.0694444,373.9444444,72,10.80890569,9.985373364,0.382851658,0.86746988,0.5,1.262546745
+1461,36317.07143,838.1984127,519.7777778,1130.119048,32422.02381,673.1666667,444.7936508,1664.111111,18068.51587,549.5793651,646.8253968,1822.492063,25046.65079,1261.714286,5082.634921,4693.722222,9406.150794,1340.246032,382.7539683,2441.761905,18077.57143,2398.174603,129.8888889,434.4603175,22051.47619,860.3095238,132.2539683,4587.214286,17323.79365,1453.492063,830.1269841,2826.420635,14927.53175,813.0396825,290.6507937,1967.896825,10995.6746,939.0555556,438.9206349,1299.666667,8771.277778,637.7460317,174.484127,2913.079365,7106.873016,1301.373016,126.2222222,3206.063492,249.2698413,374.0634921,126,15.93567865,10.3186923,0.762047301,0.919708029,0.642857143,-0.579576429
+1462,49294.20455,939.9545455,519.1818182,1139.5,44113.38636,760.4772727,835.7727273,1674.818182,25544.47727,614.5454545,551.6136364,1753.363636,35660.13636,1381.295455,4982.522727,3924.681818,12734,1507.181818,423.9318182,2462.386364,24909.31818,447.8181818,277.6136364,532.2045455,29829,448.9318182,146.5,4887.477273,24698.79545,1595.295455,816.0909091,2844.863636,21029.02273,631.2045455,325.2954545,1725.590909,16125.36364,931.8409091,501.3181818,1315.022727,12337.20455,708.9318182,183.8409091,3496.068182,10829.29545,1459.022727,136.5454545,3301.159091,275.2727273,371.3181818,44,8.675794552,6.530539355,0.658328237,0.936170213,0.785714286,-1.1920721
+1463,17774.70115,814.5517241,439.8505747,1045.724138,15348.71264,626.6666667,384.091954,1486.16092,8632.908046,509.2183908,474.6781609,1736.045977,12268.63218,1201.54023,6431.390805,3107.08046,4521.252874,1269.16092,364.4137931,2398.908046,7773.218391,377.7011494,1512.597701,511.0804598,8728.045977,406.8390805,123.0114943,2657.701149,6987.149425,1702.701149,852.2528736,2804.632184,5883.942529,762.2873563,253.1264368,1574.482759,4872.241379,832.4137931,413.2413793,1333.494253,3928.206897,1006.16092,172.0804598,5081.287356,3331.965517,1279.574713,1204.367816,3134.206897,357.8735632,373.8965517,87,13.20020837,8.557776592,0.761379737,0.966666667,0.621428571,-0.395155555
+1464,23395.05263,769.1578947,514.0921053,1056.197368,20895.55263,644.8552632,523.4342105,1493.236842,11358.94737,493.1315789,863.3552632,1857.473684,16093.23684,1232.552632,5780.657895,4074.894737,5964.907895,1217.131579,347.2236842,2579.236842,11518.36842,576.3684211,1694.039474,845.4605263,13350.52632,471.1052632,123.3552632,3713.934211,10633.90789,1715.710526,767.7236842,2787.565789,9359.078947,697.3947368,257.1315789,2304.184211,7585.131579,1108.565789,392.6184211,1323.605263,5970.026316,1080.131579,159,6971.565789,4976.789474,1254.631579,386.5131579,3138.263158,606.4473684,374.3026316,76,12.42628065,9.283486252,0.664728666,0.8,0.487179487,-0.959774994
+1465,28067.91979,735.9839572,444.1390374,1052.679144,24846.04278,639.0320856,510.0320856,1499.989305,14247.83422,489.7700535,801.4385027,1762.213904,19663.30481,1208.096257,4761.935829,2553.71123,7134.850267,1214.529412,365.3368984,2585.508021,13854.22995,428.3101604,469.7807487,861.8074866,15872.43316,380.1283422,174.855615,2581.668449,13118.28342,1646.139037,658.2780749,2841.855615,11183,848.9946524,255.3529412,2530.475936,9162.042781,1064.40107,390.5187166,1303.566845,6960.57754,723,147.0213904,2913.700535,6021.048128,1259.721925,1182.55615,3150.262032,653.4438503,374.4278075,187,19.87408652,12.10158458,0.793237208,0.954081633,0.719230769,1.5116189
+1466,47560.88961,942.8636364,547.7337662,1171.201299,17327.18182,500.987013,304.4220779,1355.87013,6450.967532,389.5844156,529.6103896,1640.25974,12420.37013,990.2272727,3729.941558,1830.012987,4461.077922,996.6753247,290.8766234,2518.116883,8107.727273,555.9220779,406.6168831,563.5649351,10169.70779,322.8376623,105.9415584,2843.701299,7492.025974,1515.688312,536.1038961,2795.006494,5762.396104,532.5064935,204.4805195,1811.227273,4151.487013,773.7727273,336.0194805,1277.37013,1884.071429,590.2727273,131.8441558,1545.746753,2073.415584,906.7597403,295.9935065,2984.75974,1108.38961,375.3441558,154,17.24875268,12.33202242,0.699174002,0.927710843,0.603921569,0.632236746
+1467,27019.30357,818.0357143,588.4285714,1152.625,26020.60714,646.4464286,496.2321429,1689.178571,13165.76786,525.0892857,528.625,1801.642857,18806.85714,1219.625,8055.285714,7199.428571,7117.75,1283.75,379.7678571,2391.464286,13543.03571,6837.589286,136.0892857,456.3392857,16246.125,484.4107143,131.375,8147.892857,12437.85714,1404.910714,1011.160714,2823.285714,10742.30357,637.1607143,283.1785714,5504.875,7376.946429,788.625,421.875,1314.910714,6240.410714,611.6071429,161.5178571,3668.232143,4868.160714,1258.035714,196.5,3224.071429,206.625,372.125,56,11.39105879,6.526938224,0.819563866,0.903225806,0.666666667,1.51288832
+1468,48277.80488,909.6585366,490.0243902,1152.463415,43062.39024,747.6097561,500.8292683,1703.878049,24256.09756,594.9268293,495.2439024,1793.073171,33876.5122,1367.609756,4859.756098,3577.829268,12235.68293,1448.97561,405.3658537,2405.853659,24305.46341,438.2439024,142.5121951,422.7560976,28758.56098,420.4390244,142.4878049,3438.073171,23054.80488,1509.317073,773.9268293,2805.121951,19673.95122,622.6341463,319.195122,1903.341463,15300.7561,874.902439,486.5365854,1294.414634,11789.70732,667.6341463,174.5121951,3630.195122,10174.21951,1445.878049,117.2682927,3225.317073,287.7804878,372.4878049,41,8.087666828,6.659795901,0.567387648,0.953488372,0.569444444,-1.46607047
+1469,24276.80921,801.9868421,589.0460526,1133.947368,19845.36184,654.2302632,741.5328947,1834.638158,10625.25658,478.8486842,1606.888158,1846.605263,16036.75658,1220.756579,7380.572368,3301.138158,5704.894737,1191.684211,388.9342105,7052.276316,10814.46711,1231.559211,1383.703947,1045.243421,12683.55921,408.6447368,119.8026316,6142.381579,10759.91447,1848.921053,868.1644737,2814.703947,8669.085526,635.8618421,299.625,31383.81579,6893.072368,1273.552632,412.3684211,1435.776316,4734.664474,1266.973684,176.7039474,7554.276316,4286.375,1208.375,277.4671053,3213.085526,928.1052632,375.9078947,152,16.79697917,11.79076569,0.712218824,0.962025316,0.562962963,-1.066006791
+1470,19152.06475,799.1438849,444.0791367,1029.079137,18544.38849,647.7913669,528.1223022,1444.201439,9904.791367,528.8201439,1256.388489,1768.338129,13839.43165,1228.906475,3647.604317,3282.625899,5184.330935,1378.352518,377.352518,2422.582734,8301.071942,368.5251799,685.2230216,620.3381295,9768.748201,389.1294964,124.971223,1938.100719,7438.014388,1473.381295,769.1151079,2796.705036,6417.798561,667.4676259,256.0647482,1444.992806,5193.928058,1320.489209,419.3597122,1352.374101,4243.942446,809.7482014,170.1438849,3920.438849,3608.302158,1334.302158,2128.625899,3144.899281,375.6834532,376.3165468,139,14.09315665,12.74275932,0.427150302,0.945578231,0.661904762,1.439283685
+1471,29533.2,972.5857143,524.5214286,1063.371429,26127,729.05,689.3571429,1476.507143,13670.15714,580.0428571,856.3928571,1786.585714,19658.13571,1305.971429,5340.657143,3255.207143,6925.05,1278.471429,387.5357143,2486.707143,11309.14286,362.7642857,1281.035714,688.6785714,13189.10714,379.6571429,239.5714286,3173.107143,10226.92143,1695.821429,786.7,2798.664286,8956.05,547.05,250.1428571,1620.357143,7158.264286,935.2428571,405.95,1371.628571,5688.935714,910.5,160.3214286,4082.457143,4817.571429,1213.621429,174.9071429,3143.185714,475.6285714,378.7428571,140,16.80553387,11.00753687,0.755633407,0.933333333,0.598290598,0.416060218
+1472,37614.07895,892.9097744,540.3721805,1135.609023,32571.16917,744.018797,710.7255639,1644.81203,18901.57143,589.6541353,713.8646617,1792.736842,26434.21053,1405.101504,4809.849624,3408.481203,9366.003759,1412.387218,400.518797,2724.330827,17915.23684,712.7706767,241.6466165,724.387218,20958.17293,455.6015038,135.7969925,3306.699248,16634.73308,1767.917293,880.093985,2821.112782,14411.70301,661.962406,306.481203,1997.409774,11525.14662,985.7744361,474.7330827,1313.609023,8776.642857,702.7894737,182.4774436,4829.041353,7522.353383,1432.924812,277.2744361,3262.135338,538.5639098,380.5150376,266,21.78624053,17.35079688,0.604756037,0.820987654,0.550724638,1.519860167
+1473,22750.5102,848.4489796,471.0816327,1030.959184,19452.53061,661.2244898,495.0816327,1420.795918,11067.69388,517.1428571,414.5102041,1720.938776,15380.57143,1194.755102,5571.979592,2677.734694,5598.183673,1165.367347,339.5510204,2481.265306,10806.61224,409.8571429,625.2857143,487.2040816,12291.71429,349.6734694,108.7142857,3857.897959,10057.18367,1364.306122,628.1020408,2812.816327,8457.367347,632.0408163,227.2653061,2304.836735,6935,723.6938776,361.5306122,1276.77551,5311.897959,736.5102041,142.6530612,3360.612245,4469.693878,1181.020408,1194.163265,3189.673469,669.0612245,374.3061224,49,8.846703026,7.307597765,0.563633497,1,0.680555556,1.463845695
+1474,46738.66327,899.5612245,474.622449,1137.173469,39986.36735,732.6836735,530.1428571,1683.806122,23365.16327,564.4489796,392.9081633,1777.908163,32424.30612,1395.102041,5262.030612,3550.653061,11858.54082,1355.94898,382.4387755,2448.632653,23097.72449,525.0510204,117.0306122,462.7959184,26514.38776,407.9081633,131.5816327,3360.561224,21559.39796,1455.55102,650.5510204,2793.94898,18414,679.1122449,293.6428571,1895.785714,14986.73469,858.3265306,443.7959184,1301.071429,11028.13265,648.4795918,166.3877551,2571.020408,9313.622449,1428.959184,1289.55102,3246.163265,710.8469388,374.0408163,98,15.54396794,8.188088037,0.85000818,0.933333333,0.680555556,1.537465586
+1475,17219.06818,744.530303,526.4469697,1059.454545,14744.30303,591.719697,716.1893939,1551.113636,8298.878788,478.8257576,473.4772727,1743.393939,11731.18182,1137.69697,7692.212121,3406.113636,4234.530303,1130.280303,329.6666667,2582.05303,8003.143939,2812.174242,882.75,457.6287879,9264.848485,402.0681818,113.2878788,7911.280303,7773.666667,1499.431818,960.9621212,2780.833333,6487.310606,643.8030303,250.8106061,11205.36364,5455.371212,834.3939394,378.1060606,1341.636364,3998.371212,946.5378788,152.0075758,5220.068182,3501.310606,1158.969697,245.1818182,3246.833333,776.9545455,378.4621212,132,13.8670127,12.91516392,0.364102784,0.936170213,0.515625,-0.602867699
+1476,23150.0431,715.2327586,477.0172414,1056.672414,19065.21552,597.1551724,616.1465517,1579.62931,10809.73276,462.3965517,589.9224138,1771.646552,15736.34483,1137,6872.284483,4305.112069,5586.439655,1145.62931,333.4655172,3518.603448,10216.75862,4543.362069,523.2327586,573.0086207,11762.15517,422.2672414,115.5086207,8415.62069,9697.12069,1425.775862,959.1724138,2784.939655,8038.818966,583.887931,242.112069,8989.344828,6597.836207,798.3275862,375.3275862,1328.646552,4778.87069,881.5862069,151.3706897,3884.017241,3999.646552,1130.241379,180.8706897,3139.12931,819.1206897,376.0775862,116,13.43387724,11.13064363,0.55991457,0.974789916,0.69047619,-1.555956591
+1477,48735.29688,894.984375,520.359375,1139.921875,44690.79688,768.1875,831.59375,1794.609375,24356.35938,597.953125,1023.78125,1873.484375,34118.92188,1347.234375,6310.65625,3543.953125,12591.89063,1450.859375,402.671875,2543.203125,24327.78125,575.765625,129.828125,953.28125,29697.17188,436.015625,311.734375,3492.453125,23402.90625,1694.8125,663.015625,2872.328125,20211.28125,626.578125,325.796875,3792.21875,14257.34375,886.3125,467.3125,1297.21875,11533.375,659.65625,184.390625,2732.609375,9464.703125,1384.734375,213.375,3331.65625,217.390625,375.140625,64,10.83855744,7.666019841,0.706921987,0.927536232,0.646464646,-1.285007649
+1478,22382.91667,733.21875,455.28125,1058.34375,19619.15625,600.4895833,415.625,1487.854167,11138.90625,469.7604167,413.6979167,1731.427083,15779.46875,1223.135417,4509.9375,2494.03125,5776.208333,1190.708333,334.96875,2419.427083,11253.20833,467.7395833,1267.208333,467.1979167,13255.94792,388.0520833,109.0729167,3171.833333,10444.59375,1406.104167,728.0208333,2795.572917,9120.791667,679.1770833,257.7604167,2463.479167,7587.333333,766.34375,383.0520833,1341.947917,5848.072917,960.0833333,151.46875,5423.90625,4863.989583,1218.895833,278.9375,3147.864583,614.9895833,376.59375,96,17.03434247,7.584335758,0.895412288,0.905660377,0.5,-0.912797851
+1479,41672.19328,885.697479,542.9453782,1132.563025,37992.72269,715.0756303,640.3865546,1678.39916,21070.65546,589.487395,478.487395,1765.109244,29534.05042,1321.668067,6793.542017,4780.327731,10705.98319,1421.735294,399.3067227,2413.752101,21387.60084,606.0882353,166,455.7184874,25255.97899,434.4117647,136.8109244,4838.810924,20068.91597,1506.97479,961.3739496,2828.743697,17203.57563,617.6218487,315.105042,2300.264706,13294.61765,872.5462185,477.0798319,1311.718487,10430.53361,661.012605,183.394958,3226.684874,8798.205882,1408.310924,133.1302521,3272.189076,285.4663866,381.1134454,238,21.15075938,15.91736657,0.658515523,0.820689655,0.574879227,-1.463377427
+1480,35697.16814,1080.035398,662.5486726,1161.646018,31351.22124,816.8230088,666.3628319,1670.646018,17801.9292,644.5575221,580.6637168,1768.637168,24193.9823,1536.477876,6088.274336,3822.247788,8859.292035,1545.530973,437.9557522,2432.353982,17038.35398,474.2123894,198.3451327,450.9469027,20249.34513,534.8318584,150.460177,4103.061947,15964.99115,1577.911504,876.8584071,2824.176991,13522.40708,783.5840708,318.6637168,2669.787611,10723.69027,946.1504425,497.9380531,1314.80531,8571.734513,718.7787611,189.8053097,2620.247788,7216.123894,1638.327434,299.6637168,3394.955752,314.5044248,379.300885,113,13.29286848,11.17564647,0.541462393,0.941666667,0.620879121,0.328919944
+1481,23795.08696,1011.721739,505.1217391,1064.808696,21084.77391,769.2521739,688.7304348,1506.765217,11769.28696,592.5304348,828.4521739,1752.66087,16671.10435,1318.669565,2786.626087,2236.408696,5903.269565,1346.165217,373.1130435,2437.026087,11581.27826,2609.156522,515.9217391,474.6782609,13814.30435,438.0086957,126.2347826,2241.217391,11083.76522,1554.582609,712.6521739,2800.669565,9565.782609,778.626087,289.5826087,1637.626087,7636.582609,907.8521739,443.4869565,1344.443478,5918.13913,738.3130435,168.0782609,4539.295652,5155.643478,1311.06087,195.9217391,3342.286957,419.3043478,380.026087,115,16.85407377,9.359225039,0.831643858,0.858208955,0.547619048,0.910423528
+1482,32750.35262,916.7190083,556.9283747,1112.176309,29561.52342,717.9311295,546.8099174,1617.435262,16640.15978,594.969697,817.1267218,1780.862259,23602.91185,1354.53719,5402.358127,3524.066116,8068.424242,1347.796143,369.5730028,2651.118457,16328.59504,467.7548209,536.2534435,782.9724518,19114.28375,441.1322314,129.2203857,3479.338843,14900.76584,1746.754821,855.3443526,2810.84022,13101.92562,646.6115702,292.5674931,1941.044077,10503.44353,1020.876033,444.9090909,1334.07438,8120.077135,763.6198347,170.9063361,3033.022039,6744.231405,1350.553719,347.0826446,3282.311295,573.9283747,383.5289256,363,23.6389623,20.2407513,0.516569375,0.883211679,0.686200378,1.061689992
+1483,17585.70755,724.7830189,485.3584906,1026.54717,15939.66981,616.6037736,437.4528302,1417.396226,8567.490566,473.6037736,445.9528302,1756.254717,12575.56604,1184.632075,5717.207547,3213.018868,4641.160377,1172.150943,418.2264151,2460.141509,8793.066038,420.4056604,1616.849057,515.6037736,10022.19811,401.4245283,115.8679245,2965.622642,8235.226415,1497.5,829.5471698,2782.518868,7052.037736,691.9811321,241.6320755,2661.603774,5715.481132,766.9150943,370.7924528,1320.188679,4535.349057,1056.792453,150.3867925,5084.839623,3725.245283,1201.462264,527.9622642,3137.443396,633.7924528,377.5377358,106,12.8883374,11.0798767,0.510828923,0.954954955,0.627218935,0.253949708
+1484,35841.48113,821.1603774,458.1226415,1093.367925,30756.84906,664.254717,798.6698113,1559.933962,17966.03774,522.0566038,1367.330189,1781.518868,25834.37736,1273.254717,4721.188679,2806.188679,9172.726415,1262.377358,358.4339623,3785.556604,17824,1073.084906,134.7830189,1452.150943,20096.71698,408.509434,1093.924528,1863.292453,16790.79245,1897.254717,586.6886792,2811.330189,14329.92453,653.3867925,263.1226415,1979.283019,11679.83962,1048.40566,406.9811321,1288.396226,8638.415094,618.0660377,160.5283019,3387.018868,7376.018868,1336.971698,2439.339623,3168.764151,730.9245283,377.5849057,106,12.26877657,11.55082619,0.337064656,0.905982906,0.630952381,0.973672144
+1485,19934.34132,746.005988,564.7245509,1077.622754,16665.16168,608.0838323,521.748503,1654.886228,8562.868263,452,463.7365269,1796.185629,13147.69461,1204.964072,5051.508982,3269.796407,4830.42515,1142.892216,355.6946108,2480.658683,8859.407186,490.6526946,3464.125749,473.8263473,10399.92216,393.9101796,117.0239521,5746.718563,8750.934132,1519.155689,1016.658683,2804.353293,6947.520958,554.8682635,261.2874251,19601.52695,5447.844311,872.3173653,383.2814371,1371.754491,3561.39521,1501.179641,151.4251497,7260.401198,3218.269461,1129.317365,217.9700599,3171.700599,975.0359281,379.245509,167,17.22010899,12.49541888,0.688085638,0.948863636,0.695833333,-0.683300863
+1486,19383.69492,783.8389831,648.6271186,1147.788136,16012.83051,651.7966102,510.0423729,1849.228814,7985.245763,463.7372881,466.5254237,1804.440678,12583.76271,1247.779661,8338.79661,3403.711864,4662.355932,1169.966102,351.0677966,2528.728814,8387.305085,536.9237288,1213.449153,462.3898305,9890.991525,435.9237288,120.1949153,9402.923729,8394.313559,1400.90678,1106.322034,2824.398305,6734.305085,553.7288136,274.8813559,26110.81356,5141.542373,1206.627119,393.5508475,1353.864407,3264.211864,1092.5,159.6864407,9062.813559,2989.652542,1130.745763,198.2966102,3207.610169,987.1779661,378.3559322,118,15.85402545,9.898511468,0.781142167,0.944,0.605128205,-0.630056457
+1487,43702.03817,1141.29771,585.7709924,1118.183206,37780.19847,827.5343511,693.4045802,1741.664122,20673.44275,649.9007634,876.480916,1790.473282,29182.20611,1487.709924,4720.450382,3442.374046,10117.14504,1463.931298,405.2366412,2488.175573,19510.19084,763.9770992,290.6717557,652.7251908,22824.0687,581.5877863,136.7022901,4394.603053,17897.37405,1696.961832,785.129771,2818.282443,15396.51908,651.1832061,304.8625954,1642.290076,12314.50382,1062.603053,464.9160305,1320.862595,9381.312977,702.2137405,177.2061069,3151.59542,8253.89313,1439.763359,173.2137405,3471.603053,397.1603053,377.7633588,131,18.18786047,9.318040537,0.858793454,0.916083916,0.626794258,-1.446347617
+1488,24149.04959,871.2975207,501.231405,1046.983471,22166.72727,673.768595,434.5619835,1450.760331,11701.14876,532.9504132,520.8347107,1734.818182,17380.80992,1283.68595,4444.289256,3795.404959,5994.619835,1289.07438,362.6363636,2609.694215,11287.01653,391.3553719,462.4628099,520.6198347,13297.4876,437.4132231,127.0661157,4904.38843,10903.86777,1484.950413,893.6363636,2806.330579,9213.619835,592,264.9669421,1932.31405,7545.041322,873.8677686,422.5123967,1304.859504,5863.297521,700.2644628,177.4049587,6737.867769,5040.14876,1334.933884,422.6942149,3179.958678,449.1652893,379.9173554,121,17.12349665,9.471564079,0.833093234,0.930769231,0.504166667,-0.775495171
+1489,28060.52273,942.9431818,633.1931818,1120.670455,24509.18182,725.0909091,916.125,1607.852273,13473.20455,587.0568182,1759.840909,1792.25,18599.51136,1353.340909,4823.761364,3761.818182,6925.306818,1365.090909,384.6590909,3067.477273,11746.79545,661.375,382.8295455,467.3068182,14006.69318,459.3977273,132.2840909,6118.5,10775.05682,2436.284091,752.7954545,2824.465909,9296.295455,1070.318182,276.9204545,1940.295455,7400.965909,1032.363636,447.1022727,1327.034091,5903.909091,1094.420455,176.1022727,4244.488636,4876.477273,1339.772727,660.6818182,3305.75,507.875,378.3636364,88,11.75794439,9.923504945,0.536369956,0.956521739,0.564102564,0.927320153
+1490,22281.85417,741.3333333,548.5208333,1044,18678.33333,618.5208333,545.2083333,1484.541667,11262.6875,462.8333333,411.8958333,1757.208333,15891.27083,1346.645833,5734.3125,3372.979167,5728.041667,1188.729167,325.6458333,2457.416667,11173.91667,442.5833333,566.3958333,447.7708333,12942.10417,409.3333333,108.6458333,4721.291667,10710.0625,1343.854167,1055.125,2791.3125,9256.458333,764.1666667,238.8541667,2265.3125,7624.25,767.0208333,380.1041667,1299.5625,5785.833333,756.25,160.875,5384.895833,5116.8125,1219.875,447.5625,3179.1875,625.0208333,377.0625,48,9.102495901,6.909543444,0.650994681,0.941176471,0.666666667,0.235892351
+1491,29401.93333,797.8333333,491.5583333,1077.533333,25233.01667,637.0583333,701.6333333,1635.275,14058.10833,524.925,1204.075,1744.066667,19581.04167,1198.616667,6077.391667,3328.883333,7152.558333,1185.975,363.1583333,4678.65,13090.30833,1255.325,252.8083333,451.4166667,15517.60833,389.2833333,118.4916667,4546.7,12864.79167,1758.841667,739.8583333,2805.9,10511.35,551.2833333,278.7333333,13297.575,8537.325,1037.05,388.55,1356.891667,5910.958333,670.0166667,178.8,3590.475,5062.716667,1179.008333,199.6833333,3229.841667,851.4416667,378.1166667,120,14.47569765,10.78495659,0.667021115,0.952380952,0.727272727,-1.569103983
+1492,21768.72289,795.5542169,639.5662651,1124.325301,18471.66265,618.5060241,505.4578313,1655.807229,10165.04819,484.6506024,704.3975904,1817.626506,14913.51807,1182.13253,7661.120482,5300.554217,5405.554217,1149.807229,326.686747,4323.783133,9952.843373,662.4578313,136.5301205,565.0361446,11996.72289,390.686747,121.3373494,6691.060241,9827.385542,1659.783133,839.4939759,2788.39759,8108.987952,601.939759,270.6746988,24882.53012,6683.120482,1063.204819,392.9879518,1337.831325,4708.481928,654.6024096,147.1084337,5631.361446,4092.987952,1167.361446,209.4819277,3201.493976,889.4698795,377.7108434,83,11.91334068,9.183380151,0.637018581,0.943181818,0.691666667,1.067207033
+1493,21433.08525,783.9606557,581.1770492,1116.563934,18497.86885,633.2688525,721.1672131,1755.203279,9510.140984,471.4622951,958.9245902,1817.537705,15014.21639,1205.239344,5261.790164,2883.12459,5400.380328,1209.262295,350.4786885,3053.019672,10250.86557,575.0327869,1646.622951,843.2098361,12129.20984,424.0032787,119.3639344,3995.681967,10075.38361,1544.331148,840.9934426,2835.64918,8285.02623,570.252459,281.304918,18442.2623,6563.111475,1004.629508,396.6295082,1355.681967,4429.268852,1099.560656,155.6459016,6485.177049,3960.62623,1190.04918,202.9967213,3195.583607,958.7770492,382.8754098,305,24.12967945,16.27489693,0.738296498,0.953125,0.693181818,0.668428286
+1494,27289.96296,797.962963,540.7242798,1131.703704,17276.14403,539.2962963,367.7078189,1629.164609,8212.312757,450.8930041,442.9012346,1761.777778,11746.39506,1017.658436,3457.300412,1823.037037,4439.584362,1073.26749,315.7119342,2501.386831,8609.707819,4839.613169,380.4320988,405.5473251,9883.979424,391.308642,106.3580247,5374.683128,7396.971193,1318.625514,529.3744856,2879.765432,6204.057613,678.5720165,228.8765432,5362.740741,3420.576132,671.3497942,357.090535,1274.72428,2893.259259,622.4403292,144.3744856,1871.209877,2363.090535,1003.786008,158.3497942,3043.938272,160.0864198,382.9341564,243,23.91145571,14.0277477,0.809837794,0.89010989,0.578571429,-1.025437972
+1495,32049.97516,804.8757764,592.9565217,1113.73913,29404.29193,658.689441,880.5403727,1651.322981,15353.41615,535.0745342,1353.279503,1815.012422,22501.6646,1210.84472,7330.521739,6226.024845,8352.763975,1301.31677,378.5341615,2750.888199,16009.1118,565.0496894,746.8819876,729.7763975,19172.98137,1559.52795,130.6459627,6621.956522,15035.6087,1514.981366,956.0621118,2817.043478,13026.56522,589.8198758,287.1677019,5599.273292,8857.981366,1130.689441,431.9627329,1323.987578,7432.875776,775.7329193,174.242236,4398.490683,5950.254658,1263.229814,274.2236025,3200.31677,206.2484472,381.1304348,161,17.92863352,11.9870499,0.743623972,0.879781421,0.596296296,1.138171482
+1496,38951.94118,828.8431373,469.2941176,1099.235294,34743.35294,730.7843137,941.9803922,1569.852941,19449.92157,557.1666667,1823.264706,1840.156863,27156.87255,1363.529412,4921.156863,3098.421569,9793.284314,1341.77451,369.9901961,2562.754902,19575.16667,589.6568627,486,1563.764706,22867.58824,474.0588235,554.7745098,1856.352941,17969.97059,1811.323529,689.8137255,2794.578431,15698.35294,730.2843137,288.745098,1679.656863,12736.2451,1101.470588,435.9411765,1318.029412,9848.313725,759.7254902,169.4019608,3206.578431,8170.54902,1373.568627,524.6862745,3189.911765,592.5588235,379.5294118,102,16.38239648,8.151677261,0.867413734,0.935779817,0.618181818,-1.213110431
+1497,25774.16667,782.316092,491.8448276,1098.310345,16431.88506,478.3275862,498.1494253,1370.494253,6446.224138,375.0574713,793.7298851,1649.666667,11796.32184,954.816092,3750.574713,1102.54023,4325.201149,969.4195402,284.6436782,2956.16092,7782.977011,3614.614943,87.67816092,525.2413793,9567.701149,331.4137931,100.2183908,3066.522989,7235.356322,1365.982759,538.316092,2791.011494,5579.005747,558.5689655,203.4655172,1342.551724,4067.666667,735.6091954,324.2643678,1262.454023,1894.166667,507.7988506,131.8333333,908.1034483,2016.701149,888.2873563,133.1724138,2942.977011,1091.373563,381.2068966,174,16.93498024,13.51504975,0.602584294,0.950819672,0.682352941,-0.259077052
+1498,42942.12217,925.1900452,585.6696833,1141.58371,39550.19457,722.6606335,575.5384615,1697.475113,22148.61538,608.5475113,479.4162896,1786.239819,30593.41629,1344.760181,7374.687783,6249.153846,11294.42534,1445.230769,411.9321267,2405.158371,22181.86878,468.2941176,174.760181,438.7556561,26544.82805,430.6063348,136.9547511,5559.054299,21168.25339,1530.058824,942.6832579,2824.895928,18055.59276,628.2850679,322.959276,2346.140271,13684.23529,907.4298643,469.3891403,1312.606335,10886.19457,695.4208145,181.2579186,3275.737557,8970.615385,1419.031674,124.1085973,3302.533937,264.9276018,382.0497738,221,27.02179439,10.54434863,0.920723153,0.917012448,0.566666667,-1.196874705
+1499,21353.03947,798.5592105,445.9078947,1039.828947,20318.42105,668.9736842,456.5328947,1513.25,11354.03289,523.6315789,918.5526316,1743.381579,15999.38816,1238.815789,4740.138158,2913.493421,5789.796053,1630.289474,364.6973684,2414.138158,10727.80921,384.0723684,646.4078947,1155.506579,12241.65789,399.6973684,207.0526316,2548.960526,9550.171053,1706.598684,782.2828947,2849.493421,8131.065789,727.8355263,267.0723684,1527.960526,6659.717105,1012.822368,426.8223684,1368.717105,5373.072368,743.6842105,171.1907895,5032.921053,4488.335526,1306.118421,1130.184211,3143.756579,364.2631579,382.6381579,152,14.54305511,13.65483556,0.344122305,0.95,0.59375,-0.536469569
+1500,35023.94615,852.2615385,526.5846154,1083.484615,32302.96154,702.9076923,579.1923077,1532.761538,17648.86154,713.2846154,477.8230769,1786.176923,25222.75385,1346.276923,5199.184615,2746.653846,9149.338462,1492.646154,424.1769231,2521.876923,17122.19231,450.8307692,535.9692308,490.9,20326.98462,414.9769231,127.6461538,2467.530769,15774.86154,1631.661538,991.4076923,2806.569231,13572.9,653.4538462,289.2230769,1934.276923,10914.05385,881.1307692,459.4307692,1364.3,8547.230769,785.0692308,174.6615385,3784.823077,7085.353846,1368.469231,420.3384615,3313.269231,556.5153846,381.8384615,130,14.17571343,12.03763972,0.528114024,0.935251799,0.714285714,0.362017943
+1501,38590.77536,846.0797101,472.0362319,1098.355072,33481.13768,777.4347826,851.5942029,1648.811594,19365.7971,547.2173913,1108.57971,1840.688406,27345.84058,1340.601449,5444.050725,2618.666667,9807.036232,1313.847826,370.557971,2503.463768,18847.21739,6801.905797,165.2463768,1652.695652,22039.11594,436.4057971,1372.326087,2717.478261,17836.76812,1664.884058,720.3550725,2825.905797,15222.08696,641.615942,283.1086957,1941.514493,12367.85507,910.384058,419.0144928,1298.601449,9363.26087,651.7826087,162.7826087,3738.753623,7814.391304,1372.637681,1204.594203,3238.442029,693.8188406,379.6449275,138,18.21200502,10.94575423,0.799235016,0.884615385,0.575,1.559235882
+1502,27399.38182,745.1454545,428.6181818,1086.054545,23210.94545,608.7272727,410.1454545,1551.618182,13432.43636,474.6545455,455.6181818,1763.181818,18800.54545,1168.8,3061.818182,1968.781818,6823.509091,1207.563636,335.7454545,2884.745455,12993.72727,6165.090909,174.7636364,492.6,14656.81818,410.8363636,118.9454545,2921.890909,12430.87273,1362.763636,645.7090909,2798.127273,10541.67273,562.9090909,254.9818182,10133.38182,8608.781818,818.3818182,397.0363636,1314,6414.472727,678.3818182,157.5818182,2439.218182,5420.927273,1197.545455,166.5636364,3247.636364,794.8181818,378.7454545,55,11.12548112,6.586753583,0.805907012,0.916666667,0.572916667,1.251072237
+1503,27137.85577,781.8942308,515.1153846,1102.057692,22522.58654,622.7884615,731.875,1663.932692,12695.22115,489.9615385,1082.451923,1775.788462,19163.90385,1205.980769,6530.711538,4042.048077,6934.096154,1195.576923,353.0192308,5181.105769,12776.96154,1159.442308,125.8653846,624.3557692,15268.49038,420.5192308,119.6826923,5764.057692,12527.64423,1769.336538,777.1442308,2803.855769,10348.42308,593.4134615,281.2788462,17904.51923,8415.692308,1065.528846,409.6153846,1364.038462,5967.192308,648,168.5576923,5264.461538,5117.788462,1229.221154,276.6153846,3224.076923,878.1057692,379.9807692,104,16.02101114,9.041995108,0.825512696,0.87394958,0.590909091,1.423357502
+1504,16933.5625,758.9895833,670.4895833,1139.53125,14492.9375,604.3645833,529.1354167,1766.5,7423.125,464.7291667,748.28125,1815.78125,12407.40625,1175.645833,8450.40625,4559.958333,4318.739583,1139.541667,338.34375,4005.5,8049.354167,1004.583333,1055.927083,578.6458333,9120.416667,412.875,119.5729167,10252.13542,7820.5625,1502.125,1258.197917,2779.635417,6300.552083,574.0416667,283.0104167,39635.47917,5103.864583,906.2395833,376.1354167,1391.53125,3437.604167,1139.010417,161.5416667,9963.291667,3120.03125,1158.270833,224.9895833,3210.885417,936.6458333,381.8333333,96,12.43572548,10.62550436,0.519560252,0.96969697,0.571428571,-0.559451627
+1505,35543.36364,788.7121212,513.020202,1106.929293,31768.45455,635.1414141,376.2676768,1695.80303,16737.85859,521.9494949,486.3282828,1764.691919,23383.83838,1182.333333,6208.994949,3795.378788,8775.590909,1267.333333,379.5555556,2856.484848,17423.59596,533.9545455,624.3232323,411.5252525,20469.72727,398.2222222,128.1565657,6220.727273,15697.60101,1532.631313,706.9494949,2804.515152,13728.70707,563.2222222,277.6262626,4441.60101,8589.166667,807.7828283,411.3232323,1292.949495,7220.80303,742.4292929,162.2070707,2630.065657,5821.954545,1215.89899,183.3636364,3181.90404,181.9292929,383.530303,198,21.48362053,12.96053728,0.797533029,0.814814815,0.628571429,-1.412194552
+1506,32912.7006,847.7664671,526.6886228,1110.161677,17849.03593,471.7125749,422.9401198,1326.568862,6760.586826,383.0419162,525.1437126,1647.736527,12880.5988,934.6526946,3777.02994,993.6946108,4569.257485,964.8682635,282.9101796,2767.035928,7979.467066,1212.023952,112.0299401,517.7724551,9684.580838,302.4251497,97.07784431,2057.730539,7490.634731,1318.011976,530.988024,2768.311377,5797.107784,498.7904192,196.011976,1746.113772,4072.682635,703.8143713,316.7964072,1251.257485,1860.898204,507.1676647,127.7305389,1052.48503,1995.065868,867.8862275,154.8862275,2935.502994,1103.047904,386.0778443,167,15.55968206,14.85304416,0.297937672,0.917582418,0.579861111,0.726478855
+1507,42356.18519,869.8296296,553.3185185,1118.844444,40094.91852,720.8148148,767.0666667,1673.962963,20982.54074,568.9925926,1141.955556,1860.933333,29883.13333,1297.222222,7632.481481,5911.948148,11116.03704,1397.474074,388.1185185,2876.422222,21505.85185,439.837037,144.0296296,936.9481481,25840,427.0148148,237.1407407,5197.6,20292.4,1860.933333,718.5333333,2826.740741,17743.56296,619.5111111,314.8,3991.807407,12554.31111,1078.251852,451.9851852,1308.044444,10242.20741,649.3481481,173.4222222,3548.962963,8188.044444,1362.57037,231.0666667,3229.488889,221.837037,383.2518519,135,16.25089407,10.85161509,0.744381163,0.918367347,0.703125,-1.170096095
+1508,32784.23913,821.2391304,545.6086957,1107.532609,30918.73913,663.2826087,723.076087,1642.271739,16456.69565,535.6413043,497.1195652,1773.26087,22881.58696,1218.326087,7856.086957,4186.163043,8512.380435,1319.956522,381.423913,2414.130435,16376.94565,556.7391304,201.5978261,436.5,19739.77174,417.1304348,132.8369565,5133.51087,15713.66304,1412.5,735.1847826,2806.836957,13533.42391,600.9456522,292,2734.521739,9773.445652,814.3369565,430.6847826,1295.793478,7815.054348,648.326087,175.1304348,6509.967391,6416.934783,1278.597826,174.923913,3232.402174,234.423913,381.9130435,92,12.0376079,9.713940828,0.590597835,0.989247312,0.836363636,-0.574772704
+1509,37311.73171,913.2357724,586.9105691,1138.357724,33851.36585,727.495935,592.4390244,1683.95935,18409.21951,590.4715447,483.4878049,1749.325203,25783.31707,1357.073171,7586.292683,4882.658537,9431.487805,1411.634146,411.2520325,2403.447154,19039.09756,448.203252,220.203252,556.9674797,22604.60976,455.3658537,136.5691057,3691.495935,17349.2439,1534.138211,965.3658537,2827.512195,15067.0813,675.1544715,317.495935,3728.96748,11602.54472,926.0731707,472.2845528,1310.178862,9358.512195,693.4146341,189.0325203,3300.373984,7758.03252,1416.544715,216.1300813,3327.227642,301.6829268,383.6097561,123,17.00363898,9.713045119,0.820787729,0.872340426,0.602941176,-1.246530792
+1510,35686.18182,843.6545455,464.9818182,1125.4,30378.96364,721.0909091,432.6545455,1638.272727,17964.36364,549.4909091,456.7454545,1754.8,24019.70909,1312.381818,4582.618182,2694.290909,8813.545455,1301.909091,366.4909091,2498.763636,17618.85455,480.5454545,760.9818182,537.8727273,19915.09091,397.1272727,124.1272727,2449.127273,16442.4,1498.018182,743.5818182,2805.4,14099.76364,636.8727273,279,2160.454545,11553.74545,907.5454545,428.4727273,1301.145455,8433.727273,847.2363636,167,3395.072727,7270.945455,1359.418182,1088.581818,3228.563636,667.1272727,380.9454545,55,10.35778517,8.253399326,0.604202884,0.808823529,0.509259259,1.285297989
+1511,36515.24422,850.3267327,466.1386139,1098.326733,31263.60396,712.2013201,597.8415842,1608.957096,18109.0033,537.0726073,459.9768977,1753.993399,25375.41254,1323.310231,4610.653465,3505.683168,9119.178218,1296.745875,369.4488449,2511.686469,18001.64686,513.1320132,123.6171617,501.5247525,20681.0198,407.3531353,128.7689769,3132.023102,16785.64026,1433.425743,729.3630363,2800.254125,14437.88779,640.5181518,274.660066,2442.970297,11701.71947,834.1353135,419.2079208,1297.884488,8682.036304,643.7590759,161.9042904,3939.858086,7373.742574,1384.320132,1918.376238,3190.683168,709.6765677,385.7524752,303,28.7431039,16.29629974,0.823742701,0.772959184,0.52972028,-0.936608282
+1512,28929.27679,786.2321429,487.4821429,1102.620536,25069.04018,634.3660714,508.8660714,1652.852679,14331.23661,493.1875,556.4464286,1802.138393,20077.24107,1187.459821,4733.46875,2922.330357,7124.191964,1189.178571,341.7142857,2911.950893,13632.59375,8263.316964,129.0892857,605.4598214,15784.25,443.6696429,119.9955357,4695.857143,13004.91964,1420.428571,813.6919643,2791.107143,10931.58036,600.9151786,268.1875,11938.77679,8956.910714,803.2991071,393.0982143,1305.263393,6501.147321,713.0178571,154.4241071,3390.96875,5499.59375,1212.419643,179.9866071,3208.669643,810.4330357,386.0133929,224,21.68174413,14.1385566,0.758137277,0.885375494,0.535885167,0.595561798
+1513,21163.3057,723.7409326,494.7875648,1075.07772,17235.34715,563.4093264,345.9067358,1569.80829,8605.435233,432.7927461,371.5803109,1758.46114,13601.7513,1111.067358,6260.512953,2765.782383,4850.450777,1095.264249,316.8393782,2397.797927,8886.937824,738.5284974,722.2590674,431.2020725,10447.49223,384.4974093,117.0466321,7270.507772,8837.150259,1308.497409,786.8031088,2792.11399,6944.290155,515.8704663,255.5647668,9480.932642,5273.65285,710.5492228,373.6580311,1304.854922,3216.274611,838.1709845,153.3782383,3744.186528,2909.42487,1046.145078,158.2124352,3126.010363,995.3056995,385.3264249,193,20.37780335,12.73528687,0.78065776,0.927884615,0.643333333,-1.179488281
+1514,28861.21708,777.8185053,500.5765125,1107.900356,12307.97153,490.7686833,509.5124555,1451.519573,5319.298932,379.7330961,1076.007117,1705.736655,9234.330961,961.9430605,7556.907473,1942.33452,3350.035587,979.6975089,285.227758,3732.743772,6068.402135,540.1316726,95.54092527,1027.199288,7391.633452,322.1992883,105.3451957,8621.679715,5834.651246,1508.053381,593.2206406,2794.558719,4619.373665,474.5017794,212.0711744,7923.014235,3422.590747,777.0711744,337.7046263,1286.188612,1768.572954,540.3096085,137.7437722,2990.085409,1791.508897,913.1957295,192.480427,2987.220641,1059.647687,385.519573,281,21.08644218,17.7436193,0.540303042,0.930463576,0.704260652,0.94190797
+1515,30786.97,889.25,544.83,1100.95,26607.81,728.5,698.93,1599.44,15124.7,556.98,720.92,1817.21,20488.32,1303.79,6452.45,4066.21,7633.4,1338.62,376.23,2587.32,14638.89,449.14,1349.06,666.41,16810.84,451.44,132.06,4958.42,13067.19,1751.08,808.87,2810.44,11244.5,645.47,284.42,1967.57,8983.28,998.24,446,1343.88,6917.99,1167.1,175.7,4468.74,5838.99,1327.44,164.14,3262.41,500.09,383.86,100,12.84721713,10.32791422,0.594760656,0.934579439,0.595238095,1.105789467
+1516,30399.18333,1029.583333,542.925,1088.704167,27287.27917,780.6208333,863.9041667,1580.558333,15181.0125,621.4166667,1410.466667,1787.5125,21172.2875,1354.204167,4811.808333,3236.304167,7660.720833,1388.0125,389.1333333,2963.125,14848.52917,429.1625,1055.966667,1557.479167,16595.41667,553.3166667,208.5416667,3396.870833,13052.33333,2175.091667,767.0375,2800.8625,11224.525,716.2833333,287.8208333,1518.433333,8953.970833,1071.466667,457.4375,1375.3875,6897.070833,859.8958333,178.2166667,5198.9875,5895.979167,1337.466667,207.7,3341,388.4,389.075,240,19.26556157,16.72686873,0.496168275,0.902255639,0.631578947,-0.846453506
+1517,31123.01887,837.4150943,476.1194969,1075.446541,26975.06918,686.7232704,671.4716981,1507.484277,15161.65409,549.5157233,910.7044025,1758.628931,21870.1195,1268.396226,4840.842767,2858.716981,7860.044025,1316.320755,370.0440252,2455.100629,14310.77358,396.8238994,497.5345912,1122.18239,16621.20126,431.9245283,294.1006289,3466.006289,13453.33962,1709.037736,783.2641509,2818.459119,11690.32704,650.3018868,292.6981132,1815.213836,9474.031447,1037.18239,439.3333333,1318.169811,7109.006289,752.9308176,164.1761006,3669.540881,6298.490566,1310.761006,278.7295597,3251.421384,467.5974843,386.7421384,159,16.63538945,13.21939059,0.607061686,0.919075145,0.623529412,1.06509119
+1518,11130.08235,908.8705882,499.8235294,1007.129412,12359.38824,660.4352941,385.7647059,1362.576471,5351.952941,509.8941176,398.0352941,1712.870588,8354.647059,1219.811765,7092.282353,2504.741176,3031.423529,1141.129412,325.4,2403.458824,5677.458824,419.7529412,1630.247059,462.0470588,6619.952941,362.6705882,104.5294118,3525.258824,4936.705882,1468.223529,715.7411765,2794.376471,4223.282353,711.7058824,229.2352941,1731.611765,3529.129412,720.8235294,354.5294118,1333.388235,3013.4,999.8235294,145.9529412,4281.623529,2347.8,1135.788235,274.1411765,3208.152941,620.1529412,385.1058824,85,13.85221054,8.498320619,0.789695311,0.904255319,0.551948052,0.444073812
+1519,27699.75641,762.5576923,486.6923077,1048.352564,24401.33974,632.4551282,531.9102564,1481.384615,13679.94231,517.2115385,492.9423077,1741.019231,19452.57692,1198.602564,5141.032051,3399.782051,7041.596154,1327.525641,364.1602564,2442.038462,13829.98077,428.9551282,921.025641,565.3141026,15870.46795,382.2564103,126.3974359,3828.339744,12727.4359,1463.314103,895.0192308,2796.75,11069.83974,620.2564103,254.4551282,2242.423077,8924.224359,784.3910256,384.6987179,1309.301282,6888.384615,839.8846154,154.2307692,5287.923077,5870.141026,1248.25,369.5705128,3182.653846,637.2307692,388.2179487,156,23.25010187,9.70197702,0.908774525,0.829787234,0.433333333,-0.597083882
+1520,27229.70313,767.359375,466.171875,1059,23913.26563,656.546875,539.5,1536.75,13700.53125,509.09375,407.078125,1738.9375,19930.01563,1243.546875,7155.34375,3305.125,7051.953125,1241.84375,356,2443.140625,14134.95313,483.3125,756.65625,486.8125,16045.0625,381.609375,122.59375,4299.765625,12875.09375,1387.609375,671.109375,2777.84375,11098.14063,653,262.15625,2303.90625,9310.46875,792.828125,403.0625,1308.578125,7029.375,832.8125,161.640625,3527,6023.15625,1349.625,4303.796875,3133.484375,675.4375,383.0625,64,11.46243945,7.347617425,0.767526763,0.914285714,0.646464646,-1.107633214
+1521,19742.90351,824.0789474,494.2894737,1027.280702,15611.05263,596.4649123,484.1491228,1379.868421,9281.245614,481.2631579,429.2280702,1726.429825,13395.92982,1166.947368,4834.719298,2507.385965,4790.070175,1158.210526,338.2105263,2626.219298,9085.263158,561.1315789,1163.473684,500.7105263,10135.54386,346.0701754,110.3684211,3301.491228,8820.140351,1406.605263,607.5175439,2786.517544,7330.22807,563.2105263,244.0614035,8212.763158,6040.289474,897.8596491,374.5087719,1344.894737,4499.333333,971.745614,155.0614035,4039.991228,3828.429825,1138.184211,784.0263158,3226.587719,760.8508772,384.8684211,114,12.92745099,11.58806665,0.443261735,0.926829268,0.674556213,1.537589561
+1522,26067.11795,788.8564103,474.9846154,1117.364103,22463.62051,636.9384615,509.7692308,1691.035897,12796.17949,495.0871795,510.8564103,1775.923077,17202.86154,1212.035897,3868.533333,2529.528205,6340.374359,1179.189744,351.3076923,2531.369231,12057.89744,10441.0359,721.6974359,506.8153846,13733.48718,484.3692308,117.4564103,3536.25641,11503.1641,1419.348718,842.9589744,2796.876923,9746.507692,869.0820513,264.0564103,6419.866667,7937.774359,869.0564103,399.9948718,1325.051282,5828.220513,865.3384615,155.2205128,3969.671795,4947.179487,1230.569231,265.6153846,3224.923077,787.6666667,387.1538462,195,17.81487025,14.40448911,0.588406208,0.890410959,0.637254902,-1.2506771
+1523,41076.38095,910.6349206,717.8571429,1144.793651,39248.01587,724.1904762,482.5079365,1784.047619,19604.60317,581.7142857,568.2539683,1838.492063,28652.90476,1289.793651,8525.793651,6686.68254,10394.74603,1405.634921,467.1904762,2439,20136.79365,452.6507937,2727.634921,473.7142857,23582.60317,551.0634921,130.6031746,8282.873016,18292.66667,1556.746032,1126.571429,2812,15987.01587,596.0634921,304.5873016,8845.587302,9994.031746,897.0793651,425.5396825,1338.365079,8487.142857,1260.349206,174.4603175,5859.968254,6654.095238,1301.507937,222.3174603,3268.904762,196.8412698,385,63,12.02817958,6.923557233,0.817723377,0.940298507,0.525,0.58931041
+1524,27038.125,901.4675926,625.5925926,1092.347222,24258.9213,689.412037,676.0046296,1598.949074,13533.98611,565.2685185,776.0324074,1843.87037,18502.00463,1249.986111,6057.893519,5473.421296,6836.314815,1315.523148,371.0185185,2444.092593,13524.375,396.6435185,192.1018519,542.8703704,15549.09722,450.1527778,126.7361111,5283.546296,12156.33333,1604.388889,1227.685185,2813.967593,10372.61111,601.4583333,279.3055556,2783.416667,8299.277778,973.8935185,438.5555556,1299.402778,6582.023148,650.5462963,175.2407407,5066.078704,5474.606481,1299.75463,137.2824074,3339.916667,327.2638889,386.337963,216,21.72536486,12.92829822,0.803667556,0.927038627,0.675,-1.176989189
+1525,25572.27468,946.3218884,564.72103,1077.317597,22644.55365,692.8369099,573.0944206,1469.875536,12593.5279,576.9012876,859.4248927,1787.004292,17777.97425,1319.171674,3866.407725,2946.175966,6329.695279,1318.2103,379.944206,2539.321888,12335.37339,587.8841202,531.0858369,665.4248927,14413.45494,491.0729614,181.9184549,2698.545064,11242.86266,1764.849785,771.1630901,2818.334764,9681.695279,675.8712446,276.5493562,1594.613734,7835.527897,1057.27897,426.5622318,1328.201717,6230.506438,879.3648069,167.0858369,2897.072961,5112.811159,1308.158798,235.9098712,3368.927039,510.4377682,390.6781116,233,25.54468641,11.89286442,0.885010549,0.932,0.554761905,-0.78005658
+1526,25151.94262,777.5819672,474.0983607,1067.401639,23686.60656,653.6557377,514.4590164,1546.770492,12462.43443,500.1311475,703.3934426,1795.598361,18445.31148,1415.516393,4376.877049,2815.54918,6640.016393,1218.229508,329.3688525,2548.852459,12921.63115,8532.319672,367.0491803,655.1721311,15279.66393,470.5245902,133.4508197,2726.352459,11720.06557,1499.557377,800.0901639,2780.557377,10327.02459,763.4016393,263.2622951,1910.483607,8478.131148,951.8688525,393.9098361,1309.639344,6649.303279,713,157.5491803,4412.163934,5627.696721,1269.795082,335.2868852,3177.934426,604.6967213,387.8934426,122,17.91291442,9.842967754,0.835500278,0.818791946,0.586538462,0.409734816
+1527,24933.00763,765.6641221,508.3206107,1052.167939,22472.93893,637.4656489,579.2061069,1487.78626,12384.70992,491.129771,896.2900763,1781.610687,17900.9771,1216.587786,5902.862595,4006.236641,6390.351145,1212.885496,340.4427481,2481.259542,12758.80916,455.610687,587.6335878,528.8931298,14527.61069,410.221374,120.6870229,3997.954198,11642.98473,1399.458015,885.1145038,2788.389313,9969.366412,723.1450382,254.1145038,2137.839695,8232.793893,1618.740458,398.9923664,1314.251908,6364.572519,767.9160305,164.1374046,8398.557252,5364.068702,1260.679389,551.2671756,3120.312977,661.4045802,387.2290076,131,16.14120937,11.16989908,0.721886679,0.85620915,0.545833333,0.905485845
+1528,26099.11392,769.1139241,509.2531646,1082.949367,23408.88608,702.3291139,688.2151899,1504.56962,13012.01266,495.164557,968.6075949,1805.949367,18852.51899,1222.265823,8061.949367,3183.037975,6862.075949,1240.873418,353.443038,2532.759494,13326.03797,1121.822785,841.0632911,1212.974684,15638.98734,394.5696203,235.2025316,3795.898734,12355.93671,1653.949367,682.3037975,2801.151899,10717.48101,639.0759494,258.7088608,2289.265823,8637.860759,853.8607595,395.556962,1297.531646,6813.797468,859.3670886,158.7721519,4830.291139,5767.898734,1295,1175.518987,3183.392405,684.9620253,385.5189873,79,11.46391669,9.522413296,0.55680651,0.868131868,0.548611111,0.6265723
+1529,33586.93519,1000.731481,608.3518519,1125.027778,30962.08333,762.5277778,1285.092593,1637.101852,16932.33333,608.6296296,1754.861111,1868.675926,23594.89815,1333.37037,9413.611111,3901.731481,8461.12963,1362.777778,390.8796296,2628.361111,16123.49074,419.8888889,867.6203704,1272.277778,18566.17593,485.9444444,838.7777778,4168.212963,14752.13889,1967.157407,859.9259259,2806.240741,12358.64815,653.3611111,293.2592593,1817.490741,10134.98148,1206.962963,453.75,1329.092593,8153.583333,820.6388889,190.6481481,6308.675926,6582.861111,1352.555556,569.4259259,3413.111111,347.9259259,386.0555556,108,13.26470948,10.42358138,0.618464147,0.955752212,0.755244755,-1.142757724
+1530,19549.61856,782.1134021,486.3505155,1028.917526,17245.53608,617,450.814433,1400.350515,9430.917526,493.1958763,588.1443299,1751,14095.24742,1184.927835,3865.113402,3143.690722,4944.195876,1221.020619,342.0721649,2466.783505,8797.505155,352.185567,337.9587629,572.8659794,10344,378.1443299,114.6701031,5327.14433,8540.896907,1504.164948,1044.597938,2789.783505,7245.14433,740.5360825,239.9484536,1885.340206,5950.412371,969.2061856,402.1752577,1292.85567,4559.876289,685.9381443,169.628866,5277.020619,3976.412371,1232.57732,547.4536082,3157.247423,454.9793814,386.9793814,97,12.98185329,9.883556312,0.648357169,0.932692308,0.673611111,-0.848430137
+1531,25456.15068,768.2739726,522.9863014,1106.691781,6486.068493,403.0547945,293.5136986,1111.30137,3065.116438,329.2328767,901.1986301,1603.171233,4941.965753,812.3972603,3424.136986,1830.541096,1821.582192,849.4041096,241.7945205,2417.842466,3333.534247,321.869863,92.3630137,1712.623288,3923.164384,245.1849315,226.4246575,4124.849315,3199.294521,1227.869863,583.4178082,2774.130137,2529.013699,446.109589,174.9863014,2211.219178,1912.157534,574.5616438,296.7945205,1251.815068,1081.856164,487.4726027,121.1506849,1480.020548,1035.40411,798.5,92.65068493,2851.130137,1028.739726,387.5616438,146,16.01273334,11.94661724,0.665867711,0.9125,0.648888889,1.011971933
+1532,21597.81197,751.5128205,508.4273504,1075.487179,9013.478632,417.2905983,292.8803419,1187.752137,3860.162393,346.3931624,598.2735043,1646.589744,6652.239316,848.6752137,3770.965812,1538.760684,2438.606838,912.5299145,266.8290598,2958.598291,4428.17094,752.8119658,389.6410256,624.3504274,5390.25641,271.5042735,93.13675214,3714.145299,4226.991453,1301.213675,548.5811966,2770.982906,3294.846154,473.5299145,174.7094017,2875.641026,2433.307692,660.6153846,304.034188,1278.222222,1198.247863,576.2905983,128.8376068,1334.905983,1285.649573,820.6923077,137.4529915,3038.358974,1079.358974,386.7606838,117,12.36940119,12.08174136,0.214407766,0.951219512,0.75,0.899382994
+1533,35322.39216,814.4901961,513.5490196,1061.980392,29392.64706,664.0392157,499.7647059,1529.45098,17796.2549,530.3921569,435.8039216,1768.54902,24666.72549,1290.72549,5600.607843,3711.294118,8750.901961,1241.470588,355.745098,2390.156863,17299.82353,445.6470588,673.6078431,481.5490196,19636.70588,413.2352941,118.6862745,3861.607843,16259.52941,1482.372549,981.627451,2794.431373,13910.05882,604.3529412,257.0588235,1916.156863,11129.45098,836.7254902,407.1176471,1282.176471,8422.647059,828.6078431,167.5882353,5089.215686,7387.686275,1286.019608,141.3921569,3183.627451,627.7254902,386.4117647,51,10.63290704,6.389578751,0.799305478,0.910714286,0.662337662,-0.009709171
+1534,29180.20755,819.2830189,454.6792453,1055.584906,24905.5283,667.5377358,554.8490566,1483.349057,14577.54717,522.1320755,455.8207547,1701.415094,20934.24528,1289.339623,4337.254717,2771.301887,7466.783019,1252.518868,374.5283019,2636.45283,14559.26415,1282.424528,835.1037736,513.009434,16180.66981,391.7075472,123.5283019,2514.669811,13755.57547,1459.641509,716.3867925,2804.745283,11702.67925,640.6509434,261.1226415,1980.556604,9481.90566,819.4622642,414.3301887,1313.59434,7105.349057,817.5188679,159.0283019,2379.867925,6111.339623,1339.735849,1953.801887,3097.764151,734.3584906,387.745283,106,16.37479024,8.459571954,0.85621377,0.92173913,0.552083333,-1.008613609
+1535,39980.77885,809,465.0480769,1088.846154,35108.82692,721.0288462,860.9711538,1553.798077,19993.49038,535.7788462,1662.076923,1849.461538,28168.13462,1320.788462,4541.538462,3043.826923,10075.34615,1322.076923,357.9038462,2612.288462,20308.13462,879.5480769,170.7115385,1393.105769,23972.38462,458.5384615,515.2788462,3111.471154,18786.91346,1687.692308,737.4134615,2814.576923,16378.26923,677.9230769,280.9807692,1866.451923,13365.26923,1018.317308,430.3269231,1309.875,10124.10577,658.6346154,165.0769231,3515.903846,8788.875,1351.682692,354.2115385,3188.807692,596.6923077,392.125,104,19.71894788,6.884642446,0.93707116,0.904347826,0.684210526,0.005407092
+1536,41986.4186,870.5348837,496.8604651,1124.511628,34611.67442,712.7906977,648.7906977,1640.837209,21399.97674,548.5348837,422.8604651,1734.488372,29122.65116,1380.139535,7776.790698,3663.139535,10269.83721,1330.116279,381.8837209,2440.232558,20973.51163,584.1627907,830.372093,484.2325581,24694.55814,423.4418605,125.1627907,5273.604651,19666.06977,1556.116279,752.9534884,2816.348837,17347.2093,657.0930233,287.9302326,2269.139535,14230.72093,856.0232558,432.8139535,1303.139535,10562.7907,886.1627907,175.6744186,4057.348837,9350.093023,1402.744186,155.7209302,3211.348837,611.8139535,386.5116279,43,9.032511354,6.220528252,0.725063488,0.977272727,0.682539683,0.435549194
+1537,27876.58436,768.7366255,464.5061728,1061.123457,24510.81481,645.3497942,485.3168724,1461.695473,13921.22222,514.8683128,873.4609053,1754.893004,19675.47737,1220.600823,5086.794239,2581.946502,7126.868313,1287.032922,348.6296296,2587.650206,13992.39506,433.4691358,675.090535,802.5596708,16218.60905,397.0576132,201.8271605,3078.168724,12928.9465,1597.884774,696.9423868,2794.423868,11170.12346,627.1687243,257.4897119,1901.91358,8997.975309,927.0164609,392.4650206,1305.588477,6999.757202,774.7283951,154.5308642,5024.90535,6014.423868,1259.526749,1080.427984,3162.707819,648.5308642,392.7242798,243,20.94615235,15.24917711,0.685557955,0.923954373,0.680672269,0.085535233
+1538,33410.09375,992.890625,480.84375,1086.734375,28341.875,728.515625,491.046875,1534.390625,16644.79688,566.40625,409.421875,1687.671875,22019.1875,1341.953125,4070.375,2982.609375,8039.34375,1277.5,369.21875,2445.609375,15901.75,564.703125,265.953125,465.75,17582.625,370.515625,126.65625,2203.265625,14930.25,1389.6875,692.015625,2796.9375,12801,657.5,269.578125,1964.96875,10112.01563,791.28125,408.609375,1296.203125,7470.25,642.84375,154.15625,1489.421875,6349.5625,1340.59375,2331.6875,3202.109375,723.71875,386.375,64,11.41950986,7.488602642,0.7549584,0.914285714,0.666666667,-1.182185158
+1539,26682.42636,781.8837209,512.2248062,1081.139535,22816.06202,627.0077519,555.0930233,1653.472868,13088.51163,490.0232558,1224.162791,1822.953488,19178.66667,1192.674419,5010.263566,3926.550388,6674.426357,1202.077519,340.3488372,3152.976744,12706.74419,2342.860465,209.0387597,959.0310078,14319.28682,598,124.0387597,4758.139535,12263.14729,1501.821705,864.6666667,2856.682171,10265.63566,599.9379845,264.5968992,9006.085271,8451.410853,1071.922481,395.6511628,1313.984496,6230.248062,697.9224806,153.3488372,4041.806202,5249.790698,1221.170543,237.8372093,3211.348837,802.496124,392.2868217,129,19.99419768,9.42045694,0.882048009,0.837662338,0.447916667,0.635171391
+1540,35490.64103,826.2820513,524.1025641,1110.717949,29582.91026,651.3974359,1152.653846,1681.346154,17112.61538,517.1282051,1463.166667,1760.141026,24724.28205,1267.448718,7428.153846,4563.769231,8744.923077,1293.141026,371.8846154,6523.589744,16806.92308,562.2564103,140.9358974,766.5384615,20001.46154,431.7179487,121.3205128,5199.25641,16745.37179,1869.666667,775.1282051,2817.448718,13790.4359,708.7307692,288.9871795,12228.53846,11313.39744,1359.423077,419.6666667,1344.24359,7566.410256,642.7820513,167.9102564,4706.012821,6760.384615,1261.602564,259.8717949,3222.038462,888.1666667,388.025641,78,12.98829025,8.477912092,0.757586282,0.886363636,0.65,-0.339830841
+1541,18863.01389,755.1805556,591.6527778,1072.25,16420.30556,597.6805556,611.3888889,1657.513889,8719.319444,456.6111111,620.3472222,1814.208333,14093.875,1147.472222,8711.097222,5159.416667,4923.013889,1146.027778,342.8194444,4308.291667,9103.652778,720.4305556,200.1805556,581.875,10855.48611,411.1805556,115.9305556,9348.069444,8940.041667,1631.180556,1128.208333,2818.625,7166.513889,566.8472222,273.6805556,28131.58333,6069,984.8055556,380.5833333,1345.666667,4307.333333,784.1666667,172.4166667,8303.958333,3733.944444,1148.916667,226.5138889,3192.916667,896.0833333,388.125,72,12.45733663,7.78947207,0.780390929,0.911392405,0.6,-0.597137105
+1542,30059.25,995.23,620.29,1080.94,27092.44,754.21,839.59,1648.35,14881.74,609.73,1532.39,1780.84,21519.26,1338.21,5504.64,3886.59,7435.24,1379,387.38,2734.72,14905.12,460.17,1257.08,561.07,17409.62,1287.37,136.46,4120.88,13767.73,1820.33,795.02,2801.22,11906.8,747.67,293.84,1813.91,9306.06,1171.6,450.15,1357.08,7416.43,916.07,176.18,5021.38,6548.46,1353.06,198.47,3425.19,402.81,389.57,100,13.09186083,10.72320754,0.573687364,0.854700855,0.641025641,-0.642905466
+1543,20265.12605,762.8907563,559.5714286,1105.210084,18006.92437,608.789916,554.4201681,1692.663866,9625.571429,471.9411765,639.6722689,1803.596639,14298.85714,1172.058824,6645.789916,3922.638655,5268.02521,1153.857143,340.2184874,3319.260504,9611.168067,5893.647059,182.1008403,516.697479,11658.16807,449.4537815,123.512605,8633.655462,9468.092437,1531.378151,1021.705882,2802.815126,7713.991597,581.9747899,283.9495798,23722.47899,6439.87395,848.8991597,388.7731092,1341.521008,4570.537815,695.0840336,160.2268908,6413.235294,3951.495798,1192.302521,197.1176471,3227.436975,876.7563025,388.8487395,119,17.80850035,8.985226844,0.863384181,0.894736842,0.619791667,1.141353033
+1544,35389.24845,864.6459627,502.9813665,1089.714286,30667.07453,710.621118,638.7204969,1574.049689,17504.67702,547.757764,816.3975155,1764.652174,24485.37267,1350.546584,4823.819876,3164.217391,8681.447205,1319.645963,360.4037267,2535.714286,17291.54658,483.0621118,453.0496894,825.6335404,20363.67702,414.5031056,156.2360248,3144.043478,15756.16149,1613.267081,760.3726708,2816.73913,13601.97516,800.5838509,289.0248447,2192.161491,11125.11801,922.4968944,437.4968944,1312.055901,8562.440994,746.8509317,164.4223602,3484.447205,7188.602484,1365.15528,433.4720497,3234.440994,588.7142857,394.484472,161,21.33221847,10.65316051,0.866375574,0.829896907,0.619230769,0.085159003
+1545,21496.48684,865.4013158,806.1842105,1148.394737,18475.48684,653.3026316,871.25,1720.434211,10412.91447,494.3618421,556.8157895,1832.256579,15527.69079,1256.434211,3539.473684,2769.578947,5426.131579,1265,362.0394737,3230.032895,10495.68421,595.5921053,1353.085526,530.9671053,12077.09868,424.3947368,122.1842105,4413.375,9870.618421,1593,699.2368421,2822.480263,8254.052632,604.3486842,261.1644737,4708.769737,6924.203947,1001.440789,410.0986842,1322.934211,4945.138158,960.3486842,165.1118421,4525.282895,4279.513158,1227.657895,133.8486842,3271.421053,834.6644737,392.0526316,152,14.86102433,13.31952143,0.443504598,0.938271605,0.678571429,-0.426085142
+1546,15902.62687,678.6716418,495.5970149,1030.19403,14082.44776,563.0895522,452.6791045,1579.104478,7593.522388,441.3731343,383.7686567,1788.30597,10878.62687,1074.134328,6604.798507,4077.477612,4073.276119,1094.992537,313.238806,2563.962687,7215.223881,2915.828358,734.0522388,421.9626866,8608.410448,395.4626866,115.9925373,8750.462687,7114.208955,1293.104478,1002.328358,2784.395522,5940.552239,570.2238806,226.6268657,8097.738806,4833.365672,799.6865672,369.4328358,1314.783582,3435.268657,755.1567164,146.0820896,4126.91791,2965.507463,1084.552239,151.9626866,3253.291045,851.7985075,389.5,134,16.11772393,11.02178911,0.729641025,0.964028777,0.656862745,-1.245780464
+1547,14755.64202,754.9961089,614.7276265,1130.859922,12786.9144,609.0583658,510.1712062,1776.435798,6656.132296,465.9766537,478.2451362,1797.988327,10351.00389,1192.603113,6977.490272,3393.645914,3778.400778,1167.237354,336.1245136,2567.159533,7024.88716,3081.81323,402.7782101,456.3268482,8316.342412,423.3774319,117.5758755,7490.894942,6970.07393,1337.583658,1026.544747,2811.070039,5775.019455,616.9494163,279.6070039,33686.14786,4685.373541,734.6070039,388.5330739,1335.552529,3153.657588,974.1789883,158.7237354,7971.400778,2895.050584,1161.540856,172.1206226,3244.354086,927.9455253,393.459144,257,18.40772913,18.06924634,0.190887499,0.944852941,0.711911357,1.404219102
+1548,42250.0375,899.5,566.6125,1144.4,38738.325,747.4625,642.8875,1740.1,21078.95,576.525,501.35,1777.3375,29859.8125,1365.6625,7203.3125,4405.875,10830.1,1402.1,436.7875,2431.9,21644.65,459.0625,959.2875,439.375,25291.925,443.9125,140.4875,6661.9625,20300.9375,1596.4875,838.7375,2834.2125,17549.8125,603.1125,319.0375,5171.3875,11301.1125,853.075,466.575,1317.5,9180.8125,822.2125,174.85,3196.7375,7637.775,1381.875,223.6375,3354.975,192.3,391.9625,80,11.70994762,9.592425487,0.573552293,0.888888889,0.559440559,-0.275812968
+1549,42546.11111,978.5432099,539.1358025,1106.975309,36261.22222,773.3950617,468.9135802,1675.234568,20808.16049,618.0864198,516.3703704,1757.320988,28738.2716,1400.938272,5224.444444,3482.91358,10247.60494,1436.493827,406.0864198,2428.765432,20405.71605,462.382716,680.5432099,466.4444444,23240.97531,469.037037,164.9382716,4762.740741,18546.02469,1632.160494,833.345679,2835.530864,16068.87654,645.8395062,302.617284,1747.62963,12638.40741,960.7160494,475.0493827,1325.333333,9763.049383,801.3703704,183.5185185,4850.901235,8577.802469,1417.419753,145.4938272,3362.777778,412.1481481,392.0864198,81,13.02180068,8.002257252,0.788895242,0.952941176,0.692307692,-0.22260502
+1550,27735.44886,937.8068182,539.6022727,1059.380682,24388.21023,695.2613636,482.5738636,1463.056818,13017.25568,563.2613636,520.9545455,1717.306818,18668.21023,1296.465909,6980.636364,3395.914773,6673.801136,1357.369318,367.9545455,2416.392045,13079.83523,456.3181818,879.9034091,475.7329545,15076.47727,414.1875,130.4431818,3583.789773,11994.08523,1634.994318,821.7954545,2797.534091,10315.82386,686.0340909,268.9261364,1771.659091,8256.323864,892.0397727,436.2102273,1333.875,6569.119318,801.1306818,176.1363636,6058.028409,5645.301136,1306.511364,156.1306818,3387.272727,420.3295455,395.3295455,176,20.55262025,12.01990975,0.811151646,0.814814815,0.661654135,-0.170116808
+1551,28273.63991,1078.603211,598.1146789,1122.025229,24797.08486,802.5114679,576.8761468,1556.568807,13704.5344,624.7293578,807.9587156,1764.555046,20254.80275,1501.743119,4406.130734,3181.674312,6797.016055,1407.305046,419.5412844,2485.417431,12439.77064,466.5963303,1099.068807,1096.396789,14782.36468,516.9518349,240.0068807,3892.860092,11727.26147,1809.961009,855.2683486,2823.224771,10132.35092,916.2821101,300.3440367,1684.788991,8278.972477,1110.754587,469.3073394,1344.41055,6550.41055,939.2201835,187.3990826,3907.883028,5672.928899,1441.635321,362.7798165,3251.263761,447.7362385,399.3050459,436,27.07869285,21.96567887,0.584797331,0.902691511,0.672839506,0.800637487
+1552,21360.06322,1156.83908,720.6551724,1135.885057,18626.82184,808.8563218,692.7298851,1540.701149,10459.96552,646.2068966,958.6091954,1794.321839,14669.43103,1550.672414,2974.718391,2743.5,5138.517241,1420.925287,409.8045977,2690.913793,9976.971264,518.2356322,250.4827586,789.1954023,11586.2069,856.183908,136.5172414,2082.172414,9022.367816,1681.149425,711.4482759,2808.798851,7807.425287,1093.264368,294.8045977,1600.37931,6464.068966,1078.413793,462.3563218,1318.672414,5050.37931,714.2873563,184.1264368,2504.149425,4263.316092,1396.477011,492.8103448,3318.735632,523.5344828,393.6149425,174,17.91291147,12.5944959,0.711094969,0.930481283,0.639705882,-0.857078626
+1553,30207.79793,793.9585492,624.2953368,1140.056995,23641.25389,605.4974093,532.6321244,1628.917098,11928.9171,489.2590674,939.2227979,1774.792746,17305.04145,1153.435233,7957.860104,4399.279793,6616.38342,1251.896373,404.8445596,2772.84456,13068.22798,412.8704663,1573.632124,684.5336788,15403.95337,396.6580311,145.5751295,9798.388601,11431.29534,1691.917098,1084.373057,2814.699482,9781.212435,559.984456,269.5284974,8965.487047,5995.57513,812.3056995,398.4041451,1322.243523,5022.305699,903.6476684,162.8445596,4181.678756,4085.683938,1155.569948,303.7512953,3215.471503,170.6580311,396.357513,193,17.81858374,14.13449731,0.608902971,0.927884615,0.634868421,0.396257162
+1554,29913.0381,880.0952381,497.9904762,1082.92381,27788.75238,713.8190476,553.2380952,1555.314286,15631.2381,554.0380952,441.647619,1746.4,22122.88571,1355.4,7035.447619,2757.171429,7748.771429,1395.228571,393.0571429,2410.619048,13481.87619,404.0666667,1537.990476,448.6666667,15763.02857,398.4190476,127.9428571,2933.495238,12632.70476,1562.304762,837.8380952,2812.685714,10587.4,790.4,285.152381,1599.590476,8635.12381,846.2952381,439.6190476,1370.866667,6835.980952,995.6857143,179.552381,3633.009524,5857.752381,1389.571429,517.8285714,3231.133333,359.5238095,393.6095238,105,13.70952177,10.02665096,0.681987295,0.945945946,0.673076923,0.76028632
+1555,47009.5619,910.1333333,487.552381,1117.638095,41896.24762,765.447619,734.3619048,1630.047619,24824.95238,615.4095238,1046.12381,1747.12381,33840.90476,1437.847619,3858.733333,2626.161905,12178.89524,1472.342857,420.8285714,2531.866667,23887.65714,503.2285714,156.2095238,1019.428571,28283.97143,500.9333333,144.2,2165.533333,22442.80952,1879.638095,754.7238095,2843.085714,19266.04762,680.5047619,329.8952381,1640,15592.4,1129.295238,504.1333333,1304.67619,11807.31429,697.247619,183.1714286,2349.704762,10216.02857,1474.733333,279.0952381,3287.67619,547.3809524,390.8952381,105,15.02141491,9.464342734,0.776549153,0.92920354,0.65625,1.566103432
+1556,34247.29289,840.334728,502.0334728,1104.912134,29730.4728,697.4225941,720.7782427,1597.217573,17081.28033,530.5439331,895.5983264,1776.142259,24473.49372,1351.179916,4872.179916,3182.154812,8707.292887,1300.485356,363.9623431,2485.008368,17019.20502,1015.820084,289.790795,634.1882845,19849.37657,432.0920502,812.3263598,2263.062762,15872.13389,1697.589958,741.0083682,2814.368201,13848.14644,671.41841,279,2026.761506,11077.53556,1014.518828,418.4393305,1310.209205,8440.728033,690.1046025,163.1589958,3138.543933,7173.782427,1382.142259,1427.171548,3231.878661,693.0669456,396.4267782,239,21.71897839,14.919969,0.7266996,0.869090909,0.611253197,-0.298469423
+1557,24308.88048,881.438247,454.9003984,1072.434263,21650.17131,674.0916335,560.3585657,1484.262948,12200.91633,516.936255,396.1713147,1691.697211,17270.3745,1322.988048,1896.123506,1098.314741,6289.776892,1247.645418,375.0398406,2435.163347,12330.13944,1315.900398,364.0278884,466.1394422,13805.63745,422.2868526,121.3944223,1195.135458,11707.9243,1373.868526,526.2629482,2796.394422,10119.83267,631.8326693,268.7250996,1821.390438,8247.075697,802.8844622,413.6812749,1297.960159,6294.438247,700.8207171,163.1513944,2619.968127,5383.884462,1391.828685,1319.553785,3103.195219,743.1155378,397.5179283,251,20.9502731,16.07721656,0.641169967,0.90942029,0.664021164,0.089856
+1558,15621.84397,745.7730496,604.6382979,1148.141844,13035.22695,601.9219858,510.2553191,1745.553191,7101.205674,457.1489362,465.5177305,1761.148936,10620.31206,1132.333333,6004.574468,3462.092199,3910.085106,1203.780142,339.106383,2518.460993,7202.212766,1250.921986,197.3191489,465.2695035,8555.858156,393.7588652,118.3687943,6607.58156,7104.716312,1340.780142,950.177305,2909.631206,5812.056738,566.9716312,280.7021277,32997.02837,4699.092199,740.6879433,386.1347518,1341.468085,3239.907801,956.4609929,155.9078014,6599.723404,2929.929078,1147.631206,219.8439716,3227.829787,912.4751773,394.3475177,141,16.66953035,10.89668728,0.756763369,0.927631579,0.691176471,0.198962922
+1559,19525.72083,742.2416667,533.0875,1120.420833,17026.50833,630.3833333,456.0458333,1712.370833,8690.045833,456.6833333,461.6583333,1798.345833,13205.4375,1135.266667,5243.595833,2867.741667,4855.004167,1127.408333,328.925,2678.45,9044.720833,8149.5375,369.2916667,536.0541667,10571.51667,438.5541667,119.7583333,5990.416667,8698.475,1360.2875,954.6958333,2810.479167,7053.8125,822.3791667,273.9583333,21798.2625,5685.579167,779.7041667,385.0833333,1313.65,3751.025,877.3666667,155.2791667,6549.766667,3308.708333,1141.304167,151.5,3185.579167,947.0166667,394.6875,240,20.77160362,14.9791034,0.692795919,0.956175299,0.75,1.306511105
+1560,34142.02804,896.5514019,587.0560748,1130.719626,30294.71028,718.9158879,496.4299065,1668.35514,16665.85981,575.2897196,531.6542056,1775.757009,23195.76636,1323.345794,6524.551402,5671.654206,8886.17757,1399.485981,392.8785047,2433.878505,17562.36449,433.1962617,683.5607477,1004.327103,20653.95327,441.8411215,135.5794393,4882.682243,15579.20561,1536.364486,1069.971963,2830.224299,13553.62617,640.8130841,314.8598131,3380.299065,10317.42056,1170.971963,455.0280374,1315.981308,8470.17757,846.1028037,184.1775701,4841.728972,6935.925234,1396.850467,180.9906542,3368.691589,307.682243,394.4579439,107,13.46959985,10.39369385,0.636058453,0.963963964,0.694805195,-0.235629865
+1561,26617.83178,968.8598131,644.635514,1103.065421,23903.71963,759.1775701,664.2149533,1612.345794,12418.79439,578.8598131,622.0654206,1835.757009,17976.59813,1376.271028,5662.17757,4438.981308,6403.252336,1320.037383,379.4485981,2497.46729,11262.43925,423.6074766,2648.616822,572.1775701,12565.45794,490,125.5607477,4027.280374,9605.635514,1687.700935,888.1962617,2800.523364,8347.906542,580.317757,261.4485981,1731.028037,6718.757009,900.8971963,427.4766355,1410.542056,5432.420561,1613.11215,170.635514,5276.738318,4500.785047,1349.168224,278.5700935,3304.663551,482.3271028,392.3831776,107,14.05292451,9.950624091,0.70613013,0.922413793,0.648484848,1.399530662
+1562,16952.09524,718.2666667,423.1238095,1047.761905,15982.24762,593.7428571,434.0761905,1436.628571,8268.92381,467.9333333,432.1142857,1734.447619,12342.8,1153.542857,2493.380952,1870.32381,4545.8,1187.647619,327.6857143,2440.980952,8938.047619,581.1047619,650.8666667,490.447619,10167.3619,385.4761905,116.1809524,1980.761905,8252.666667,1361.190476,848.5238095,2785,7173.133333,1078.495238,239.3714286,1728.847619,5934.866667,766.3142857,372.3047619,1301.6,4739.933333,776.6571429,150.9047619,4813.92381,3829.238095,1214.247619,571.6571429,3108.142857,672.3238095,392.9238095,105,18.98077377,9.072075983,0.878380875,0.734265734,0.460526316,-0.973328416
+1563,23243.61688,788.9025974,442.7012987,1050.155844,20150.43506,668.6233766,839.9025974,1495.785714,11665.0974,501.9415584,924.7077922,1758.525974,17021.44805,1253.727273,3975.123377,2703.62987,6061.298701,1209.603896,351.0779221,2506.876623,11740.78571,5558.077922,267.6363636,968.2727273,13186.04545,415.961039,594.8246753,2185.551948,10974.87013,1659.590909,628.4025974,2786.519481,9346.077922,674.4415584,255.6558442,1982.344156,7620.331169,865.025974,401.6428571,1304.642857,5748.38961,661.0779221,155.5584416,3101.383117,5038.292208,1312.064935,1733.285714,3123.655844,719.5454545,394.8051948,154,19.25480897,10.77703838,0.828691034,0.895348837,0.623481781,1.435989555
+1564,16777.92391,741.5326087,411.0869565,1003.630435,14547.32609,575.1195652,469.2826087,1392.652174,8324.478261,464.7282609,375.7282609,1686.641304,11899.23913,1133.5,4967.141304,2703.684783,4331.728261,1122.184783,324.4565217,2459.434783,8678.543478,452.2608696,1095,479.3043478,10022.51087,359.2173913,113.6521739,2474.413043,8399.48913,1351.01087,568.2608696,2788.141304,7232.130435,590.3478261,246.2391304,5829.934783,6113.097826,869.4673913,378.3043478,1353.5,4601.75,921.7173913,162.9891304,3490.065217,3958.391304,1179.413043,1182.576087,3288.26087,769.0543478,393.7391304,92,11.6151303,10.32285512,0.458407577,0.968421053,0.58974359,0.001867031
+1565,21855.86864,863.8559322,1044.677966,1219.34322,18756.76695,665.6991525,955.5042373,1874.779661,10441.4661,508.9661017,1046.169492,1928.733051,15073.82203,1230.09322,5717.79661,3917.029661,5489.334746,1234.940678,355.3940678,5316.902542,10165.7161,1104.04661,728.6525424,625.059322,12147.37712,449.5169492,125.5805085,5614.457627,9779.173729,1608.474576,820.6652542,2806.707627,8203.449153,619.5381356,282.5254237,16879.05085,6726.872881,1079.334746,413.2966102,1375.728814,4778.966102,803.6398305,157.8432203,6021.004237,4120.826271,1233.165254,211.6525424,3276.169492,859.8771186,398.2076271,236,21.26656471,14.99226419,0.709238337,0.936507937,0.69005848,-0.626680398
+1566,34181.2,889.9111111,560.5333333,1105.4,30833.52222,694.9444444,616.8111111,1615.255556,17262.36667,568.9222222,510.8222222,1775.844444,23808.34444,1291.8,7371,4906.144444,8906.022222,1380.577778,382.1222222,2411.344444,17711.77778,446.9555556,239.7222222,1775.322222,20583.12222,429.0666667,131.8888889,3510.088889,16280.44444,1487.922222,984.2444444,2836.666667,14135.77778,607.8,307.8,2762.677778,10769.61111,1377.155556,455.1555556,1302.855556,8512.188889,789.1222222,175.8555556,3442.544444,7204.688889,1384.166667,185.3555556,3453.944444,296.1777778,392.4888889,90,15.657812,8.138573594,0.85430186,0.891089109,0.625,-1.320167908
+1567,26412.75419,874.3910615,540.0614525,1096.03352,22636.74302,751.5586592,754.8603352,1543.519553,13055.86034,613.273743,998.4357542,1804.810056,17661.29609,1297.810056,3588.586592,3308.240223,6455.005587,1330.536313,368.5307263,2489.843575,12093.19553,474.3575419,1337.061453,1313.625698,13796.12291,952.1731844,397.0446927,2671.653631,10789.23464,1719.910615,726.2234637,2814.340782,9360.692737,740.4804469,281.3687151,1626.083799,7504.145251,990.8938547,432.7318436,1386.26257,5694.776536,1012.597765,174.0782123,4917.363128,4830.670391,1370.391061,263.6256983,3277.156425,496.0893855,398.1173184,179,21.09494205,11.39521376,0.841545002,0.87745098,0.639285714,0.188549234
+1568,24913.36957,836.4347826,519.6086957,1088.130435,21700.52174,684.1630435,872.0108696,1536.73913,12427.65217,541.2065217,1482.326087,1854.521739,17844.96739,1333.902174,5820.923913,3864.695652,6308.967391,1278.108696,362.8369565,3243.445652,12048.1087,449.326087,167.7282609,1828.804348,13587.27174,457.5543478,251.1956522,2983.206522,10824.72826,2081.652174,893.4891304,2817.336957,9441.554348,675.423913,277,1887.695652,7785.467391,1134.282609,433.9347826,1312.195652,5946.586957,639.1413043,168.6956522,4470.402174,5048.391304,1327.76087,358.5326087,3260.75,535.3913043,394.9456522,92,13.52152396,9.015537755,0.745277369,0.893203883,0.58974359,-0.728060145
+1569,38981.25,865.9117647,476.9705882,1099.205882,32685.01471,699.1323529,698.7647059,1555.279412,19399.57353,553.2352941,446.2205882,1761.588235,27329.92647,1316.441176,5546.5,2138.838235,9639.25,1302.955882,366.8676471,2429.617647,19282.44118,485.6323529,238.9852941,462.9558824,22280.45588,414.6911765,123.6617647,2855.426471,17746.45588,1439.235294,666.7941176,2797.441176,15352.13235,752.3382353,269.3823529,2064.882353,12609.83824,827.1176471,421.1911765,1283.558824,9362.75,666.9117647,164.5147059,2749.117647,8066.558824,1347.176471,323.3823529,3240.794118,617.6176471,393.6323529,68,11.23355161,7.963870619,0.705272686,0.931506849,0.62962963,1.44408873
+1570,25754.74766,795.4018692,501.8037383,1131.168224,18599.20561,588.2523364,416.8037383,1684.962617,8924.065421,476.9345794,436.6728972,1791.981308,12596.02804,1063.196262,3690.570093,1641.224299,4615.317757,1127.738318,330.2056075,2401.299065,9254.056075,6088.672897,152.9065421,469.4953271,10568.38318,426.271028,114.5794393,5090.953271,7977.915888,1336.084112,496.8878505,2841.093458,6743.457944,665.6728972,247.6448598,5985.074766,3731.149533,665.7009346,371.3831776,1285.158879,3075.084112,588.8411215,145.3364486,1640.205607,2658.448598,1051,249.9813084,3112.766355,157.4018692,395.0654206,107,12.9790935,10.54554077,0.582958259,0.981651376,0.748251748,-1.099790922
+1571,39751.38462,876.3692308,514.2153846,1140.876923,34666.67692,706.6923077,411.4769231,1710.030769,18160.12308,552.5076923,472.7076923,1776.230769,25979.58462,1270.661538,5138.446154,3748.015385,9302.338462,1317.953846,383.8615385,2440.615385,18628.53846,401.8153846,682.0461538,423.7230769,21736.07692,393.8769231,127.1846154,4693.861538,17075.44615,1573.738462,701.6307692,2843.676923,14412.64615,571.2769231,298.4307692,7325.230769,8852.661538,794.6923077,419.6461538,1299.584615,7563.461538,736.3846154,174.7846154,2991.830769,6310.615385,1281.046154,325.8923077,3238.753846,181.9538462,393.3384615,65,10.83041234,7.732336797,0.700200083,0.955882353,0.738636364,1.445288441
+1572,50029.875,948.8461538,611.8653846,1162.182692,46441.54808,777.6057692,718.5384615,1821.413462,25914.38462,626.3942308,483.7307692,1789.038462,35594.50962,1412.240385,8127.509615,5793.326923,13320.25,1503.288462,414.1057692,2413.567308,25881.26923,732.3557692,143.7403846,448.1538462,31713.38462,457.75,141.3461538,7897.490385,24822.74038,1579,928,2849.423077,21518.09615,650.8846154,346.0480769,2589.663462,16054.36538,907.1730769,492.7403846,1316.817308,12623.34615,677.9807692,193.6538462,2637.009615,10528.42308,1468.067308,128.4807692,3373.711538,252.9519231,394.7980769,104,13.43968501,10.05718928,0.663337554,0.95412844,0.742857143,1.451611419
+1573,40629.17526,899.4536082,593.1340206,1122.164948,37907.3299,728.5463918,666.3608247,1709.43299,20982.02062,582.0721649,493.0721649,1785.917526,28747.12371,1336.701031,7194.587629,4866.371134,10459.42268,1405.824742,396.6494845,2425.041237,21126.09278,457.8865979,139.6185567,439.8762887,25026.8866,426.8247423,133.257732,5597.494845,20226.45361,1516.494845,917.5979381,2810.061856,16870.90722,614.1134021,309.556701,2091.443299,12825.09278,884.1649485,474.0824742,1296.886598,10132.92784,666,183.1443299,4684.969072,8411.515464,1413.329897,135.185567,3288.515464,271.185567,395.7216495,97,12.30716618,10.48025849,0.524261373,0.941747573,0.621794872,0.055626326
+1574,35297.97838,864.372973,510.9675676,1091.167568,31425.96216,711.1135135,595.9675676,1560.827027,18061.61622,571.5783784,645.2486486,1741.924324,25527.4,1362.827027,5085.697297,3383.994595,9344.302703,1385.621622,384.3675676,2571.627027,18140.62162,467.8,297.6378378,621.6756757,21261.20541,489.1567568,150.4054054,3076.745946,16731.13514,1668.621622,965.4756757,2806.464865,14601.14595,655.5675676,298.4432432,1956.151351,11606.28108,1176.151351,459.4054054,1311.232432,9002.178378,703.972973,178.627027,3282.221622,7709.740541,1399.962162,459.8432432,3246.113514,556.8108108,397.9621622,185,20.41864464,12.38120244,0.795184544,0.898058252,0.604575163,-0.600734909
+1575,16118.37179,789.5641026,456.6666667,1042.576923,13746.61538,611.974359,794.8974359,1443.769231,7946.974359,486.6282051,1088.846154,1816.435897,10730.55128,1148.846154,4126.333333,2801.179487,4097.769231,1135.179487,334.3461538,3200.653846,7805.923077,497.6410256,969.0897436,1192.192308,8710.012821,383.8461538,116.2692308,2157.935897,7433.615385,1788.051282,597.525641,2795.987179,6398.730769,646.2820513,243.6282051,3343.679487,5280.448718,1066.705128,380.5769231,1346.935897,3953.128205,849.8205128,150.3846154,5249.730769,3340.064103,1228.666667,2967.089744,3135.846154,757.974359,394.1153846,78,13.52601176,7.551728073,0.829631398,0.917647059,0.666666667,1.146703146
+1576,11572.84921,679.2777778,469.7619048,1040.119048,9589.642857,548.5714286,468.9603175,1510.722222,5314.603175,427.2222222,456.8730159,1765.055556,8014.436508,1074.18254,5303.992063,3750.230159,2902.690476,1331.65873,330.2142857,3596.198413,5448.753968,452.6984127,850.984127,552.9365079,6292.230159,360.4206349,112.5396825,4511.984127,5441.087302,1340.769841,889.7063492,2824.34127,4447.150794,579.9285714,253.0238095,17891.0873,3616.912698,761.047619,365.3412698,1352.309524,2488.063492,882.7936508,152.8333333,6243.285714,2269.396825,1081.674603,216.7936508,3125.634921,901.031746,396.4365079,126,13.53243398,11.98274829,0.464670639,0.954545455,0.692307692,-0.564529292
+1577,21432.8022,725.1978022,477.1098901,1092.802198,13072.91209,424.5274725,237.967033,1233.164835,6280.076923,367.0769231,286.7692308,1636.131868,10084.46154,927.8021978,4077.406593,1314.186813,3552.153846,938.3956044,271.1758242,2402.626374,6619.571429,1546.120879,111.3516484,433.6813187,7564.43956,289.5494505,96.42857143,3193.098901,6737.637363,1117.769231,584.8021978,2780.054945,5286.208791,466.6043956,206.4615385,4063.43956,3973.120879,644.1538462,315.1978022,1260.868132,2297.593407,537.989011,128.9450549,1629.659341,2136.483516,899.1648352,91.82417582,2918.582418,1003.395604,396.1868132,91,12.59534404,9.36959882,0.668297806,0.928571429,0.7,-0.545427546
+1578,38363.8855,1058.839695,587.389313,1105.038168,35400.35878,762.9541985,510.0610687,1554.412214,19160.79389,628.389313,531.0534351,1768.137405,26772.69466,1365.450382,5206.305344,3412.885496,9487.114504,1396.244275,382.4580153,2399.725191,18724.44275,425.0992366,161.0305344,462.129771,21974.12977,435.0076336,130.7480916,3814.519084,17238.9313,1510.694656,881.740458,2809.625954,14589.53435,627.2977099,289.1984733,1603.122137,11569.55725,901.5038168,444.0916031,1316.961832,9462.198473,644.8778626,172.0687023,2480.51145,7741.763359,1340.755725,218.4351145,3468.030534,335.7557252,396.8244275,131,16.3932013,10.34879025,0.775550527,0.97761194,0.671794872,0.893235492
+1579,37151.89623,1007.254717,577.0660377,1124.377358,33624.16981,773.7264151,707,1647.377358,18959.42453,621.5283019,1340.198113,1795.207547,26548.51887,1396.396226,4391.254717,4725.179245,9222.254717,1482.160377,399.0943396,2501.349057,18395.58491,450.2641509,1276.858491,579.9716981,20702.19811,495.0377358,141.3113208,3557.037736,16703.9717,1713.018868,863.5,2823.066038,14105.37736,688.1226415,306.1226415,1873.566038,11210.91509,1631.896226,467.2735849,1339.433962,9007.084906,892.1509434,182.3018868,5110.971698,7449.735849,1413.292453,451.7358491,3373.981132,349.0849057,396.6698113,106,13.78397531,10.66075616,0.633897995,0.876033058,0.688311688,1.457183007
+1580,29217.71193,815.5596708,524.4012346,1107.209877,25197.66461,649.7983539,871.8148148,1657.022634,14135.88683,512.2716049,1103.958848,1814.759259,20055.63169,1216.709877,6015.144033,3810.899177,7233.559671,1235.397119,350.4382716,4985.273663,14024.23251,5061.664609,316.4423868,1035.820988,16081.6358,421.4506173,126.9876543,4237.220165,13093.06996,1930.40535,716.0473251,2797.253086,10919.53498,643.3888889,267.6934156,9623.092593,8958.473251,1825.469136,408.2098765,1323.306584,6521.541152,699.7263374,159.0864198,3997.374486,5453.582305,1234.345679,233.6604938,3252.77572,820.7572016,405.3497942,486,27.80809878,22.91885141,0.566329369,0.929254302,0.619897959,-0.586874415
+1581,22153.39241,780.0253165,460.5443038,1056.316456,18931.11392,642.2405063,560.7848101,1478.962025,11043.98734,491.4050633,587.4050633,1749.278481,16139.08861,1256.012658,4177.075949,2696.658228,5822.708861,1240.544304,365.2405063,2506.075949,11312.63291,479.9367089,1253.746835,605.3417722,12999.6962,394.0759494,153.6075949,2426.56962,10515.73418,1555.594937,790.8481013,2805.075949,9070.746835,955.9873418,251.9620253,1858.177215,7368.898734,829.0886076,390.4936709,1322.708861,5766.35443,974.3037975,165.556962,4144.860759,4972.164557,1295.21519,512.3670886,3111.594937,679.1012658,396.3544304,79,11.59435637,8.972781836,0.63331736,0.94047619,0.718181818,-0.817562603
+1582,15301.89565,714.4608696,502.5478261,1083.234783,13309.2,572.8608696,437.6956522,1606.991304,7316.278261,449.8782609,510.973913,1811.495652,11107.26957,1105.730435,6130.2,3622.434783,4012.843478,1123.373913,327.2434783,2996.678261,7500.730435,676.0695652,312.9478261,510.1826087,8807.591304,402.9913043,111.5478261,7188.982609,7400,1359.973913,812.7043478,2813.104348,6156.513043,632.9913043,256.373913,17545.05217,5110.878261,789.1217391,384.3043478,1331.2,3562.452174,711.6521739,147.0173913,4587.182609,3111.208696,1128.104348,211.0956522,3233.434783,872.6,397.9304348,115,13.99760041,11.18244807,0.601486162,0.93495935,0.631868132,-0.714657213
+1583,14208.16471,693.0058824,474.3647059,1095.876471,12585.59412,559.9,447.5176471,1647.511765,6158.364706,432.9647059,497.0235294,1775.6,9948.952941,1191.088235,9017.694118,2305.729412,3603.958824,1101.305882,318.5176471,2645.494118,6695.623529,3872.252941,454.6,532.3117647,7918.5,430.0235294,121.2470588,7731.647059,6546.382353,1329.776471,681.0176471,2815.764706,5255.970588,583.1176471,245.4588235,12099.72353,4071.852941,770.8,365.7529412,1317.176471,2508.2,752.2470588,143.8529412,3832.464706,2226.517647,1064.882353,152.7058824,3167.358824,990.8588235,397.4705882,170,19.96757252,12.95325609,0.761031767,0.813397129,0.566666667,1.380678483
+1584,43571.73134,978.8955224,648.8283582,1210.58209,40329.84328,797.119403,611.0298507,1860.843284,20986.97761,611.6044776,1356.865672,1828.029851,29875.97761,1388.014925,7044.559701,6269.470149,10923.94776,1503.902985,510.0298507,3415.992537,21976.28358,510.7835821,1977.350746,771.2014925,25869.00746,509.1268657,146.6716418,5739.955224,19932.73881,2065.880597,933.7462687,2840.074627,17217.47015,634.9552239,333.1268657,4700.328358,11448.63433,1066.380597,484.6791045,1343.208955,9500.91791,1084.044776,191.0298507,4154.335821,7412.134328,1428.768657,321.0970149,3347.858209,200.1492537,398.238806,134,18.23690988,9.450418917,0.855257735,0.95035461,0.62037037,-1.13032206
+1585,40781.75904,871.3855422,587.7831325,1114.084337,38101.72289,712.5421687,564.0963855,1643.566265,19731.60241,566.3975904,531.5060241,1819.963855,27267,1290.831325,8961.891566,5583.26506,9957.373494,1373.674699,386.5662651,2515.060241,20190.06024,1230.216867,437.686747,440.6987952,23892.03614,420.1807229,134.3012048,7995.060241,19081.53012,1614.73494,930.686747,2822.036145,16270.56627,602.2048193,297.1927711,2519.144578,12328.84337,970.2409639,454.6144578,1300.590361,9847.349398,717.4216867,182.4457831,5849.144578,8291.60241,1378.289157,155.9036145,3310.86747,280.9156627,397.9759036,83,11.50456083,9.414373006,0.574767741,0.892473118,0.685950413,-1.009905185
+1586,37395.39623,980.1886792,637.509434,1152.735849,32988.43396,740.7169811,576.6981132,1680.433962,18495.18868,593.2264151,537.9245283,1807.566038,25051.92453,1365.150943,7338.075472,6534.754717,9372.188679,1423.849057,396.1886792,2576.245283,17457.54717,442.1886792,255.5283019,471.6981132,20479.71698,453.0943396,135.5660377,6987.886792,15689.32075,1719.037736,1397.924528,2869.792453,13391,633.6037736,308.9245283,3205.132075,10402.71698,930.3207547,458.1698113,1314.396226,8580.603774,688.3584906,188.4150943,4333.245283,6893.037736,1411.113208,298.2830189,3319.396226,318.8867925,396.3773585,53,9.798856371,7.115549397,0.68752447,0.898305085,0.6625,1.392336373
+1587,24475.76471,910.9159664,556.7815126,1088.672269,21968.04202,699.8823529,580.4621849,1528.714286,12359.31092,561.697479,587.8991597,1732.05042,17482.2437,1355.210084,5576.97479,3887.344538,6401.285714,1337.521008,379.0672269,2463.02521,12199.7395,430.0756303,431.6302521,556.0084034,14482.03361,524.3361345,129.3781513,4969.478992,11301.35294,1549.739496,803.789916,2808.369748,9823.857143,701.7647059,279.907563,1856.344538,8007.10084,954.1344538,453.3361345,1316.941176,6300.663866,735.7563025,182.6806723,4777.537815,5472.453782,1382.983193,648.302521,3265.319328,431.1344538,399.0504202,119,14.93734216,10.53882809,0.708674384,0.894736842,0.653846154,-0.716882298
+1588,30741.51389,962.5138889,530.375,1096.777778,26037.47222,753.6805556,753.7083333,1518.055556,15298.29167,583.5972222,722.6527778,1758.527778,22258.38889,1393.166667,5682.833333,3399.763889,7825.722222,1372.027778,386.75,2494.222222,15292.41667,447.2916667,296.4583333,640.3194444,17616.91667,602.6666667,141.125,3268.138889,14362.125,1669.291667,769.0833333,2808.833333,12452,798.1666667,296.6527778,1828.972222,10118.76389,998.9027778,473.7777778,1312.916667,7639.458333,701.9583333,187.4027778,4980.097222,6924.569444,1425.972222,569.8472222,3385.541667,470.1666667,396.7638889,72,12.6403227,7.453354203,0.807659584,0.9,0.692307692,-1.467362394
+1589,33329.09504,837.4876033,494.8140496,1091.834711,28350.65289,686.6363636,546.8512397,1543.599174,16444.85537,533.3264463,509.8677686,1759.566116,24111.06612,1322,5492.731405,3489.446281,8351.876033,1310.553719,361.5,2584.971074,16891.86364,466.0123967,647.2479339,516.0867769,19449.86364,408.607438,121.5247934,4082.264463,15621.84711,1540.053719,701.5454545,2798.181818,13511.14463,617.8016529,267.0330579,1957.206612,10958.95868,850.607438,404.2520661,1325.070248,8483.805785,801.2190083,159.9752066,4550.950413,7226.243802,1336.789256,380.3347107,3227.822314,628.6363636,403.8305785,242,20.1819306,15.82441901,0.620649077,0.930769231,0.75625,0.149313733
+1590,28418.48864,771.8068182,543.5,1076.022727,24793.84091,657.3863636,752.9318182,1535.795455,14162.48864,508.4545455,1657.238636,1810.045455,20082.04545,1251.568182,6408.625,3624.443182,7274.386364,1303.5,345.0909091,2619.352273,14223.93182,450.5681818,463.1363636,1203.840909,16289.45455,425.3295455,200.9318182,4272.022727,13027.59091,1802,944.5340909,2787.636364,11244.18182,682.2727273,252.9659091,2203.056818,9013.170455,1307.181818,397.8636364,1311.431818,6981.75,739.1477273,156.6818182,8648.920455,5962.613636,1285.875,480.125,3195.125,659.2840909,399.1477273,88,13.34466062,8.959884876,0.741076171,0.888888889,0.564102564,-0.310967093
+1591,17363.14444,824.7,501.6333333,1077.877778,14777.47778,635.5777778,814.1555556,1599.588889,8426.344444,499.1222222,1077.188889,1763,11735.34444,1255.066667,6578.055556,3433.833333,4268.588889,1181.077778,354.9444444,3204.977778,7887.677778,3131.355556,1938.5,890.6,8988.511111,611.6,123.7,4215.044444,7682.133333,1580.877778,687.5111111,2809.888889,6431.3,741.8777778,277.6888889,8383.955556,5264.155556,1450.088889,395.8666667,1389.8,3961.088889,1313.155556,158.7777778,6400.4,3376.311111,1240.733333,580.8111111,3252.1,793.8666667,397.6333333,90,12.55626196,9.184180669,0.681903376,0.989010989,0.692307692,1.157772083
+1592,12924.08029,743.9562044,639.8248175,1112.875912,6574.145985,398.459854,293.2116788,1153.605839,3182.605839,330.0875912,265.2773723,1618.109489,5022.218978,832.8759124,3400.343066,1383.211679,1817.510949,870.5839416,249.5547445,2372.956204,3269.686131,1979.080292,77.65693431,467.7153285,3818.540146,266.2481752,91.06569343,4934.956204,3111.824818,1125.642336,606.1970803,2779.423358,2462.131387,448.2262774,175.7956204,3940.211679,1809.379562,558.4160584,300.9416058,1252.270073,1016.605839,510.8540146,123.8540146,1113.218978,971.9562044,804.8467153,77.01459854,2889.058394,1026.255474,399.2043796,137,15.12780469,11.6734327,0.636042397,0.971631206,0.752747253,0.597990167
+1593,45699.74713,934.3390805,571.2643678,1157.982759,9320.873563,430.637931,254.3333333,1218.011494,3559.41954,351.3563218,475.7931034,1619.45977,6631.258621,872.5,3426.166667,1805.683908,2410.977011,906.3045977,266.5804598,2482.666667,4315.126437,325.7528736,286.5632184,385.6896552,5135.683908,279.3390805,97.74137931,3243.33908,4006.201149,1276.701149,528.9885057,2771.281609,3032.252874,484.2988506,182.7988506,1606.729885,2050.436782,627.591954,309.5632184,1259.063218,968.045977,540.3965517,124.7528736,1619.04023,1063.787356,828.9942529,411.316092,2892.482759,1114.08046,401.4597701,174,16.6781625,13.44923172,0.591373625,0.97752809,0.644444444,-0.231697471
+1594,32005.79231,931.2307692,514.5,1102.315385,28168.69231,732.5769231,554.4461538,1555.246154,16433.16923,587.6846154,665.8461538,1760.053846,22559.3,1424.623077,4873.438462,3207.430769,8077.053846,1351.153846,383.1538462,2631.646154,13967.69231,451.3,798.8538462,567.3692308,16231.13846,427.4076923,134.4384615,3243.361538,12552.73077,1701.176923,917.2538462,2792.184615,10949.7,619.6692308,289.3307692,1928.146154,8847.292308,1048.484615,444.7615385,1328.346154,6682.153846,831.9,174.9769231,3534.376923,5753.815385,1353.284615,878.3923077,3183.415385,568.7615385,399.7923077,130,15.49930785,10.89893759,0.711003306,0.955882353,0.677083333,-1.263554391
+1595,24184.32468,900.961039,525.3636364,1089.558442,20387.03896,692.961039,562.4675325,1541.662338,11241.75325,555.7922078,740.5064935,1847.012987,14677.55844,1240.155844,7961.792208,2721.493506,5354.480519,1295.636364,351.9090909,2560.558442,10783.67532,407.9480519,2022.441558,562.0779221,11321.11688,568.1168831,123.8051948,3204.87013,9238.207792,1802.675325,791.7272727,2848.025974,8020.051948,786.3376623,271.6233766,1454.896104,6216.051948,960.4805195,425.1818182,1362.857143,4761.116883,1116.311688,160.3116883,4213.207792,4219.584416,1252.168831,165.8181818,3278.558442,402.4545455,398.8831169,77,12.71051824,7.783359938,0.790582278,0.93902439,0.802083333,1.500410943
+1596,42437.76923,855.0384615,494.8846154,1112.75,36897.23077,728.9615385,670.3653846,1588.769231,20561.5,554.0961538,1012.75,1793.346154,29080.17308,1377.057692,5612.423077,3245.25,10393.73077,1320.192308,360.1730769,2688.653846,21286.21154,572.6923077,179.0384615,691.5961538,25028.5,424.9615385,122.6153846,3526.384615,19322.53846,1651.442308,783.6153846,2792.807692,16848.44231,698.4230769,299.1730769,1876.576923,13840.44231,1045.25,432.1730769,1292.057692,10465.61538,675.6730769,168.2115385,2966.307692,9004.596154,1390.192308,242.8653846,3192.711538,604.2307692,398.6538462,52,9.367861827,7.142296238,0.647076068,0.962962963,0.722222222,-0.629920925
+1597,25195.57971,940.8405797,553.7101449,1091.73913,21927.01449,684.8985507,463.3478261,1581.666667,12317.94203,532.3478261,426.6811594,1777.521739,17583.71014,1245.884058,4529.637681,4314.565217,6116.710145,1228.144928,349.115942,2410.144928,12327.50725,487.5072464,903.3768116,491.2318841,14250.30435,383.0434783,120.5942029,2498.855072,11781.94203,1411.057971,684.1594203,2817.333333,10075.26087,629.1014493,257.5072464,7349.057971,8325.521739,853.9275362,406.4492754,1337,6123.681159,887.1594203,163.3768116,4573.304348,5167.637681,1278.15942,1195.753623,3320.173913,776.1884058,399.6521739,69,10.44422323,8.611251703,0.565863397,0.958333333,0.627272727,-1.015500804
+1598,13963.67544,742.377193,677.0701754,1111.315789,11957.87719,603.2982456,955.1140351,1717.201754,5938.605263,457.4035088,922.8947368,1812.850877,9804.631579,1242.377193,7318.517544,4005.482456,3516.342105,1143.692982,326.1491228,5973.763158,6540.412281,518.6140351,355,1069.5,7984.131579,492.3508772,116.5263158,5871.429825,6418.666667,1838.947368,742.1491228,2810.807018,5164.166667,562.9736842,253.3070175,18827.10526,4270.596491,1181.535088,385.622807,1327.017544,2799.315789,692.2631579,161.1491228,7891.912281,2539.236842,1141.754386,250.5438596,3193.947368,965.5175439,401.5526316,114,14.40639878,10.44884482,0.688441437,0.919354839,0.581632653,0.685048442
+1599,47771.1,959.9166667,617.3166667,1151.783333,44016.31667,761.9833333,688.9333333,1731.85,25087.83333,613.7833333,626.35,1795.083333,34512.76667,1391.666667,7238.45,6914.466667,12521.26667,1463.183333,412.6666667,2676.55,25048.5,471.1333333,131.65,587.3833333,29640.23333,459.1833333,137.95,5516.333333,24283.95,1711.366667,826.15,2830.55,20298.11667,639.4833333,331.5333333,2404.85,15226.61667,950.7833333,475.3666667,1304.183333,11928.1,659.7833333,188.4833333,4501.066667,9960.3,1464.9,154.9666667,3271.3,265.1666667,401.1666667,60,12.41461154,6.627357305,0.845588506,0.909090909,0.545454545,0.573419527
+1600,45312.79389,1006.21374,551.1450382,1104.725191,40128.43511,769.4122137,605.1984733,1614.755725,23032.8626,625.8625954,470.129771,1770.954198,31750.99237,1400.122137,4510.526718,3422.091603,11447.71756,1446.290076,402.7938931,2388.038168,22039.91603,440.3969466,164.1984733,448.8625954,26082.15267,456.5419847,133.6793893,3410.78626,20592.0687,1546.274809,961.6641221,2833.206107,17411.9313,631.8396947,311.7633588,1830.167939,13827.67939,894.4274809,471.0916031,1313.908397,10959.38168,673.2900763,177.1221374,3446.954198,9280.954198,1439.152672,131.5954198,3398.671756,328.4732824,403.3969466,131,16.48461782,10.5952461,0.766088317,0.97037037,0.582222222,0.861237026
+1601,34791.37956,890.8175182,531.3941606,1114.445255,31253.13139,733.8832117,697.5912409,1592.781022,18150.87591,593.0218978,1119.927007,1794.364964,25114.82482,1391.116788,4477.978102,4286.620438,8944.875912,1407.19708,384.7007299,2646.525547,16836.58394,470.4744526,254.8613139,1124.072993,19797.94891,583.1021898,284.0437956,3145.277372,15697.82482,1829.145985,851.6058394,2808.686131,13647.75912,672.5036496,304.9124088,2098.605839,11139.78832,1172.49635,467.5328467,1318.10219,8619.262774,872.8832117,175.9927007,3494.116788,7385.59854,1395.773723,358.7664234,3269.824818,541.1459854,402.2773723,137,17.52091192,10.21808179,0.812333276,0.951388889,0.671568627,-1.142299348
+1602,40415.37736,815.2264151,459.7358491,1088.943396,35650.90566,676,495.6226415,1548.245283,19866.84906,522.5471698,444.3773585,1695.207547,28541.67925,1299.830189,5197.283019,3188.433962,10499.32075,1317.566038,349.5849057,2427.132075,21077.26415,473,289.4339623,483.2075472,24931.4717,449.8679245,122,2813.150943,19155.58491,1465.641509,702.2830189,2806.735849,16663.01887,791.6226415,282.9433962,1806.981132,13711.56604,864.245283,415.3396226,1305.226415,10584.16981,715.0377358,161.1320755,2252.90566,8775.056604,1328.283019,296.490566,3169.188679,610.3396226,400.7924528,53,12.38217284,6.377725909,0.857146169,0.868852459,0.53,-0.813781332
+1603,35342.73874,876.8108108,582.0990991,1129.342342,31959.79279,705.7027027,613.3513514,1663.459459,17852.9009,572.2252252,466.9099099,1811.837838,24688.97297,1284.495495,9451.747748,5043.990991,9091.315315,1361.279279,388.5045045,2405.252252,18458.0991,435.2252252,725.990991,1342.153153,21611.2973,432.5675676,130.9459459,5821.756757,16920.81081,1516.738739,1206.216216,2810.468468,14807.3964,608.981982,307.6936937,2558.495495,11266.36036,1338.495495,446.1081081,1314.900901,8947.495495,868.1081081,181.5675676,4605.432432,7545.495495,1403.351351,172.3153153,3386.234234,298.6126126,402.0900901,111,13.47869741,10.61068073,0.616674098,0.956896552,0.672727273,-1.505671968
+1604,50808.54054,1095.918919,600.1081081,1185.189189,42724.32432,884.3783784,1383.216216,1755.675676,24820.67568,684.5405405,1779.162162,1830.756757,34633.48649,1593.621622,3076.108108,4922.297297,11871.62162,1530.891892,430.6216216,2697.081081,22343.94595,498.8378378,431.7837838,806.1621622,25728.37838,2161,139.1621622,3133.972973,20990.72973,2104.135135,864.3513514,2885.513514,17999.56757,684.5675676,326.0540541,1588.945946,14098.2973,1454.135135,514.7297297,1332.135135,10650.35135,770.3243243,183.3513514,4268.621622,9096.162162,1487.135135,194.1351351,3350.783784,480.0540541,399.8378378,37,8.512861498,6.074663154,0.700567119,0.902439024,0.528571429,-1.426861954
+1605,22674.61379,798.7241379,1056.351724,1184.82069,20510.51724,637.9862069,832.5931034,1807.358621,11227.87586,489.0551724,461.3793103,1856.744828,16554.88276,1227.351724,4280.475862,2489.848276,5923.103448,1212.57931,343.6551724,2583.62069,11685.68966,1489.213793,251.8827586,473.737931,13590.0069,429.6758621,119.9241379,5714.324138,10830.17241,1378.248276,691.2758621,2822.413793,9201.4,653.5586207,261.2551724,8618.075862,7721.944828,935.8206897,417.3310345,1336.496552,5513.972414,635.7517241,156.7172414,4586.158621,4764.875862,1217.172414,142.6551724,3227.482759,841.8827586,403.6137931,145,14.82219117,12.63327655,0.523017745,0.941558442,0.69047619,1.569998576
+1606,24729.40514,759.5723473,567.1543408,1101.418006,8665.353698,421.6559486,220.681672,1238.022508,3993.607717,344.4565916,240.2090032,1627.826367,6605.453376,854.4051447,2898.067524,1524.585209,2383.614148,894.9453376,253.9003215,2348.572347,4354.414791,2783.028939,174.0771704,375.2025723,5119.196141,281.9067524,94.53697749,4595.742765,4000.054662,1111.061093,627.681672,2773.453376,3195.745981,453.1961415,186.3890675,4495.524116,2360.308682,569.2186495,306.1286174,1257.154341,1269.398714,525.7138264,125.2186495,1193.736334,1208.099678,817.4244373,77.21221865,2879.643087,1042.604502,405.5787781,311,23.62213924,17.03099873,0.692959889,0.956923077,0.719907407,-1.313256958
+1607,45422.92271,905.7294686,574.8309179,1169.801932,42124.47343,754.9855072,688.6280193,1805.357488,21698.14976,582.1111111,2027.019324,1805.753623,31097.22222,1328.7343,7230.130435,5001.63285,11359.68599,1429.048309,403.8164251,2660.371981,22746.85024,439.1932367,188.0628019,1132.956522,27240.22222,441.8067633,384.2077295,5706.323671,20607.28986,1748.676329,619.5458937,2864.7343,17641.21739,626.5458937,322.1304348,10050.04831,11204.15942,958.6135266,459.4154589,1332.304348,9427.850242,660.8019324,182.3913043,3310.980676,7699.541063,1349.898551,491.7294686,3269.763285,182.9710145,405.8599034,207,18.08561417,14.96932426,0.561182141,0.949541284,0.608823529,-0.939746121
+1608,42595.10156,912.734375,639.9726563,1137.875,38412.6875,729.3476563,682.7929688,1732.53125,20434.41406,581.3828125,703.5429688,1806.636719,29440.79297,1332.90625,9704.394531,7267.046875,10731.82813,1431.5625,405.7578125,2561.765625,21627.14453,449.3945313,783.3320313,572.2460938,25552.14844,727.7578125,143.1289063,8961.433594,19954.35156,1619.78125,1066.808594,2816.921875,17251.23047,623.4492188,322.2304688,5215.308594,12220.62109,1001.1875,462.7148438,1323.8125,9826.570313,808.5820313,186.265625,4018.578125,7911.84375,1390.09375,221.984375,3304.746094,211.6171875,404.53125,256,26.81139835,12.57133911,0.883261667,0.895104895,0.568888889,-1.311221974
+1609,46262.35878,938.1450382,621.1755725,1161.603053,42614.20611,758.5648855,748.7175573,1766.068702,24008.27481,610.0152672,725.7099237,1790.007634,33140.16794,1391.954198,8207.236641,6558.656489,12187.23664,1464.862595,413.6870229,2793.946565,24102.22901,467.4427481,145.778626,926.9618321,29409.25191,452.8473282,142.7938931,5753.183206,23119.41221,1684.648855,860.3435115,2843.549618,19898.60305,643.6717557,335.4732824,2863.656489,14943.15267,939.0305344,481.7862595,1311.687023,11718.80916,666.6412214,186.7633588,2409.480916,9647.473282,1447.648855,161.9236641,3341.618321,254.5725191,403.9389313,131,19.47823175,9.680216007,0.867764218,0.770588235,0.574561404,1.464583882
+1610,15558.35593,714.8559322,468.1228814,1049.072034,13480.99576,580.5720339,585.0635593,1546.182203,7092.09322,441.690678,493.1228814,1798.25,10851.68644,1074.59322,6228.542373,3128.826271,3867.173729,1181.20339,327.6144068,2786.720339,7236.911017,1900.419492,1341.792373,500.8008475,8409.067797,376.2457627,116.3135593,5847.851695,6944.614407,1487.885593,657.1822034,2792.995763,5733.686441,944.4025424,245.7542373,14222.16102,4744.372881,729.1610169,366.4322034,1358.457627,3274.533898,956.3983051,149.0423729,3708.216102,2869.538136,1080.927966,222.2330508,3134.516949,884.1525424,406.3940678,236,18.65129469,16.72462097,0.442638257,0.904214559,0.653739612,0.353899404
+1611,36177.70588,817.1470588,434.5294118,1116.235294,30405.41176,676.9705882,418.3823529,1527.764706,17623.20588,529.2058824,514.7941176,1728.117647,24639.52941,1277.088235,2990.235294,1849.647059,8990.529412,1279.470588,346.3529412,2582.088235,17878.29412,449.5588235,131.2352941,508.5,20646.85294,415.5588235,121.3823529,1751.764706,16408.70588,1472.764706,655.7058824,2791.529412,13974.73529,766.9117647,255.5294118,1845.794118,11312.17647,842.8823529,409.6176471,1286.823529,8764.705882,653.6764706,160.4411765,2454.382353,7410.764706,1337.352941,438.5588235,3190.058824,618.5,401.3529412,34,6.597682302,6.571407079,0.089157869,1,0.944444444,1.570796327
+1612,34078.98361,779.147541,452.4918033,1074.786885,29886.93443,654.4590164,528.8032787,1516.459016,17409.03279,501.2131148,501.6557377,1763.770492,24675.2623,1238.147541,5296.278689,2305.57377,8778.57377,1286.032787,353.2622951,2441.196721,17813,434.2295082,668.4918033,557.5409836,20452.13115,387.3770492,128.5081967,2748.213115,16426.04918,1495.721311,836.147541,2788.311475,14389.88525,642.3278689,273.6885246,1730.196721,11810.95082,879.3114754,405.9344262,1298.196721,8700.377049,805.7540984,157.6885246,2340.032787,7547.180328,1306.622951,213.3934426,3182.04918,668.0327869,402.852459,61,11.41605326,7.14693827,0.779788675,0.897058824,0.616161616,1.442648151
+1613,42410.32143,933.0892857,850.7321429,1206.464286,34780.46429,767.9642857,877.0535714,1834.464286,21375.42857,578.375,558.3214286,1826.125,28651.07143,1450.267857,1632.642857,1239.25,10053.10714,1419.625,379.1607143,2451.25,20669.69643,593.0178571,176.5892857,520.25,23687.69643,460.8571429,172.3571429,1348.839286,19310.5,1584.321429,593.2857143,2817.5,16938.42857,1161.75,307.3571429,1535.392857,13393.71429,941.5357143,443.4464286,1315.821429,10061.21429,668.3928571,169.7678571,1224.982143,8715.267857,1479.607143,314.2321429,3242.410714,683.6964286,403.75,56,10.21725003,7.501744406,0.678907909,0.949152542,0.565656566,0.39446109
+1614,24414.26316,833.6184211,496.9736842,1096.618421,20729.81579,682.8947368,850.5526316,1545.855263,11978.89474,516.7894737,871.6578947,1782.223684,16616.84211,1266.894737,4067.644737,4137.815789,6157.460526,1232.684211,359.1710526,2718.592105,11887.96053,479.9605263,737.25,970.5131579,13300.81579,623.0526316,120.5,2579.25,11362.05263,1629.881579,656.6973684,2778.592105,9642.763158,695.1052632,264.1184211,2724.013158,7842.894737,1214.486842,412.75,1335.157895,5946.763158,847.5657895,169.8289474,5686.513158,4998.368421,1359.328947,1725.263158,3184.381579,759.3815789,402.1447368,76,12.78658577,8.035872475,0.777840971,0.915662651,0.730769231,1.532872141
+1615,8844.375,767.5576923,726.3653846,1403.701923,7441.615385,594.6346154,540.8173077,2250.875,4078.105769,452.4230769,471.4615385,1785.519231,6346.182692,1211.528846,9853.057692,3302.596154,2338.115385,1176.653846,330.1634615,2546.461538,4478.009615,542.9519231,192.5192308,471.3365385,5187.288462,388.7788462,123.25,13332.875,4439.326923,1329.721154,1119.096154,2803.25,3766.086538,614.625,291.7692308,43172.00962,3063.096154,813.8173077,378.7692308,1346.336538,2112.182692,853.1346154,154.9519231,8300,2028,1131.048077,195.5961538,3208.846154,920.6153846,405.0192308,104,12.43160777,10.79911148,0.495370489,0.981132075,0.666666667,1.202654967
+1616,23976.52614,793.3856209,587.7418301,1133.395425,19899.78105,635.4738562,745.3888889,1809.091503,10193.44118,470.2745098,2148.630719,1790.25817,15835.34641,1232.565359,8767.088235,3695.346405,5659.281046,1167.473856,338.6339869,6095.679739,10490.58497,700.3398693,374.2026144,898.245098,12580.3366,414.130719,123.9901961,7503.150327,10476.87255,1871.091503,760.5686275,2810.820261,8445.751634,555.0326797,283.4411765,28469.57516,6587.405229,1139.503268,394.2418301,1370.584967,4163.179739,709.2352941,160.2418301,7969.336601,3872.767974,1155.643791,300.2843137,3190.70915,982.4444444,409.0065359,306,23.33598011,17.72510513,0.650435838,0.916167665,0.633540373,-1.273012078
+1617,44866.5098,904.7745098,581.9215686,1146.058824,41772.29412,732.8431373,928.2156863,1737.058824,22080.11765,592.3921569,724.9313725,1837.245098,31614.92157,1351.696078,6519.941176,5773.029412,11696.73529,1455.421569,404.6078431,3284.852941,22813.43137,523.9411765,140.7058824,962.4019608,28436.53922,459.3039216,138.8529412,4859.696078,21611.37255,1810,841.8333333,2821.088235,18834.55882,739.7941176,337.6372549,3544.45098,13663.40196,1000.029412,472.7156863,1335.45098,11006.80392,655.5196078,178.5784314,3346.764706,8912.294118,1417.294118,175.245098,3293.313725,238.8431373,404.745098,102,12.19208719,10.92748421,0.443495206,0.944444444,0.653846154,-1.360338299
+1618,25208.94286,1015.585714,614.0571429,1081.064286,23240.12857,721.6285714,591.6071429,1599.785714,12383.32857,609.0214286,567.2928571,1790.478571,17473.49286,1302.557143,6373.942857,4788.528571,6424.478571,1323.421429,368.4,2409.521429,13211.02143,430.6857143,292.4571429,462.8071429,14750.72857,617.1785714,132.4285714,5054.8,11398.39286,1491.735714,1047.285714,2814.057143,9716.214286,633.5357143,284.2928571,4250.435714,7481.564286,907.4357143,425.0785714,1327.321429,6206.871429,657.7142857,175.1642857,4037.821429,4894.514286,1309.728571,717.4714286,3403.114286,316.8,408.0785714,140,17.05258872,12.00055414,0.71045962,0.843373494,0.555555556,-0.203161204
+1619,24102.81633,899.5510204,495.2244898,1099.72449,21114.91837,743.877551,782.1428571,1520.326531,12382.26531,561.9591837,1785.795918,1795.94898,17679.87755,1405.693878,4050.408163,4286.214286,6162.357143,1332.734694,384.3979592,2949.785714,11576.86735,493.0408163,462.6428571,935.2857143,12907.5102,590.4387755,136.0204082,2137.612245,10702.45918,2086.632653,798.9081633,2835.683673,9235.255102,722.9387755,291.5,1864.591837,7502.091837,1283.693878,456.1326531,1321.05102,5751,737.0306122,188.8571429,5275.714286,5081.112245,1440.795918,1469.489796,3232.734694,471.1938776,405,98,14.10084679,9.209212868,0.757274744,0.907407407,0.636363636,-1.398445519
+1620,32709.17526,983.8659794,538.9072165,1086.041237,28709.92784,775.5876289,653.0206186,1530.360825,16600.63918,667.1752577,734.1134021,1769.865979,23500.69072,1444.257732,4391.505155,3761.061856,8312.814433,1448.494845,396.9072165,2507.886598,15515.03093,467.9175258,932.1340206,551.0412371,18284.39175,556.2061856,137.0721649,3790.14433,14604.91753,1837.907216,1011.268041,2814.041237,12557.56701,821.2164948,304.6082474,1767.731959,10286.72165,1009.453608,476.4639175,1386.793814,7865.268041,901.4536082,178.5876289,4079.268041,6970.402062,1525.639175,841.2680412,3303.56701,484.1546392,406.0721649,97,14.45478459,8.957831783,0.784827757,0.906542056,0.497435897,-1.010975912
+1621,15579.74672,698.5458515,375.1004367,1037.174672,14125.72052,573.9082969,385.6550218,1394.161572,7775.200873,450.4934498,386.628821,1730.200873,11309.10044,1154.720524,1670.803493,978.5458515,4183.611354,1140.90393,318.30131,2398.624454,8146.729258,393.0349345,131.1310044,473.0786026,9372.048035,370.5545852,113.9170306,1185.379913,7547.122271,1290.131004,591.3930131,2838.877729,6611.524017,608.4104803,229.7117904,1538.349345,5423.528384,734.9868996,372.2401747,1295.401747,4330.052402,609.7161572,149.0524017,2847.786026,3647.733624,1223.480349,1855.078603,3106.021834,645.7729258,408.510917,229,20.95136041,15.52303703,0.671606191,0.851301115,0.602631579,1.387235852
+1622,21131.33088,820.3970588,453.3455882,1050.551471,17955.92647,637.5882353,429.5073529,1438.235294,10430.93382,493.1176471,395.7647059,1707.367647,14685.26471,1239.419118,1560.558824,1032.602941,5305.875,1183.176471,335.9558824,2402.411765,10390.68382,440.6029412,156.7426471,493.6691176,11904.05147,374.9117647,115.875,1185.830882,9658.477941,1333.926471,533.6985294,2843.036765,8361.176471,615.8382353,243.4632353,1578.257353,6874.051471,747.3308824,385.1323529,1296.227941,5160.389706,615.5294118,150.5808824,1708.926471,4464.419118,1363.764706,10386.93382,3138.573529,713.2573529,405.9117647,136,14.75874734,11.83940841,0.597060753,0.957746479,0.747252747,-1.049863609
+1623,31114.80734,920.2752294,476.2201835,1094.53211,27115.10092,741.7981651,484.8807339,1611.321101,15894.83486,553.6697248,412.0733945,1730.137615,21703.88991,1370.504587,4262.009174,3898.59633,7677.082569,1314.733945,381.3486239,2477.477064,15628.6789,507.3027523,1116.651376,475.6697248,17693.6422,391.0366972,129.6330275,3419.486239,14513.02752,1534.504587,720.9816514,2791.770642,12780.88073,622.4220183,269.2477064,2040.458716,10367.22936,888.9266055,417.266055,1309.082569,7625.027523,878.0550459,166.3853211,2754.853211,6547.844037,1445.275229,2733.238532,3158.559633,727.7522936,405.7798165,109,12.5822346,11.14720682,0.463784398,0.915966387,0.644970414,1.201707899
+1624,32539.97436,794.3846154,460.6666667,1078.589744,27378.20513,641.4487179,917.2692308,1597.166667,16247.28205,506.0769231,1092.166667,1780.910256,22300.48718,1199.205128,2960.512821,2498.397436,8051.346154,1256.75641,351.1923077,3278.782051,15950.53846,2136,245.4358974,683.1153846,17938.82051,432.5769231,171.0384615,2131.602564,15315.70513,1520.230769,700.7692308,2849.230769,12872.08974,579.1538462,268.5384615,7355.089744,10518.35897,1309.679487,408.7307692,1318.089744,7547.179487,694.2435897,160.525641,2968.371795,6485.435897,1255.987179,244.3461538,3231.358974,804.0384615,403.5512821,78,11.92795586,8.671596405,0.686639901,0.962962963,0.619047619,-1.479610708
+1625,19913.95122,725.5505226,531.7665505,1080.745645,16777.85017,590.7735192,633.7665505,1727.902439,8509.254355,446.4181185,818.8919861,1797.118467,12977.80488,1219.574913,7999.752613,3426.912892,4859.275261,1116.334495,318.4146341,4689.947735,8889.390244,733.9094077,332.7909408,1771.874564,10482.40767,403.0557491,120.7874564,7832.989547,8743.062718,1525.358885,827.902439,2879.114983,7115.010453,556.7700348,254.9198606,18151.19861,5645.679443,971.6864111,375.2473868,1320.912892,3735.996516,744.8815331,151.4390244,5911.756098,3387.930314,1096.996516,200.5853659,3202.341463,951.0418118,409.2125436,287,22.5964724,16.93872616,0.661870537,0.914012739,0.629385965,-1.329345053
+1626,24826.17486,826.8087432,711.557377,1183.874317,22309.16393,645.9180328,919.0382514,1834.606557,10710.85246,520.0491803,1077.786885,1836.437158,15099.83607,1182.612022,9930.174863,4947.825137,5834.759563,1247.928962,355.2896175,3564.295082,11282.56284,672.1311475,1558.442623,579.9016393,13368.81421,445.9562842,127.7540984,13339.83607,9743.836066,1833.994536,1022.803279,2805.579235,8291.874317,585.8032787,291.4863388,23364.02186,4969.344262,920.6830601,406.3989071,1360.098361,4080.333333,902.5956284,166.6721311,5804.535519,3440.606557,1176.04918,373.9180328,3286.393443,163.8907104,409.295082,183,18.11301748,12.98826286,0.69700335,0.943298969,0.677777778,0.581715192
+1627,29298.92079,844.8811881,562.4653465,1111.326733,27189.12871,700.2475248,593.6336634,1625.306931,14685.35644,556.9405941,555.4158416,1826.50495,21023.50495,1282.663366,7737.643564,4887.267327,7733.435644,1339.970297,449.3465347,2560.60396,15729.77228,433.7920792,1734.910891,485.4356436,17957.74257,432.8613861,128.6336634,4431.514851,13970.0495,1658.861386,938.6039604,2806.643564,12159.50495,656.8118812,292.7227723,2296.069307,9093.930693,936.7623762,432.4653465,1316.316832,7492.316832,1013.247525,177.1584158,5095.217822,6000.554455,1348.50495,221.0594059,3288.049505,286.5544554,406.8415842,101,13.16423901,10.68339945,0.584287062,0.834710744,0.647435897,1.454968638
+1628,40946.01205,989.4698795,534.3373494,1114.361446,33612.66265,752.9277108,551.939759,1614.903614,20423.83133,588.7108434,562.9156627,1758.048193,27376.68675,1362.204819,4272.843373,3623.60241,9822.421687,1325.903614,384.3373494,2572.216867,19499.50602,506.4819277,363.9036145,652.5903614,22041.25301,420.626506,126.0481928,3020.542169,18823.06024,1591.216867,665.6385542,2804.73494,16035.68675,717.7951807,294.1566265,2787.686747,12981.86747,994.5783133,447.3975904,1323.048193,9425.626506,715.8192771,161.2168675,2796.144578,8016.325301,1384.891566,1599.674699,3362.26506,768.4698795,406.4457831,83,11.05641257,9.964163542,0.43338004,0.912087912,0.628787879,-0.650125087
+1629,36052.89922,1001.728682,553.8914729,1113.658915,31199.26357,745.7674419,654.3333333,1610.496124,18235.34884,574.5503876,633.9379845,1755.875969,25450.12403,1332.147287,3841.976744,3157.96124,8868.875969,1294.48062,376.7596899,2480.945736,17843.13178,656.0155039,837.5271318,665.6124031,20585.9845,414.0930233,126.3100775,2829.868217,17152.51163,1599.976744,678.3100775,2813.852713,14620.65891,691.4031008,283.3023256,4863.953488,11990.4031,1021.914729,422.4186047,1329.697674,8708.550388,872.9767442,159.1937984,3118.069767,7219.116279,1345.705426,1866.170543,3400.325581,780.751938,407.7751938,129,18.09852438,9.744759174,0.842671276,0.908450704,0.551282051,-1.173420441
+1630,18258.14354,749.9760766,561.6794258,1094.277512,14263.50718,568.7942584,849.8229665,1605.789474,6998.69378,440.9330144,2294.210526,1727.22488,11336.33014,1084.349282,8576.105263,3711.913876,4083.090909,1092.430622,309.8899522,3584.401914,7572.497608,394.507177,226.8708134,2229.062201,9140.626794,609.0430622,113.6555024,7245.956938,7666.086124,1655.861244,697.4354067,2868.736842,6111.990431,515.0382775,246.1913876,18324.38278,4736.167464,2074.172249,366.1004785,1315.679426,2828.69378,632.9808612,160.1052632,6689.148325,2714.004785,1054.822967,268.6028708,3154.014354,1005.023923,409.1339713,209,17.50596914,15.2604416,0.489990285,0.976635514,0.768382353,-1.22203637
+1631,42892.98131,911.771028,576.8738318,1146.948598,38848.71495,755.0700935,678.771028,1724.542056,21904.71963,597.9485981,702.3971963,1816.079439,29914.50467,1372.915888,8790.785047,5293.53271,10828.75701,1442.196262,400.6682243,2724.158879,22126.6729,465.6588785,152.7102804,593.0934579,26198.1729,450.5654206,137.9345794,5386.154206,21044.87383,1764.214953,973.0794393,2819.242991,18037.93458,633.7943925,327.9719626,2266.71028,13624.95794,947.3411215,482.6448598,1310.238318,10489.25234,672.7336449,187.4392523,4601.85514,8932.990654,1449.051402,164.1495327,3345.761682,272.6168224,411.5607477,214,18.75669288,15.00600201,0.599953955,0.938596491,0.703947368,-0.485475641
+1632,35573.59494,893.9746835,518.5822785,1097.772152,32683.97468,715.3037975,618.8734177,1592.253165,18498.25316,570.7468354,556.0506329,1761.56962,25951.50633,1331.139241,4514.974684,2954.329114,9217.35443,1401.075949,394.8101266,2403.898734,17261.60759,414.4177215,980.5063291,456.2911392,20816.31646,424.4050633,128.8734177,2996.683544,16324.49367,1589.78481,810.3670886,2800.860759,13892.70886,673.556962,298.3924051,1523.329114,11001.89873,993.1772152,445.1772152,1330.506329,8804.746835,851.7721519,176.556962,3503.075949,7430.063291,1407.113924,624.2531646,3280.810127,350.8987342,405.1265823,79,13.81475308,7.658733737,0.832258321,0.897727273,0.705357143,1.501611359
+1633,26940.72258,948.4580645,623.7290323,1093.677419,14165.45161,571.6064516,350.7935484,1366.716129,7598.729032,518.0645161,508,1772.032258,11828.16129,1142.077419,7068.967742,2453.064516,4351.619355,1246.180645,334.9870968,2484.329032,7943.451613,379.1677419,2477.303226,480.8,9881.754839,451.9483871,120.7548387,4786.877419,7677.793548,1823.516129,1050.483871,2853.941935,6525.664516,669.5096774,246.8064516,1480.122581,5361.922581,866.4387097,400.4258065,1350.767742,4306.135484,1344.703226,164.1935484,3167.722581,3638.948387,1197.883871,142.3354839,3273.606452,400.5612903,407.6967742,155,19.23779284,10.97865779,0.821171304,0.928143713,0.596153846,1.230643964
+1634,29356.4375,877.15625,669.975,1118.60625,25673.26875,713.275,649.41875,1597.86875,14638.61875,569.8125,682.26875,1801.9375,20319.59375,1344.50625,4754.26875,3059.70625,7472.4875,1369.5,379.4125,2466.1,14123.9,456.68125,338.8,637.85625,17010.85625,441.825,197.26875,4202.5625,12954.5875,1624.70625,915.34375,2819.36875,11379.65625,655.40625,286.6875,1868.71875,9166.38125,980.575,455.9375,1328.125,7242.1,718.76875,175.425,4272.2875,6057.4125,1377.41875,220.69375,3360.075,509.2125,408.29375,160,17.25117086,12.7512344,0.673538849,0.898876404,0.533333333,1.374700006
+1635,31650.12791,788.7267442,465.5290698,1077.040698,26437.25,666.0581395,882.0988372,1508.139535,15177.30814,535.1686047,1557.261628,1848.325581,21255.72674,1278.465116,6253.436047,3799.819767,7834.273256,1279.156977,347.7267442,2844.726744,15604.01744,460.1162791,601.7151163,1385.424419,18242.66279,426.0406977,121.4302326,2971.348837,14360.40698,1903.19186,695.1627907,2794.319767,12299.37791,724.2093023,270.8837209,1728.866279,10010.93605,1228.186047,420.3081395,1319.593023,7792.25,811.3546512,162.4360465,5481.418605,6608.366279,1338.273256,596.0697674,3196.255814,596.4127907,410.6046512,172,19.15057538,11.67109075,0.792833635,0.92972973,0.597222222,-0.602286151
+1636,45768.16418,927.880597,614.3731343,1141.19403,43909.23881,763.5074627,497.2835821,1780.716418,22935.46269,598.6268657,543.1492537,1806.134328,32331.8209,1377.014925,6893.358209,6313.776119,11988.92537,1468.253731,411.7761194,2416.567164,23490.37313,460.2835821,135.761194,455.3880597,28812.01493,517.761194,137.761194,6348.865672,22073.37313,1545.791045,996,2856.268657,19104.02985,668.3134328,323.9701493,5378.701493,13850.1791,986.6119403,473.8059701,1321.462687,11018.20896,663.6268657,186.238806,2949.865672,8932.164179,1440.850746,174.0597015,3264.522388,224.7313433,408.5522388,67,13.43225628,6.983127225,0.85424085,0.893333333,0.515384615,-0.403419657
+1637,36804.85,925.89,601.82,1142.17,33151.17,747.97,616.47,1732.16,18800.97,594.26,489.91,1807.41,25335.77,1356.26,6435.46,5225.04,9473.34,1424.86,392.62,2406.56,18863.05,454.15,433.21,474.14,22071.61,449.43,137.42,5338.36,17121.1,1529.47,1137.75,2829.77,14815.73,625.34,317.22,2376.28,11521.47,906.24,476.04,1313.16,9036.91,735.14,192.39,4460.77,7622.16,1434.93,162.24,3387.29,306.76,409.77,100,13.09817096,9.811723467,0.662466984,0.961538462,0.714285714,-0.220708504
+1638,21720.20721,791.3783784,542.2072072,1069.027027,21151.99099,663.0630631,568.8198198,1540.036036,11480.73874,520.2162162,745.3693694,1806.981982,15609.01802,1196.621622,5073.459459,4329.144144,6048.81982,1321.414414,370.8018018,2577.747748,12109.21622,398.4954955,2453.387387,600.4144144,13489.85586,609.6846847,124.6126126,3980.765766,10257.87387,1725.882883,868.1441441,2812.783784,8822.027027,902.6486486,269.1261261,1692.504505,7243.765766,970.5855856,418.1891892,1360.738739,5738.288288,1253.306306,169.6576577,4764.801802,4822.990991,1285.963964,159.8648649,3251.234234,380.1351351,408.5585586,111,13.29603086,10.91094376,0.571479117,0.925,0.569230769,-1.25148842
+1639,26252.06316,796.2105263,571.9789474,1091.547368,23014.43158,667.9789474,568.3473684,1563,12990.63158,528.1684211,605.8105263,1796.905263,18776.98947,1273.336842,4091.168421,2382.2,6728.305263,1558.484211,342.5684211,2457.547368,13225.29474,500.8105263,1231.294737,631.4105263,15155.16842,417.2105263,132.9368421,2314.726316,12247.76842,1686.105263,933.5473684,2836.368421,10564.32632,832.2526316,263.9263158,1666.305263,8455.389474,971.8421053,394.8736842,1327.073684,6611.284211,939.3789474,160.0315789,2694.336842,5632.252632,1316.473684,364.7263158,3209.221053,677.9052632,409.4526316,95,12.24312329,10.14993436,0.559201968,0.989583333,0.659722222,0.847739857
+1640,27151.24176,993.8901099,480.2527473,1105.032967,24542.91209,724.7912088,494.8241758,1597.835165,13878.62637,593.7692308,565.3846154,1766.835165,18425.15385,1312.813187,2420.461538,1687.659341,6749.373626,1337.32967,373.6593407,2397.791209,13729.71429,411.1318681,247.3186813,484.978022,15708.47253,453.043956,128.5274725,2246.087912,12198.25275,1492.054945,742.4945055,2862.637363,10421.79121,952.3406593,304.7252747,1731.087912,8282.043956,873.989011,432.5494505,1306.703297,6596.934066,677.4615385,171.5494505,2256.230769,5535.43956,1336.879121,540.3186813,3377.318681,342.2967033,410.3076923,91,12.24739252,9.755304715,0.604610931,0.947916667,0.541666667,0.279486413
+1641,36752.98936,1019.191489,583.1170213,1134.521277,33896.94681,825.106383,793.606383,1742.382979,19582.12766,638.5744681,973.2765957,1770.819149,28148.70213,1552.06383,7767.159574,5148.723404,9931.829787,1491.12766,412.4361702,2479.43617,17406.93617,474.2553191,395.7446809,674.1808511,20549.5,1006.43617,140.7659574,5879.882979,16137.02128,1666.946809,832.7021277,2815.840426,14205.03191,693.606383,327.7446809,2045.255319,11591.21277,1103.914894,490.3510638,1336.553191,9086.712766,782.6276596,190.0957447,4966.978723,7634.957447,1499.946809,428.787234,3347.5,434.9574468,409.2978723,94,13.19830546,9.426916357,0.699888598,0.94,0.61038961,1.194876722
+1642,19496.7549,994.6176471,522.1764706,1090.009804,17487.87255,768.627451,595.2254902,1487.872549,9564.970588,592.8137255,878.9803922,1782.480392,14649.51961,1522.392157,3261.656863,3218.039216,4857.519608,1372.558824,391.1862745,2585.892157,9939.656863,469.9411765,687.8137255,742.4117647,11927.71569,665.6862745,136.9117647,3030.607843,9465.823529,1653.392157,896.0588235,2822.166667,8320.911765,1082.892157,300.8235294,2318.627451,6918.372549,1080.509804,471.1666667,1346.245098,5422.617647,832.5294118,189.2745098,4577.382353,4802.480392,1586.058824,2545.823529,3126.196078,459.127451,410.745098,102,15.08053493,8.828625759,0.810721608,0.971428571,0.607142857,-0.683945204
+1643,21048.81197,811.8717949,498.3418803,1073.837607,18866.22222,651.2735043,552.0512821,1490.470085,10746.52991,623.2820513,708.3504274,1764.393162,15246.7094,1251.692308,4136.444444,2896.051282,5552.786325,1540.794872,383.6837607,2681.948718,10843.83761,434.0769231,738.991453,684.5470085,12621.36752,405.7863248,124.982906,2161.179487,9835.65812,1727.418803,761.1282051,2800.923077,8619.769231,726.5982906,258.4529915,1661.25641,7106.316239,940.4786325,430.9059829,1359.376068,5607.059829,991.3162393,168.1367521,2983.794872,4813.717949,1408.213675,230.8632479,3222.162393,529.0940171,411.1282051,117,18.00605189,9.371346094,0.853888883,0.790540541,0.491596639,0.537914453
+1644,32209.48,823.272,474.456,1070.48,27462.8,669.68,521.168,1513.336,15334.464,633.648,755.504,1793.368,21881.928,1284.528,5306.416,4041.296,8070.464,1286.128,388.976,2520.488,16114.664,463.272,677.048,709.248,18825.592,579.352,162.232,2195.76,14780.264,1828.584,681.44,2814.272,12794.032,694.56,270.304,1851.6,10238.64,966.544,407.376,1318.744,8147.192,933.288,158.944,3703.68,6847.176,1312.472,209.424,3212.336,608.48,410.848,125,18.80724843,8.733804592,0.885633415,0.925925926,0.520833333,-0.74916905
+1645,35297.14667,790.8133333,423.08,1069.893333,30172.44,644.3333333,1016.48,1503.173333,17621.37333,524.6933333,2047.76,1841.893333,24678.77333,1304.6,3612.533333,2213.64,8640.613333,1296.44,359.4933333,2814.16,17730.64,461.8266667,441.8266667,580.0266667,20061.86667,407.56,281.52,1424.653333,16132.25333,1832.853333,597.7466667,2828.586667,14074.68,616.0266667,263.68,1653.893333,11329.09333,1256.68,404.2533333,1310.28,8429.666667,724.6,159.1733333,3578.52,7214.253333,1355.266667,2110.573333,3179.6,696.1733333,408.2133333,75,12.91014846,7.477021095,0.815215022,0.974025974,0.576923077,-0.977029481
+1646,21917.92,1100.32,579.4666667,1090.773333,19136.24,699.6933333,913.96,1520.48,10746.94667,551.92,1567.533333,1721.306667,14686.78667,1231.88,3923.12,2298.213333,5220.893333,1183.56,342.36,4296.226667,10360.84,494.9066667,636.0266667,1048.6,12012.02667,403.24,124.8933333,2998.213333,9917.293333,1704.12,536.6666667,2792.533333,8313.906667,576.24,269.4133333,15855.36,6845.253333,1291.813333,387.9866667,1363.253333,5138.066667,822.2266667,153.0533333,4145.586667,4270.906667,1180.373333,414.2266667,3374.106667,794.8133333,408.4933333,75,10.45132168,9.399201367,0.437267766,0.9375,0.619834711,-0.234138321
+1647,42924.35294,995.6431373,538.145098,1112.756863,39979.23529,780.9215686,880.7843137,1633.360784,22534.62745,627.0156863,1649.72549,1829.352941,30600.16863,1407.819608,5609.384314,3409.498039,11004.01176,1430.603922,406.572549,2682.023529,21691.97647,466.0470588,945.1294118,897.7803922,25524.68627,990.8627451,136.572549,3272.643137,19705.86667,1996.207843,785.1137255,2867.184314,16958,713.1764706,319.1803922,1488.101961,13749.15294,1302.043137,475.2509804,1326.329412,10695.82353,828.1372549,185.5333333,2956.180392,9091.760784,1429.772549,169.1568627,3402.462745,386.0588235,417.5098039,255,26.38857935,13.39979873,0.86148218,0.86440678,0.461956522,-0.824556071
+1648,28983.52727,784.1454545,434.9545455,1075.090909,25056.65455,678.8545455,665.1454545,1503.145455,14491.81818,526.5181818,1722.418182,1766.354545,20082.28182,1248.263636,5436.018182,2930.536364,7382.990909,1270.136364,345.9636364,2476.809091,14542.18182,433.5545455,703.1909091,1784.6,16887.76364,412.4363636,517.8,2253.245455,13407.36364,1876.390909,726.6363636,2787.427273,11631.01818,715.5181818,265.0272727,1597.3,9313.009091,1125.318182,404.4090909,1313.927273,7204.845455,801.3272727,153.9545455,3666.718182,6183.845455,3208.009091,909.7454545,5612.136364,663.6363636,410.6090909,110,13.7634294,10.64672741,0.633732915,0.924369748,0.654761905,-1.455766517
+1649,21165.61935,781.3419355,559.083871,1096.083871,18253.10968,622.6580645,799.8064516,1625.774194,10192.33548,484.2064516,1091.206452,1790.167742,14752.40645,1164.36129,4856.045161,3518.058065,5310.341935,1178.670968,342.5354839,4243.019355,10051.4129,1077.535484,641.0967742,840.9419355,11827.94839,496.9677419,121.2387097,4257.548387,9348.987097,1515.767742,712.2709677,2823.387097,7818.941935,575.883871,269.3483871,14824.91613,6460.554839,1506.529032,391.0516129,1323.935484,4500.606452,764.0129032,164.1096774,5233.941935,3872.270968,1192.567742,267.0580645,3211.677419,857.6193548,412.4967742,155,18.02081439,12.16351863,0.737844689,0.861111111,0.569852941,0.918264844
+1650,28563.19512,1175.284553,663.3577236,1138.308943,16192.66667,590.6829268,408.3495935,1437.414634,9208.512195,472,516.3495935,1761.341463,12513.50407,1147.910569,4097.373984,2206.552846,4964.349593,1251.398374,344.8780488,2450.154472,9592.97561,378.6422764,652.1463415,518.0325203,11236.43902,385.7398374,125.2601626,3619.764228,8678.780488,1592.861789,753.3170732,2858.853659,7663.536585,813.2926829,256.9105691,1449.195122,6417.414634,883.5853659,427.300813,1346.065041,5029.292683,751.0813008,166.5772358,4255.682927,4287.195122,1258.894309,187.4308943,3286.195122,420.3821138,411.7398374,123,13.76347642,12.2012772,0.462734807,0.866197183,0.727810651,-0.644629544
+1651,19016.8125,1069.104167,532.6041667,1032.708333,17923.70833,748.1041667,731.125,1389.5,8375.854167,585.3958333,1317.604167,1770.791667,13398.22917,1283.0625,7244.125,3210.9375,4580.395833,1178.5,310.9166667,3255.833333,8796.479167,397.2291667,121.625,782.3541667,10069.22917,375.1666667,144.4375,2406.958333,7672.291667,1729.375,599.9791667,2784.541667,6556.145833,568,221.4791667,1643.4375,5294.770833,901.5833333,363.7916667,1298.958333,4436.4375,575.6875,137.1875,2773.895833,3402.104167,1125.1875,234.5833333,3360.041667,617.75,410.5833333,48,10.57357914,6.305155017,0.80275256,0.842105263,0.6,-0.352305787
+1652,26860.89437,917.2042254,513.1619718,1088.084507,22690.87324,721.3028169,564.1408451,1596.176056,13444.49296,556.6619718,401.1971831,1694.711268,18201.53521,1348.422535,2587.922535,2138.323944,6783.408451,1277.65493,367.2394366,2400.429577,13521.01408,488.5422535,452.0352113,479.2112676,15437.51408,414.7464789,122.7183099,2052.077465,12843.12676,1418.71831,618.6830986,2811.147887,11038.0493,720.1901408,274.8380282,2030.5,9082.690141,934.5070423,431.2887324,1310.387324,6756.197183,733.7183099,166.5211268,2428.190141,5812.690141,1395.838028,1228.140845,3142.232394,754.4295775,411.9577465,142,16.1080637,11.54903092,0.697101949,0.934210526,0.642533937,-1.034660438
+1653,26940.26744,781.372093,500.9302326,1079.860465,18642.59302,570.4418605,663.6976744,1676.918605,10593.45349,455.755814,1446.860465,1828.255814,15092.46512,1107.151163,7787.94186,5035.453488,5479.081395,1165.790698,316.7325581,6515.290698,10467.55814,528.6976744,191.0697674,969.5697674,12019.15116,367.9767442,110.5348837,6548.081395,10050.09302,1698.790698,761.6046512,2790.197674,8337.581395,585.1744186,250.5,11244.94186,6738.72093,1319.813953,384.5116279,1305.790698,4671.418605,622.1860465,146.2209302,4343.825581,4099.72093,1119.5,249.9302326,3102.976744,873.0348837,410.3953488,86,15.19066395,7.825284359,0.857107406,0.914893617,0.551282051,0.829539813
+1654,42243.08824,909.9558824,642.9411765,1161.294118,40264.10294,741.4117647,505.2941176,1732.279412,21190.73529,580.2205882,499.8235294,1784.470588,30016.58824,1345.176471,6403.705882,8534.176471,11056.42647,1430.808824,396.8823529,2402.838235,21969.58824,453.8235294,131.6176471,437.25,26594.61765,449.3235294,138.0735294,5567.220588,20162.67647,1492.926471,882.4264706,2820.926471,17460.27941,633.9705882,333.6617647,3808.529412,12622.94118,907.6470588,454.7352941,1306.088235,10173.08824,679.7941176,186.7352941,3461.661765,8161.220588,1402.411765,141.8823529,3286.985294,231.7205882,411.6617647,68,9.766230904,9.248845829,0.321165585,0.931506849,0.618181818,-0.058163972
+1655,56704.5625,997.96875,629.0078125,1193.71875,53628.71094,799.3671875,559.1015625,1825.484375,29180.98438,631.796875,572.6875,1806.0625,41061.35156,1466.351563,6545.601563,6452.0625,14965.05469,1562.867188,434.1875,2631.765625,30035.73438,494.8359375,153.453125,553.2265625,37106.96094,471.875,147.5703125,4828.773438,28151.9375,1722.570313,964.4296875,2922.078125,24190.125,684.875,352.6171875,3665.046875,17711.71875,993.8515625,504.859375,1325.046875,14253.86719,683.609375,192.578125,2425.445313,11457.13281,1529.070313,149.671875,3378.898438,237.734375,417.3203125,128,21.86188465,8.164710149,0.92764314,0.882758621,0.421052632,-0.755154167
+1656,55519.97778,972.8888889,583.9555556,1165.222222,51299.24444,782.9555556,653.5,1774.788889,27172.32222,602.2333333,633.3666667,1769.933333,38779.32222,1400.655556,8454.533333,5483.944444,14063.21111,1493.511111,415.7444444,2524.577778,28241.72222,467.5666667,291.9777778,596.2111111,33593.02222,452.9777778,194.0777778,6894.844444,25878.36667,1661.088889,820.7,2850.433333,22046.74444,638.9111111,333.6,5244.955556,14963.75556,908.4888889,485.4,1305.711111,12224.53333,691.0333333,184.6333333,3127.777778,9987.933333,1466.244444,223.9666667,3310.355556,197.2888889,412.7,90,12.49642841,9.39962006,0.658952533,0.957446809,0.681818182,1.00993919
+1657,48243.58491,960.2830189,665.509434,1192.45283,44402.90566,776.9811321,614.7735849,1808.320755,24176.26415,627.5471698,525.9056604,1817.54717,34054.71698,1411.886792,7759.830189,7953.150943,12366.69811,1510.396226,429.3773585,2452.509434,25325.26415,474.8113208,142.8867925,455.3962264,30941.43396,463.2264151,146.3396226,6657.698113,23703.71698,1591.018868,991.2641509,2835.528302,20493.73585,641.490566,349.1132075,2111.358491,15247.24528,924.6792453,500.7924528,1302.773585,12328.81132,662.7358491,180.7735849,2526.849057,9894.849057,1486.396226,127.6226415,3352.584906,247.0943396,414.3207547,53,12.51498016,6.000152426,0.877575956,0.828125,0.490740741,-0.327200007
+1658,20807.77692,972.9,526.0615385,1082.930769,17858.93846,764.0538462,673.1692308,1540.323077,10329.23846,784.6076923,622.0769231,1742.130769,14805.76923,1388.207692,3625.746154,1965.253846,5266.561538,1400.392308,405.1538462,2418.1,10308.39231,468,1326.992308,677.1307692,12030.59231,464.4923077,134.7,2061.615385,9494.446154,1856.561538,730.5307692,2800.723077,8291.292308,1428.138462,290.4846154,1765.823077,6801.307692,1007.861538,445.1538462,1451.153846,5268.707692,1010.023077,180.6538462,3467.076923,4753.584615,1419.046154,477.9615385,3267.292308,488.1615385,416.5384615,130,16.9938574,10.05515234,0.806163125,0.921985816,0.601851852,-0.24832753
+1659,32311.21212,882.1969697,532.4242424,1098.19697,28579.84848,740.9848485,602.2575758,1697.651515,16422.21212,554.4545455,799.2727273,1786.651515,23094.65152,1397.227273,8157.863636,5374.409091,8236.909091,1356.545455,378.0454545,2799.424242,16627.56061,492.3030303,1136.848485,760.6818182,19434.07576,638.2121212,130.1363636,5515.575758,15559.84848,2057.121212,848.030303,2801.166667,13603.83333,736.2878788,282.7424242,2179.30303,11143.0303,1212.469697,432.3636364,1327.787879,8216.348485,955.3333333,170.6060606,3739.954545,7182.045455,1456.136364,3440.651515,3271.575758,721.2121212,413.3939394,66,10.37582488,8.84478539,0.522822356,0.904109589,0.6,-0.190021407
+1660,18264.43506,869.3766234,809.7337662,1142.603896,10791.32468,595.5194805,604.5454545,1660.363636,5770.064935,445.2272727,429.3766234,1848.272727,9017.928571,1101.525974,6158.577922,2607.201299,3200.75974,1152.88961,380.8116883,2528.779221,6182.727273,410.7272727,1732.915584,476.2337662,7309.623377,393.538961,116.2987013,6099.058442,5941.038961,1458.246753,601.9805195,2790.37013,4931.474026,752.4090909,235.2467532,8081.584416,4165.74026,863.8766234,373.5,1341.707792,2831.409091,1017.37013,147.5584416,3125.922078,2582.227273,1100.727273,173.5519481,3147.896104,898.8831169,415.2142857,154,15.04999464,13.08410225,0.494151383,0.944785276,0.684444444,-0.792881867
+1661,50150.72059,949.1029412,608.9117647,1184.735294,47590.67647,746.1617647,1050.573529,1774.529412,24489.29412,590.6029412,2035.088235,1809.941176,34559.07353,1354.970588,8302.647059,4124.102941,13077.39706,1425.647059,402.6176471,3977.529412,25971.47059,449.4852941,165.8088235,1016.367647,32241.76471,460.8529412,171.9852941,5265.132353,23859.72059,1988.970588,526.3235294,2825.764706,20381.51471,608.7058824,315.9117647,4154.5,13005.17647,1068.926471,471.2647059,1314.132353,10696.25,665.4705882,184.7647059,2618.705882,9031.470588,1405.838235,473.8235294,3311.705882,174.8235294,415.7352941,68,12.17858796,7.526676119,0.786158167,0.871794872,0.53968254,0.053552819
+1662,53458.35897,955.8717949,614.025641,1182.461538,48434.97436,761.025641,526.025641,1796.461538,27243.94872,640.7435897,525.1794872,1816.974359,38076,1397,7649.487179,5867.897436,13999.84615,1495.846154,423.8205128,2478.153846,27635.76923,472.1538462,136.7948718,521.6410256,34069.58974,445.5641026,143.025641,6286.487179,26547.64103,1595.333333,806.1025641,2840.897436,22747.87179,643.6410256,340.7692308,2194.820513,16984.46154,926.9230769,487.3846154,1297.358974,13431.94872,679.3333333,200.6410256,3114.25641,11143.69231,1496.051282,128.5384615,3336.846154,254.3333333,411.0769231,39,8.541073762,6.063608681,0.70426703,0.975,0.722222222,-1.456416298
+1663,46552.52273,896.0227273,485.25,1111.090909,39645.29545,726.8409091,591.2045455,1589.454545,23353.68182,598.3181818,475.2954545,1782.704545,32443.54545,1366.977273,2921.295455,2751.25,11948.75,1466.045455,408.8181818,2392.886364,21597.65909,451,182.6363636,566.7045455,26111.77273,448.25,133.9772727,2569.181818,20591.65909,1515.704545,913.3409091,2838.613636,17519.61364,634.2954545,312.3409091,1776.136364,13962.70455,978.4545455,465.8409091,1305.886364,10855.54545,679.8409091,187.8636364,2945.477273,9517.886364,1448.204545,145.2727273,3292.75,327.5,412.2727273,44,9.123791589,6.290178408,0.724356198,0.956521739,0.628571429,1.346927166
+1664,22838.53968,991.2857143,601.2380952,1088.698413,21072.03175,743.1111111,528.1111111,1537.468254,11678.71429,581.8333333,659.484127,1795.18254,16793.5873,1315.103175,5199.873016,4283.793651,5873.595238,1326.801587,435.3888889,2472.738095,10434.0873,408.1825397,2272.095238,659.4444444,12240.92857,468.1190476,129.4206349,4900.039683,9771.111111,1656.52381,973.1904762,2797.992063,8299.626984,718.4365079,282.8253968,2198.515873,6520.460317,952.4206349,429.8650794,1384.134921,5329.079365,1154.555556,178.468254,7615.31746,4462.150794,1353.373016,528.7380952,3675.087302,351.3174603,415.8809524,126,15.91240995,10.48977219,0.751950495,0.933333333,0.642857143,-0.653531916
+1665,16402.11321,854.3301887,472.9716981,1059.490566,14751.33962,681.1981132,390.7169811,1430.386792,8019.273585,527.1037736,405.7735849,1713.45283,11932.5,1330.556604,1566.858491,1122.292453,4102.981132,1264.367925,359.4716981,2382.330189,8253.688679,444.6320755,324.0377358,472.8962264,9773.40566,473.2735849,130.6792453,1263.481132,7775.45283,1418.320755,795.1132075,2920.320755,6802.943396,785.2358491,272.1037736,2098.556604,5619.349057,845.6698113,449.0943396,1329.679245,4457.566038,689.754717,179.9245283,4877.301887,3995.95283,1413.216981,2817.981132,3205.792453,476.5849057,414.9433962,106,12.95584009,10.59273408,0.575782329,0.954954955,0.627218935,0.980270202
+1666,22968.13542,853.5208333,487.75,1071.177083,20923.45833,685.5833333,493.78125,1497.760417,11435.52083,649.2604167,763.0520833,1758.916667,16121.38542,1296.354167,3725.8125,2546.239583,5952.958333,1437.291667,362.875,2450.791667,11131.39583,481.1666667,1136.885417,727.2083333,13579.10417,438.7604167,144.34375,2441.4375,10233.625,1798.947917,817.0208333,2842.083333,9064.864583,783.40625,271.5833333,1688.4375,7484.052083,1065.125,427.8854167,1358.739583,6019.854167,978.71875,174.875,4196.28125,5041.416667,1331.427083,240.1666667,3239.0625,498.8333333,413.9895833,96,12.83303285,10.15055437,0.611853888,0.834782609,0.571428571,1.084534639
+1667,27503.02586,954.3103448,932.2586207,1187.844828,24977,805.0775862,1072.155172,1763.517241,13919.99138,612.9396552,1196.413793,1901.655172,19765.56034,1431.931034,3205.551724,3145.017241,7092.12069,1487.844828,391.1465517,2827.836207,13369.0431,507.112069,449.2931034,1178.689655,15454.17241,464.7241379,165.3275862,2100.586207,11819.11207,1843.887931,731.887931,2851.353448,10551.34483,694.4482759,300.0344828,1826.12069,8570.431034,1146.905172,472.7327586,1342.137931,6940.405172,763.4827586,182.7758621,3089.698276,5594.465517,1431.137931,308.1034483,3292.232759,518.362069,416.1982759,116,15.26970105,10.84559612,0.703930303,0.84057971,0.517857143,-0.513318394
+1668,26915.32967,868.956044,557.7802198,1092.098901,24117.27473,712.4395604,784.6153846,1577.076923,13848.3956,592.6043956,1503.373626,1810.527473,19964.31868,1367.241758,5051.89011,3512.945055,6852.527473,1414.615385,395.2417582,3255.406593,13760.46154,498.3516484,884.4395604,801.1758242,16409.76923,433.5824176,133.8131868,2568.593407,12878.6044,2079.197802,708.5164835,2817.065934,11076.37363,693.1098901,297.6813187,1725.43956,9025.131868,1343.153846,450.5824176,1357.230769,7037.923077,1467.10989,173.5824176,2520.758242,6210.417582,1548.78022,324.7692308,3175.593407,539.1428571,412.9450549,91,11.72259638,10.01358248,0.519924861,0.978494624,0.758333333,1.325805425
+1669,35360.63448,781.2965517,428.5793103,1072.97931,30840.06207,654.2206897,770.7724138,1542.055172,17811.08276,522.4275862,1032.22069,1757.324138,25313.84828,1277.324138,3611.37931,1925.903448,8950.172414,1406.765517,367.2344828,2835.751724,17777.92414,463.2896552,802.1103448,589.8,20654.3931,393.8275862,141.1586207,1301.848276,16579.17241,1698.662069,587.2068966,2821.22069,14261.63448,817.9172414,277.6275862,1576.648276,11461.31034,1001.186207,400.5931034,1310.089655,8540.717241,845.8344828,158.7103448,2690.282759,7396.331034,1306.593103,423.2,3170.77931,698.5241379,418.1586207,145,19.35511084,10.64289632,0.835246799,0.833333333,0.609243697,-0.511582422
+1670,20044.68,862.776,538.056,1073.752,17181.96,651.072,841.568,1541.792,9492.4,510.048,1313.248,1752.192,13552.504,1201.488,4725.544,2636.864,4859.328,1193.64,342.168,4235.784,9355.344,773.352,914.016,1180.728,10692.408,397.824,145.376,2568.776,8786.488,1852.496,556.816,2800.64,7366.552,602.592,278.768,24880.512,6119.648,1672.832,399.456,1340.344,4566.968,924.256,156.688,6218.304,3773.536,1196.016,825.376,3296.376,801.6,415.344,125,15.44909054,11.15169159,0.692065375,0.899280576,0.56561086,-1.261697284
+1671,22850.65248,726.070922,438.0921986,1058.858156,14810.94326,532.0070922,607.6099291,1439.70922,8117.12766,432.5248227,922.7092199,1747.957447,11991.90071,1029.822695,5676.170213,3582.829787,4286.014184,1061.836879,304.2411348,4984.312057,8040.638298,1858.035461,174.3687943,854.9503546,9328.815603,356.4113475,108.5815603,3618.184397,7546.120567,1667.319149,623.1702128,2803.446809,6259.659574,530.3404255,233.0567376,7922.992908,5084.929078,1091.070922,355.2340426,1296.574468,3511.014184,587.787234,140.0851064,3182.148936,3039.106383,1040.361702,193.5390071,3102.283688,869.5602837,418.9787234,141,16.0795664,12.71701934,0.611970309,0.87037037,0.552941176,0.596856589
+1672,21118.04386,795.9912281,641.4298246,1146.149123,14323.29825,600.4385965,589.8684211,1852.921053,7335.473684,454.5614035,1845.535088,1801.912281,11474.75439,1138.991228,9876.026316,3724.307018,4243.885965,1164.5,327.6842105,8038.754386,7873.035088,448.8070175,153.4561404,1190.631579,9593.070175,551.6315789,118.8596491,9810.710526,7886.210526,1529.184211,797.6052632,2789.833333,6454.45614,539.5701754,284.8157895,36589.67544,5227.938596,1280.605263,392.9210526,1427.526316,3426.570175,677.9824561,161.377193,8439.245614,3203.754386,1140.429825,359,3203.368421,964.9210526,414.1578947,114,15.7351718,9.648768623,0.789929603,0.897637795,0.633333333,-1.190294896
+1673,52390.83206,921.2061069,580.7480916,1171.801527,50594.8855,783.8778626,649.2748092,1784.450382,27011.55725,603.7099237,845.7633588,1817.740458,38105.25954,1388.061069,6854.389313,6738.206107,13792.92366,1494.984733,423.389313,2478.916031,27726.56489,470.9694656,202.3816794,690.7099237,33495.98473,532.1832061,147.0229008,5387.335878,26044.45802,1666.419847,842.7557252,2835.610687,22334.72519,648.8549618,328.8015267,5037.160305,15850.41985,986.2671756,475.3816794,1314.29771,12363.37405,691.0610687,190.5419847,4266.671756,10192.84733,1433.366412,222.2290076,3336.335878,215.8091603,417.2519084,131,16.33325449,11.05541386,0.736106861,0.885135135,0.592760181,-0.114820732
+1674,29995.85981,840.3925234,495.1121495,1086.542056,26460.38318,672.2990654,789.2149533,1537.616822,15641.53271,543.2242991,1189.074766,1776.831776,20717.73832,1262.682243,4700.121495,4077.663551,7978.074766,1349.317757,376.635514,3549.299065,15909.7757,445.364486,953.728972,1305.168224,17351.43925,452.6728972,131.3551402,2856.224299,13729.14953,2028.037383,786.7943925,2822.514019,11947.63551,672.588785,289.8037383,1486.869159,9504.271028,1257.327103,457.2149533,1436.280374,7214.579439,845.046729,178.2990654,4336.64486,6282.785047,1336.514019,205.4205607,3347.074766,370.8504673,416.3271028,107,13.46391057,10.36795704,0.637977023,0.963963964,0.685897436,-0.478813995
+1675,30931.59072,820.8860759,507.6962025,1101.485232,25988.23629,729.6455696,621.5864979,1616.898734,14675.43038,542.3375527,1673.054852,1815.046414,20580.37553,1303.451477,6519.400844,3597.974684,7400.409283,1278.767932,355.8649789,2572.725738,14699.1519,452.9493671,556.4725738,1225.417722,17178.92405,422.2236287,930.8438819,3524.919831,13303.62025,1989.135021,817.185654,2805.983122,11530.45992,675.9873418,265.4050633,1986.767932,9170.886076,1043.485232,404.7088608,1292.578059,7052.07173,742.185654,156.5485232,4895.49789,6091.666667,1291.49789,329.3755274,3242.257384,684.1561181,420.3755274,237,21.48099806,14.57776183,0.734475486,0.911538462,0.626984127,-0.592370124
+1676,39056.93333,885.9333333,493.2222222,1083.333333,31847.4,702.4,832.7555556,1572.688889,19845.53333,537.2666667,922.9333333,1746.488889,27534.66667,1281.622222,5693.288889,3302.044444,9639.111111,1277.155556,356.4666667,2824.466667,19246.02222,491.4222222,729.6,788.8,21699.13333,432.4888889,131.9333333,2878.777778,18974.11111,1843.933333,696.4222222,2804.866667,16076.31111,611.9777778,277.8,4987.444444,13262.04444,1273.511111,429.5111111,1321.711111,9161,845.5777778,168,3266.888889,8134.555556,1325.977778,904.4,3294.222222,788.6444444,414.0222222,45,8.534560882,6.913560582,0.58633822,0.918367347,0.625,0.164167986
+1677,18336.08108,788.8738739,1026.423423,1162.756757,16316.10811,637.7387387,851.6126126,1818.297297,8813.513514,476.9459459,506.3333333,1865.405405,13160.10811,1170.747748,5650.918919,3657.477477,4693.801802,1223.594595,338.8018018,2645.342342,8825.342342,1378.648649,1229.243243,513.4864865,10218.18919,448.3063063,122.8558559,5982.351351,8160.567568,1398.18018,768.6216216,2805.801802,6822.432432,584.8198198,265.6036036,9547.828829,5741.405405,982.6396396,400.7927928,1335.414414,4021.261261,926.0720721,165.5855856,4832.522523,3436.900901,1196.261261,177.8738739,3242.333333,846.4954955,415.0810811,111,15.59933996,9.236440802,0.805861126,0.932773109,0.630681818,1.036373348
+1678,47161.5566,917.1981132,592.8867925,1152.820755,39145.91509,716.5188679,667.2924528,1667.622642,21335.41509,581.490566,766.245283,1807.141509,30421.01887,1327.490566,7611.367925,5680.320755,11176.64151,1415.122642,397.1886792,2825.792453,22574.63208,453.5566038,133.5754717,738.3396226,27407.16981,439.6320755,132.1415094,4622.811321,21194.32075,1604.528302,823.6886792,2820.075472,18195.49057,629.3207547,316.8207547,3290.490566,13646.39623,897.2358491,462.0849057,1309.764151,10955.67925,656.6698113,184.7358491,3094.773585,8932.90566,1418.943396,171.509434,3297.235849,256.1886792,417.3396226,106,18.376479,7.988394918,0.900571658,0.828125,0.509615385,-1.073452378
+1679,45995.13043,899.9565217,542.9130435,1121.208696,42400.01739,758.8869565,691.6173913,1666.852174,23625.8087,600.1217391,790,1805,32357.24348,1372.895652,6793.634783,4211.721739,11729.74783,1445.643478,486.2173913,3196.356522,24290.33913,470.6521739,1016.947826,585.4521739,28207.2,443.9652174,139.626087,3637.782609,22210.75652,1846.895652,820.7217391,2816.147826,19294.32174,649.973913,325.6695652,1537.573913,14682.41739,1007.243478,477.2956522,1348.878261,11538.3913,855.1478261,231.1130435,2679.53913,9920.156522,1450.347826,239.0521739,3296.565217,284.5652174,418.2956522,115,14.987296,10.77038991,0.695387855,0.833333333,0.638888889,0.322672816
+1680,32610.7957,877.1505376,548.7956989,1111.247312,29504.10753,750.0537634,563.7741935,1643.344086,16150.6129,567.0322581,607.9032258,1839.247312,22082.21505,1290.763441,5592.494624,3732.365591,8254.913978,1346.655914,452.4731183,2818.688172,16621.16129,435.1612903,2145.827957,458.9462366,18893.16129,436.6236559,134.4086022,4016.795699,14766.01075,1753.731183,962.6236559,2817.236559,12920.69892,651.9139785,294.8494624,1887.215054,9780.247312,892.5376344,441.5053763,1348.72043,7768.333333,1096.032258,186.2150538,4338.182796,6432.623656,1368.494624,233.2365591,3247.655914,294,416.516129,93,13.14310451,9.825729694,0.664153991,0.885714286,0.553571429,-0.502770935
+1681,27926.35393,1051.410112,574.2865169,1094.814607,24745.93258,749.8651685,619.5168539,1573.853933,14254.67978,612.7921348,714.3539326,1793.921348,19546.44944,1318.949438,4943.370787,3173.061798,6912.55618,1377.949438,359.7022472,2452.022472,13515.41573,408.741573,292.2247191,519.1348315,15982.5,452.011236,130.0280899,4934.331461,12597.32584,1618.977528,859.241573,2815.089888,10766.55056,856.1910112,282.5842697,1888.634831,8441.544944,938.258427,438.2022472,1327.207865,6567.162921,665.9325843,170.7359551,3781.741573,5727.196629,1310.348315,278.3146067,3461.455056,337.0898876,421.6516854,178,18.88314526,13.88909433,0.677493621,0.89,0.523529412,-0.149647811
+1682,42666.78947,1096.789474,584.0300752,1164.548872,37876.95489,876.0300752,595.3759398,1685.639098,21963.17293,667.2631579,738.1203008,1761.766917,30647.00752,1687.473684,5702.586466,3655.977444,10811.24812,1617.93985,464.3759398,2478.315789,20813.47368,545.2857143,467.1954887,792.5338346,23880.54135,525.887218,160.0601504,3643.556391,19013.61654,1876.75188,803.2706767,2826.834586,16674.83459,781.2105263,355.0225564,1792.774436,13472.81955,1222.902256,543.2556391,1337.421053,10346.13534,811.5037594,216.6616541,3892.233083,8965.631579,1657.616541,326.556391,3339.473684,432.5789474,417.9323308,133,17.38217101,11.35231748,0.757270604,0.801204819,0.59375,1.409566118
+1683,29967.2126,792.007874,494.1338583,1069.031496,23246.4252,615.7244094,622.8110236,1462.03937,13444.50394,489.1102362,1129.110236,1735.858268,19478.04724,1206.622047,4184.133858,2792.070866,7123.283465,1284.385827,339.6377953,2754.582677,13783.19685,431.7244094,752.976378,1200.905512,16036.01575,685.1968504,117.8976378,1961.818898,12974.62205,1550.96063,592.2047244,2817.685039,11233.9685,716.8188976,255.511811,1618.188976,9060.417323,1135.401575,401.4488189,1335.220472,6773.566929,807.488189,156.0393701,3385,5978.582677,1276.787402,1648.496063,3130.76378,709.6377953,417.976378,127,16.21055169,10.79186455,0.746191946,0.808917197,0.566964286,-1.023507493
+1684,37940.15625,961.734375,457.828125,1102.015625,31804.64063,748.734375,612.21875,1654,18918.14063,572.421875,689.953125,1738.84375,26668.03125,1381.28125,3492.21875,3319.3125,9411.5,1310.65625,384.953125,2931.640625,19008.67188,495.625,529.09375,631.015625,21615.90625,416.9375,129.828125,2210.484375,18139.78125,1573.046875,789.65625,2780.375,15689.54688,674.96875,281.421875,2232.640625,12819.375,980.875,422.65625,1328.796875,9426.421875,767.53125,171.890625,3021.203125,7822.625,1400.15625,1148.828125,3219.703125,763.015625,415.921875,64,11.96174874,7.022464286,0.809531295,0.941176471,0.581818182,-0.937538921
+1685,10148.77778,695.4567901,519.3950617,1009.506173,7893.617284,532.962963,502.4074074,1504.765432,4431.506173,406.382716,452.5555556,1768.246914,6239.160494,1002.518519,6223.024691,3497.777778,2343.962963,1134.234568,308.6296296,2541.012346,4454.975309,882.2098765,883.7407407,469.9506173,5130.716049,366.0617284,106.8641975,6377.308642,4152.777778,1381.012346,835.691358,2785.876543,3462.024691,552.4691358,205.3580247,4215.148148,2775.419753,659.1358025,340.5308642,1294.333333,1838.395062,781.6419753,135.5061728,3091.135802,1643.592593,999.7037037,140.345679,3037.975309,912.617284,416.7407407,81,12.09597917,8.640796186,0.69978577,0.931034483,0.623076923,-0.343547262
+1686,42592,908.2937063,598.8811189,1147.062937,10404.7972,407.0909091,229.4615385,1174.727273,4010.573427,343.9230769,267.7482517,1589.608392,7355.846154,831.2377622,2391.916084,1230.811189,2623.804196,879.6083916,245.8741259,2351.888112,4654.041958,259.8461538,401.1538462,441.8601399,5525.713287,247.8601399,90.78321678,2873.293706,4215.202797,1145.671329,491.7552448,2768.377622,3204.167832,431.3986014,174.1748252,1391.951049,2176.20979,568.8531469,298.6783217,1253.335664,1003.727273,549.5664336,116.4195804,1013.776224,1092.601399,791.3286713,94.65034965,2808.13986,1110.608392,417.9440559,143,14.22194238,12.9199409,0.417990886,0.959731544,0.680952381,-1.259333188
+1687,16259.92737,709.122905,590.3407821,1114.201117,17032.73184,536.2849162,686.0558659,1581.569832,7983.357542,450.0837989,1080.888268,1748.402235,10756.32402,1038.111732,5396.307263,3425.256983,4414.435754,1087.597765,337.6201117,4008.340782,8365.418994,392.0558659,1440.318436,612.9441341,9790.944134,341.8379888,108.1452514,5867.435754,7504.631285,2029.586592,418.0949721,2803.603352,6244.402235,503.603352,247.7597765,10712.14525,3409.670391,847.3128492,365.1787709,1287.156425,2854.318436,793.4078212,148.1340782,3450.631285,2548.022346,1040.536313,279.7597765,3138.430168,139.9944134,419.4636872,179,18.53621985,12.47685348,0.739545395,0.917948718,0.658088235,-0.693672433
+1688,31886.6888,831.1493776,461.2614108,1076.738589,25090.89627,758.6182573,762.4813278,1571.701245,13962.82158,536.4273859,2263.356846,1807.103734,19781.74274,1272.356846,6336.634855,4683.647303,7207.962656,1259.593361,347.8838174,3055.13278,14352.41079,429.6431535,593.2406639,1980,16745.11203,1300.161826,198.8423237,2284.647303,13041.18257,1920.79668,631.9917012,2793.572614,11440.47303,638.9004149,265.8589212,1629.647303,9254.410788,1744.742739,392.0414938,1304.692946,7022.124481,759.7178423,159.593361,4714.153527,6085.697095,1363.560166,1369.020747,3276.771784,667.8547718,422.8381743,241,19.05327151,17.86349212,0.347836758,0.870036101,0.6025,-0.688993133
+1689,26631.33094,850.2517986,437.3741007,1069.726619,24843.69784,719.7482014,508.676259,1611.028777,13690.22302,533.2733813,511.5539568,1714.52518,19794.29496,1342.611511,3700.086331,3144.122302,6751.42446,1444.345324,369.6115108,2397.309353,13147.30935,461.9640288,1138.690647,611.3741007,15101.30935,404.676259,121.5539568,1674.769784,11986.02878,1461.985612,741.2158273,2802.863309,10497.97842,947.1079137,267.3669065,2046.014388,8755.467626,881.7266187,415.0143885,1333.482014,6482.244604,912.6834532,166.2158273,3389.402878,5530.460432,1380.47482,1164.359712,3109.273381,734.0719424,417.5107914,139,16.15620753,11.02711746,0.730856357,0.952054795,0.668269231,1.051458048
+1690,47814.32773,939.7563025,600.6218487,1160.302521,41780.12605,740.9159664,716.4537815,1743.865546,22923.70588,573.0168067,1318.193277,1838.571429,32093.86555,1344.310924,10888.52941,6816.638655,12183.65546,1435.352941,426.3361345,3212.89916,23974.69748,451.9495798,1133.176471,1116.537815,29394.14286,468.1092437,604.4369748,6312.445378,22146.31092,2262.613445,825.8907563,2818.890756,19048.70588,633.9663866,318.1008403,2722.159664,13636.95798,1044.848739,474.1932773,1325.252101,10943.55462,890.4537815,187.8067227,3502.512605,8960.588235,1409.689076,288.697479,3340.226891,206.2268908,420.6218487,119,15.99192773,9.885243114,0.786068374,0.881481481,0.583333333,0.083092711
+1691,41387.88,1014.8,601.4,1127.853333,36277.48,779.2,736.2533333,1711.546667,21168.88,633.7466667,568.5333333,1813.64,28353.56,1403.333333,5524.946667,3941.48,10240.09333,1450.613333,406.2933333,2452.093333,21696.84,485.88,657.4266667,485.2266667,24804.81333,489.3333333,138.6666667,4161.973333,19412.61333,1596.106667,905.6933333,2822.533333,16785.41333,695.6,318.44,3032.653333,13210.06667,964.76,474.9066667,1319.946667,10196.97333,730.6266667,185.1466667,3694.2,8685.72,1470.6,597.7733333,3413.493333,319.12,418.28,75,12.96627336,7.851387678,0.795827164,0.882352941,0.520833333,-0.776181509
+1692,17395.27027,750.1216216,406.3243243,1040.554054,15847.64189,622.9459459,443.7905405,1424.533784,8677.898649,475.1689189,404.2297297,1722.290541,12454.42568,1196.648649,1712.614865,934.8783784,4573.418919,1191.743243,328.777027,2437.621622,8993.614865,407.6621622,364.6216216,447.9054054,10714.60811,408.1351351,114.2635135,903.6756757,8324.432432,1356.459459,655.1081081,2851.702703,7274.925676,617.2837838,253.8513514,1767.398649,5894.75,787.0608108,399.6486486,1345.891892,4728.608108,709.6689189,156.4054054,2899.878378,4123.614865,1296.398649,1985.47973,3115.114865,581.5337838,420.2027027,148,14.40484321,13.36950767,0.372266525,0.95483871,0.616666667,0.779593628
+1693,23939.69412,830.6235294,553.8,1082.352941,21502.17647,666.6823529,499.3294118,1566.235294,11359.56471,521.0117647,725.4941176,1775.517647,17195.09412,1279.682353,6930.870588,4629.352941,6128.576471,1261.188235,340.8235294,3248.176471,12233,450.1176471,604.0117647,679.7882353,14164.35294,423.5294118,118.5764706,5088.482353,11009.35294,1776.235294,746.9764706,2775.635294,9525.447059,707.5764706,260.4352941,2325.635294,7697.929412,1011.717647,403.9529412,1341.917647,6339.152941,772,159.7529412,5891.517647,5230.152941,1294.964706,353.4235294,3239.470588,622.8235294,417.6117647,85,14.71088353,8.858230349,0.798379294,0.787037037,0.435897436,-0.953792396
+1694,21875.23958,770.0104167,442.0833333,1056.166667,19136.42708,626.8541667,704.875,1555.145833,10938.71875,503.1875,1862.020833,1779.1875,15837.21875,1225.96875,5968.614583,3799.145833,5820.645833,1196.010417,335.96875,2771.322917,11058.52083,4065.645833,1181.052083,1375.958333,12738.09375,440.8020833,116.8541667,1833.229167,10729.64583,1972.854167,556.8333333,2836.239583,9032.572917,615.6875,254.0625,2328.53125,7481.28125,1600.96875,399.4479167,1316.864583,5609.822917,922.6770833,153.7708333,2464.958333,4820.885417,1292.104167,977.6458333,3207.739583,779.6354167,417.4270833,96,13.16504478,9.502795575,0.692080605,0.932038835,0.685714286,1.392478189
+1695,25457.10989,769.7802198,481.4945055,1081.714286,23156.39011,628.043956,546,1634.741758,12562.1044,484.3186813,612.5384615,1765.774725,18172.46703,1151.620879,4907.417582,2767.620879,6402.307692,1161.197802,348.6043956,3250.126374,12438.33516,9446.054945,737.0769231,531.3571429,14272.13736,640.6703297,115.5549451,4547.71978,11552.91758,1455.153846,679.6813187,2795.010989,9461.379121,575.0659341,255.3296703,13722.07143,7896.840659,991.4725275,390.7197802,1325.846154,5581.862637,830.021978,157.0879121,4120.950549,4655.538462,1170.71978,185.3076923,3235.950549,832.9615385,421.4010989,182,17.79963174,13.67292882,0.640260375,0.870813397,0.631944444,0.322257844
+1696,13535.08621,732.4655172,612.3103448,1137.387931,10313.46552,549.7758621,456.7241379,1754.732759,5330.551724,423.4310345,491.3362069,1763.077586,8342.275862,1113.043103,7386.991379,2885.62931,3043.862069,1050.103448,307.1293103,2571.681034,5567.025862,4519.862069,611.3965517,472.2844828,6831.112069,419.4137931,115.3362069,11317.68103,5658.525862,1356.37069,808.9396552,2784.801724,4629.396552,616.3706897,258.6551724,29106.58621,3682.172414,746.1293103,358.4655172,1309.5,2224.560345,732.9224138,156.3448276,9133.974138,2136.724138,1054.068966,207.2068966,3163.672414,994.137931,418.7241379,116,15.44599446,9.707939281,0.777802692,0.928,0.703030303,1.298105614
+1697,28603.3128,986.6872038,787.5829384,2491.890995,26539.09005,737.7819905,810.7582938,3996.36019,12599.57346,581.8672986,825.5876777,2004.161137,18099.41232,1311.36019,7760.208531,3558.175355,7027.753555,1472.246445,391.0473934,2830.890995,13690.43128,3018.180095,546.6587678,493.0047393,16727.81991,534.7251185,137.5924171,10988.44076,11918.55924,1699.687204,646.535545,2802.312796,10072.80095,670.4691943,307.9952607,10568.78673,6022.995261,1020.744076,441.1469194,1304.483412,4966.459716,700.4976303,175.3317536,3105.445498,4346.127962,1295.777251,225.7630332,3350.739336,155.1137441,421.9810427,211,18.29986615,14.86724073,0.583067842,0.954751131,0.694078947,-1.204072261
+1698,53022.05263,948.2434211,550.4276316,1183.960526,48640.83553,775.1973684,582.4210526,1854.526316,26495.61184,608.5460526,590.7236842,1809.730263,37593.46711,1408.986842,6495.881579,5015.559211,14182.11184,1506.710526,427.6578947,2566.986842,27508.01316,464.7105263,201.2631579,457.2368421,33816.44079,484.9539474,145.9210526,5466.921053,25510.82237,1609.842105,634.3026316,2840.282895,21319.60526,649.4736842,345.6644737,5647.217105,14518.11842,904.5789474,477.9605263,1325.822368,11825.78947,680.1447368,183.4802632,2295.302632,9659.585526,1445.118421,264.4605263,3300.605263,190.4868421,422.0131579,152,17.32254374,12.64610367,0.683407265,0.88372093,0.558823529,-0.695535058
+1699,40349.14118,1033.611765,543.2117647,1128.917647,35490.95294,808.4823529,643.2823529,1619.694118,19807.12941,637.9058824,1229.752941,1785.976471,28514.21176,1547.294118,3713.105882,3980.4,10013.8,1518.458824,445.6,2660.741176,18187,495.7882353,1217.011765,1008.658824,21666,516.5882353,142.8705882,3515.917647,16691.75294,2018.117647,819.4117647,2815.329412,14812.52941,944.6352941,323.5529412,1960.270588,12175.34118,1319.152941,486.9529412,1363.388235,9470.623529,961.6823529,202.4235294,3873.152941,8055.352941,1533.294118,283.9411765,3266.270588,445.7882353,419.8352941,85,12.22439129,9.162634826,0.661962334,0.913978495,0.653846154,-0.13371925
+1700,37310.76471,827.9411765,497.6960784,1085.392157,30568.60784,690.3235294,635.8235294,1593.794118,18031.57843,551.754902,1060.990196,1796.656863,25175.69608,1319.95098,6264.77451,3496.970588,9232.156863,1325.588235,360.2352941,2501.95098,18681.22549,471.745098,387.8333333,804.7352941,21515.01961,459.872549,156.3921569,3264.333333,17223.28431,1800.941176,669.1470588,2800.833333,14934.47059,632.9509804,280.7156863,1852.754902,11849.40196,988.2058824,420.2941176,1320.215686,9159.009804,728.8823529,164.6176471,4587.078431,7920.313725,1381.137255,264.6862745,3246.735294,612.3627451,420.6960784,102,12.50222895,11.26304275,0.43406246,0.886956522,0.603550296,-0.068149567
+1701,27922.01546,798.5876289,457.8298969,1058.742268,24566.63918,665.0206186,689.685567,1504.324742,13647.20619,516.9123711,936.4690722,1811.737113,19882.52577,1246.561856,5377.345361,3032.716495,6907.407216,1272.505155,374.0257732,2696.417526,14270.03093,466.1752577,1089.742268,800.5670103,16323.1701,405.6237113,151.7835052,2888.752577,13265.46392,1914.14433,693.8402062,2810.912371,11592.2268,741.2061856,261.0154639,1960.902062,9264.829897,965.7216495,393.6597938,1365.835052,7288.262887,920.0206186,160.3402062,5707.206186,6094.149485,1356.582474,1286.561856,3149.587629,632.242268,423.2680412,194,16.55169326,15.51302171,0.348666628,0.937198068,0.633986928,0.095679955
+1702,21963.96241,785.8045113,565.2932331,1118.180451,8783.165414,409.1654135,274.887218,1170.37594,4646.315789,341.6015038,356,1642.62406,7031.082707,857.8120301,3545.045113,1741.736842,2545.37594,1026.421053,266.1729323,3115.548872,4825.097744,1635.744361,110.6390977,373.1052632,5321.466165,273.9548872,94.84210526,4284.593985,4586.947368,1292.917293,593.9849624,2807.278195,3884.706767,461.9097744,188.3458647,4595.879699,3064.195489,654.7593985,311.2932331,1270.992481,2016.240602,545.9097744,129.5263158,1718.669173,1821.481203,876.1353383,92.2556391,2904.165414,921.3233083,420.6090226,133,15.15007146,11.78679336,0.628261188,0.898648649,0.59375,-0.763765957
+1703,40522.71429,913.9047619,663.4761905,1169,38311.35714,746.8095238,487.952381,1791.428571,20685,591.5238095,670.9047619,1843.880952,28923.90476,1352.714286,8963.190476,8967.047619,10814.69048,1444.166667,421.0714286,2400.428571,21164.02381,462.3809524,144.3809524,482.7142857,26191.2381,464.6666667,143.0238095,7088.714286,19630,1585.547619,1002.333333,2824.428571,16934.85714,635.7142857,330.5714286,5085.880952,12171,878.8333333,467.7142857,1315.738095,9680.261905,662.0238095,172.0714286,3663.952381,8007.119048,1415.357143,169,3304.761905,225.0714286,418.3333333,42,10.60637155,5.479637262,0.85620492,0.857142857,0.525,-1.11168015
+1704,20255.83206,898.7328244,498.4274809,1082.51145,17973.28244,746.6793893,521.2748092,1524.320611,9641.419847,566.1755725,429.9083969,1725.78626,13839.22901,1418.839695,2951.40458,1758.961832,4996.251908,1395.183206,425.0534351,2396.381679,8469.961832,550.9389313,1145.900763,471.1221374,10007.32824,422.0305344,125.9770992,1507.51145,7867.114504,1554.992366,796.6183206,2794.290076,6973.59542,685.1603053,279.8091603,2030.053435,5513.099237,839.2824427,455.2366412,1337.229008,4469.343511,954.6870229,180.610687,3295.549618,3861.160305,1416.015267,1728.061069,3130.839695,564.1526718,421.9389313,131,14.33335096,11.74995203,0.572702786,0.942446043,0.727777778,0.124952515
+1705,23617.47154,887.5528455,469.2520325,1068.658537,20214.98374,664.0650407,565.203252,1587.04878,11831.20325,541.0243902,406.3414634,1812.902439,16529.69106,1258.902439,2755.268293,1574.788618,5815.699187,1222.96748,336.9593496,2377.430894,11884.36585,421,140.1463415,473.1626016,13564.22764,427.3333333,117.2601626,1832.178862,11128.17886,1360.081301,604.2682927,2807.837398,9636.796748,610.7479675,251.495935,1535.170732,7725.593496,868.804878,385.2276423,1309.373984,6015.243902,1084.804878,158.5934959,2417.300813,5184.674797,2262.878049,281.8130081,3323.455285,648.9756098,420.0813008,123,15.31664547,10.34449968,0.73747327,0.953488372,0.683333333,-1.140657093
+1706,35751.57143,876.9642857,564.6785714,1156.738095,33335.86905,697.1309524,805.7380952,1758.130952,17403.91667,565.3095238,2194.392857,1829.214286,24893.95238,1289.392857,12211.39286,5017.011905,9224.166667,1362.452381,386.797619,5447.47619,18599.92857,514.5,137.4404762,903.1071429,22485.41667,461.5238095,128.1428571,5957.166667,16900.84524,2247.952381,648.3809524,2817.47619,14255.47619,603.547619,313.6666667,10862.71429,9108.22619,1142.178571,431.2857143,1327.607143,7669.107143,650.5595238,189.5357143,3204.154762,6393.547619,1305.404762,500.1428571,3300.059524,180.7142857,421.6190476,84,14.24852374,7.648157332,0.843729626,0.943820225,0.7,-0.533220441
+1707,39114.66667,867.4444444,661.8444444,1112.533333,34343.02222,712.6888889,503.6,1637.866667,19013.64444,569.2,513.2888889,1825.244444,26732.84444,1282.666667,5084.822222,5884.822222,9737.644444,1401.444444,394.4,2549.155556,19945.55556,435.8,741.5333333,457.2,23261.68889,430.2444444,131.8888889,5802.533333,18019.68889,1597.888889,1406.4,2824.4,15759.28889,597.9555556,290.2444444,2743.355556,11966.33333,905.2444444,449.1777778,1317.4,9306.133333,790.8666667,183.7777778,7491.355556,7995,1368.711111,146.5333333,3320.4,299.6222222,420.4888889,45,10.94502868,5.363334737,0.871708531,0.9,0.555555556,-0.71354126
+1708,22004.98913,887.826087,568.0326087,1076.771739,20356.54348,667.9673913,448.8152174,1516.847826,11290.53261,540.4130435,532.5978261,1765.467391,15415.46739,1226.293478,7210.652174,3241.956522,5752.391304,1404.543478,361.0326087,2438.706522,11150.5,386.6086957,197.7934783,478.3804348,12601.58696,448.25,121.2717391,5267.141304,9769.25,1453.836957,856.2934783,2803.25,8477.554348,583.8369565,259.7282609,2067.336957,6768.163043,859.826087,423.8695652,1297.282609,5404.478261,647.75,169.5217391,4844.021739,4502.51087,1283.347826,187.423913,3454.858696,326.9347826,421.6847826,92,12.90492471,9.379711411,0.686815359,0.93877551,0.638888889,-0.691591893
+1709,48375.65761,1039.326087,520.2554348,1141.586957,43860.07609,861.1032609,691.2608696,1688.75,24349.95109,654.8804348,1126.23913,1762.021739,35670.88043,1625.913043,2277.538043,4391.809783,12040.88043,1560.891304,442.5380435,2532.701087,22900.75,534.451087,364.1195652,865.0923913,27222.125,657.3423913,171.1956522,2753.146739,21357.95109,1831.331522,902.5434783,2829.043478,18885.16848,805.8315217,350.576087,2099.755435,15307.5163,1320.445652,531.0271739,1338.309783,11839.17935,788.7336957,208.375,3609.190217,10083.34783,1644.418478,1572.440217,3291.288043,456.6630435,424.1684783,184,15.82953265,15.26372133,0.264972504,0.906403941,0.676470588,-0.137935868
+1710,23571.42657,816.4265734,424.4335664,1054.671329,20632.48252,649.7062937,494.4405594,1538.181818,11906.09091,504.0909091,835.3216783,1732.692308,17620.73427,1284.846154,2070.216783,2217.342657,6203.664336,1221.65035,345.9230769,2567.727273,12271.72727,505.8111888,328.8251748,784.979021,14147.74825,409.9370629,117.5944056,1655.762238,11843.11189,1603.153846,565.1678322,2876.909091,10202.93706,774.6433566,258.8531469,1957.475524,8412,1309.881119,405.3286713,1307.755245,6282.27972,681.6153846,158.2307692,2235.811189,5484.832168,1329.825175,2107.594406,3143.951049,768.8811189,423.4195804,143,16.67626261,12.09891952,0.688203771,0.899371069,0.595833333,-1.046980526
+1711,32052.96639,879.4957983,618.3277311,1109.168067,28208.26891,706.4621849,791.8067227,1627.756303,15377.70588,559.6722689,861.7647059,1825.94958,21990.57983,1285.361345,6928.865546,6696.714286,7969.823529,1335.991597,381.1092437,2718.218487,15242.13445,424.1596639,1291.571429,1028.10084,17793.28571,445.9663866,130.4705882,5168.260504,13332.97479,1787.823529,1170.655462,2815.042017,11764.47059,597.4621849,292.0840336,2935.210084,8974.97479,1071.277311,447.8067227,1329.537815,7280.672269,898.3109244,179.9831933,6518.915966,6005.890756,1338.680672,369.0672269,3345.546218,308.1848739,422.9495798,119,13.28002328,11.67607655,0.476413973,0.9296875,0.704142012,-0.457025442
+1712,23701.81707,1252.719512,614.402439,1094.012195,21060.47561,784.8414634,651.6829268,1502.963415,11242.54878,624.8170732,484.3292683,1749.45122,14995.10976,1336.219512,4268.52439,1979.073171,5349.073171,1351.365854,369.6829268,2402.47561,8455.097561,375.7439024,856.1829268,441.4512195,11270.78049,426.8902439,124.8414634,5094.54878,8546.231707,1764.097561,724.9634146,2843.146341,7237.609756,780.0731707,255.0243902,1577.487805,5886.804878,829.1585366,418.7195122,1350.621951,4694.5,839.1097561,163.1341463,4162.585366,3888.231707,1217.768293,136.1463415,3447.597561,398.8292683,421.3780488,82,11.45387417,9.208004705,0.59473672,0.964705882,0.759259259,1.514785349
+1713,41205.59259,915.3148148,697.3518519,1170.592593,35149.46296,787.1111111,811.7037037,1781.611111,21536.81481,614,2373.37037,1890.740741,30562.64815,1443.111111,3198.388889,3391.203704,10745.46296,1471.685185,407.5185185,2504.592593,20971.51852,510.6111111,288.6851852,2525.462963,25071.42593,511.7037037,284.2407407,1823.055556,20042.51852,2581.37037,740.0740741,2832.074074,17384.72222,685.1111111,334.6296296,1681.962963,13986.68519,1609.759259,514.1111111,1340.833333,10493.05556,737.8148148,188.6111111,2915.203704,9610.074074,1525.833333,233.6296296,3426.351852,510.2037037,421.2407407,54,9.363311879,7.556953101,0.590440443,0.885245902,0.675,0.377590651
+1714,28601.51899,979.2531646,636.0632911,1120.518987,26813.35443,803.0759494,588.4050633,1590.493671,14755.32911,632.5316456,928.3164557,1791.101266,21267.36709,1533.987342,5226.962025,2871.506329,7311.64557,1527.582278,441.0253165,2726.759494,14547.81013,518.2025316,1572.949367,737.9746835,17494.27848,486.4683544,148.2405063,2431.075949,13327.92405,1937.227848,697.8101266,2829.898734,11671.31646,1034.860759,323.278481,1829.632911,9533.050633,1125.21519,501.4936709,1398.177215,7642.949367,1102.670886,195.0379747,3541.253165,6463.35443,1554.734177,439.556962,3146.392405,528.4303797,421.4683544,79,12.84354144,7.853919136,0.791238802,0.975308642,0.658333333,1.008117933
+1715,20672.57851,862.8760331,532.4214876,1090.735537,18234.24793,726.3553719,738.553719,1540.801653,10102.84298,557.0495868,1127.396694,1776.413223,14530.02479,1348.190083,4442.438017,3688.338843,5214.553719,1361.61157,451.2479339,2578.628099,9750.322314,462.3719008,1300.347107,677.0330579,11675.95868,1129.157025,129.8181818,3208.694215,9024.46281,1633.512397,831.1900826,2803.049587,7944.661157,667.2727273,267.2809917,1995.14876,6403.801653,1244.338843,457.1652893,1387.892562,5071.024793,959.8677686,177.9586777,5396.165289,4553.090909,1380.966942,335.4545455,3154.826446,551.5950413,423.2727273,121,14.18528391,11.18093735,0.615410454,0.937984496,0.620512821,-0.530903196
+1716,34603.05263,828.0075188,467.8120301,1076.609023,29548.22556,690.0601504,638.5714286,1593.180451,17755.10526,531.9172932,1073.706767,1742.473684,24007.81955,1304.383459,5634.639098,3609.105263,8802.827068,1342.075188,364.2255639,2631.601504,17167.05263,450.112782,649.2330827,982.2030075,19991.2782,1277.142857,126.3909774,3040.654135,16026.54135,1552.593985,612.4210526,2802.533835,14111.59398,844.7368421,274.6015038,1903.443609,11348.78947,1170.007519,419.7218045,1326.233083,8317.609023,796.2781955,165.1503759,4323.067669,7288.090226,1342.593985,464.3759398,3200.526316,719.4360902,423.6917293,133,18.99639581,9.328707626,0.871115737,0.880794702,0.492592593,-1.068832186
+1717,18760.27723,706.6831683,471.8217822,1038.564356,14769.25248,553.4950495,506.3118812,1492.965347,8011.460396,426.7376238,1068.876238,1733.366337,11595.94554,1053.113861,7911.628713,3616.128713,4100.59901,1179.920792,326.5544554,4445.866337,7999.207921,910.9108911,1801.465347,770.1287129,9158.970297,363.4653465,111.0742574,7225.891089,7400.232673,1678.569307,722.509901,2788.673267,6177.282178,698.6039604,230.2871287,8239.851485,4980.727723,921.0841584,356.7079208,1326.242574,3372.717822,1033.470297,174.7871287,4085.480198,2919.450495,1039.188119,231.480198,3095.99505,885.8960396,424.3861386,202,17.39801587,15.24252701,0.482116345,0.957345972,0.660130719,0.315634796
+1718,30017.57639,886.2222222,649.1319444,1258.597222,27648.39583,670.5972222,1012.625,1888,13964.72917,545.3958333,2132.069444,1875.638889,19959.56944,1234.5,8327.125,4578.326389,7377.368056,1325.222222,370.0069444,4778.465278,14953.72222,517.8472222,303.5486111,813.6319444,18089.64583,440.6041667,126.6041667,6475.326389,13552.88194,1932.673611,636.0138889,2815.527778,11458.6875,583.3125,293.0486111,16560.78472,7130.138889,1213.645833,423.4166667,1322.958333,5896.951389,660.0069444,173.4166667,3947.729167,5015.576389,1259.277778,451.8611111,3264.1875,167.6388889,426.0069444,144,17.27023921,11.2638301,0.758037966,0.911392405,0.6,-0.628619609
+1719,38962.88034,1263.196581,634.0940171,1139.965812,28165.03419,798.4871795,587.2051282,1564.957265,16108.89744,634.2222222,573.5384615,1728.726496,22933.24786,1454.487179,5068.213675,2861.982906,7977.059829,1401.008547,385.1025641,2406.777778,15724.48718,447.8803419,602.4957265,552.5982906,18408.24786,459.2820513,136.1880342,4790.367521,14329.65812,1673.008547,734.2222222,2819.692308,12621.60684,685.974359,296.4786325,1524.880342,9809.205128,937.9487179,457.017094,1341.974359,7709.401709,756.5982906,181.8888889,3491.316239,6575.17094,1361.487179,240.8632479,3432.008547,420.3504274,423.6324786,117,13.82731753,11.00562556,0.605384032,0.906976744,0.75,1.013178728
+1720,15633.32941,997.0117647,518.2352941,1036.176471,15136.88235,686.8235294,482.9058824,1390.117647,7428.305882,579.3764706,1420.176471,1754.717647,9743.223529,1204.388235,3897.152941,3093.152941,3905.905882,1213.894118,330.6352941,2434.305882,7427.141176,393.0588235,527.8470588,1373.188235,8036.4,394.2588235,118.4823529,2317.458824,5917.164706,1807.564706,696.5411765,2810.517647,5396.411765,565.2470588,235.9058824,1638.705882,4447.541176,1136.929412,385.6705882,1312.364706,3787.894118,960.5176471,151.1411765,2566.988235,2906.741176,1135.541176,213.4470588,3422.788235,504.3764706,424.8117647,85,15.1412212,8.035399304,0.847561673,0.85,0.551948052,0.510578453
+1721,21156.33862,736.1957672,525.0529101,1081.333333,14917.28042,573.5449735,659.7724868,1720.867725,7471.190476,439.1269841,899.6666667,1794.148148,11363.08466,1096.878307,8278.671958,3924.539683,4240.746032,1120.936508,316.042328,3706.962963,7672.915344,1326.375661,177.4391534,641.6190476,9352.148148,413.4285714,117.8518519,11578.24868,7562.058201,1584.730159,863.5449735,2783.978836,6234.666667,534.3915344,253.8835979,18204.44444,5052.285714,946.0846561,372.7248677,1315.328042,3229.740741,664.5925926,150.2645503,4710.222222,2964.904762,1095.666667,196.5661376,3176.746032,966.3280423,425.1904762,189,20.98838258,12.05017317,0.818760378,0.964285714,0.583333333,-0.857968575
+1722,32298.95161,974.5806452,553.516129,1072.516129,27077.90323,791.1935484,749.6774194,1536.258065,16364.33871,734.983871,1284.177419,1819.629032,23002.45161,1437.354839,5832.66129,3103.774194,7966.887097,1427.951613,500.7258065,2443.967742,16368.09677,486.6774194,1701.887097,1128.774194,18968.09677,519.9354839,132.6612903,1597.983871,15272.04839,2267.967742,732.3870968,2810,13269.85484,827.3064516,300.5322581,1542.419355,10858.53226,1862.096774,473.2903226,1389.209677,8086.145161,1122.854839,186.5322581,3620.290323,7508.919355,1456.467742,237.1612903,3309.967742,493.7258065,424,62,12.00596226,6.696827983,0.82998087,0.96875,0.563636364,-0.817046856
+1723,27186.35075,797.3432836,488.9850746,1064.134328,23022.6791,673.4626866,554.7761194,1541.425373,13185.70149,521.0373134,1556.514925,1911.313433,18615.48507,1286.022388,5177.61194,3546.947761,6647.119403,1254.238806,341.5597015,2529.574627,13451.00746,439.9925373,339.6044776,1291.567164,15563.42537,428.6492537,124.0373134,3579.455224,12405.51493,1989.097015,875.5522388,2793.589552,10786.95522,647.4029851,272.1940299,1869.88806,8601.462687,1250.470149,410.7910448,1306.343284,6632.58209,701.5447761,165.0298507,4642.664179,5907.11194,1352.149254,876.4402985,3188.343284,601.6791045,425.1343284,134,17.09627955,10.44053722,0.791869302,0.899328859,0.683673469,0.840763552
+1724,36899.16667,844.3888889,514.962963,1092.694444,29531.62037,673.6018519,849.0462963,1595.490741,18239.77778,521.4537037,1307.694444,1756.777778,24522.15741,1254.092593,7837.777778,2756.703704,8860.972222,1253.083333,349.7685185,2601.601852,17687.63889,481.787037,1055.351852,899.462963,20314.23148,620.7592593,590.6759259,2639.574074,16836.7963,1770.268519,593.962963,2803.111111,14374.91667,624.4907407,279.2962963,7083.027778,11727.75,1093.518519,429.1481481,1323.222222,8336.185185,972.1296296,164.0833333,3929.759259,7207.296296,1289.231481,1042.398148,3212.027778,794.8148148,423.2222222,108,17.8763619,8.182219543,0.889100682,0.892561983,0.6,1.368607119
+1725,34600.5,936.3541667,531.6770833,1109.208333,28418.64583,737.1875,929.4166667,1706.354167,16588.26042,552.3541667,1499.697917,1787.447917,21631.65625,1297.479167,4882.197917,2835.635417,7819.104167,1291.697917,502.6041667,4565.239583,15181.92708,2131.90625,1961.09375,936.2395833,17112.29167,468.375,128.5833333,3124.84375,13947.48958,2004.072917,602.34375,2885.427083,11447.35417,582.2083333,294.6458333,12997.91667,9141.739583,1326.5625,431.59375,1349.447917,6364.583333,1216.958333,166.6041667,4530.333333,5250.510417,1264.4375,262.9895833,3293.208333,821.7291667,423.8020833,96,11.89265891,10.48479773,0.471961222,0.96,0.79338843,0.72632386
+1726,20970.09934,898.4635762,430.8145695,1037.013245,17322.39073,666.0728477,362.9006623,1443.245033,10244.64901,514.0728477,408.9602649,1654.549669,14222.23841,1305.523179,1324.748344,982.0860927,5156.635762,1230.642384,353.5496689,2427.397351,9608.15894,444.1390728,139.4304636,452.1258278,10982.39073,632.3311258,119.7019868,1059.490066,9158.807947,1306.880795,548.205298,2819.794702,7894.178808,633.3046358,251.1854305,1843.701987,6400.152318,817.0596026,401.4834437,1303.483444,4819.086093,619.7417219,162.4768212,1773.860927,4172.529801,1365.860927,5466.609272,3101,754.3046358,425.9271523,151,15.27564006,12.66581277,0.559024651,0.932098765,0.725961538,-1.098903455
+1727,16272.61039,731.0324675,500.8246753,1075.623377,10260.98701,511.1623377,321.7597403,1508.909091,5237.298701,402.5844156,389.7402597,1741.12987,7974.896104,998.961039,5786.155844,2728.461039,2905.805195,1027.811688,290.1623377,2525.480519,5484.75974,4670.636364,221.5454545,438.1623377,6269.168831,395.5649351,109,8326.220779,5314.396104,1231.954545,775.2337662,2792.207792,4410.493506,664.6818182,225.525974,10818.81169,3474.811688,644.7142857,348.1103896,1289.071429,2274.285714,599.3571429,141.2012987,3185.11039,2053.318182,987.1363636,120.1883117,3097.136364,942.5324675,427.5,154,14.61635365,13.501607,0.383037201,0.950617284,0.733333333,-0.076535763
+1728,25753.04211,757.1473684,544.3157895,1116.810526,22557.95789,607.3157895,419.3473684,1758.863158,11261.17895,460.2736842,449.8526316,1803.884211,17041.13684,1234.505263,7296.326316,2496.684211,5988.778947,1186.747368,331.7578947,2523.610526,11408.85263,5359.621053,166.6315789,460.1263158,13870.25263,420.2631579,117.4947368,7821.305263,11403.75789,1401.789474,783.8421053,2800.789474,9105.536842,801.8736842,283.3368421,22848.93684,7186.863158,787.9684211,385.6105263,1328.284211,4486.463158,659.7157895,160.5052632,4947.736842,4073.6,1137.821053,179.9157895,3173.631579,982.5578947,425.1789474,95,11.4057328,10.91190138,0.291065171,0.913461538,0.659722222,-0.264002488
+1729,58555.70588,988.0980392,550.254902,1155.705882,56566.98039,781.3137255,541.9803922,1806.352941,30293.01961,614.0784314,1289.196078,1773.568627,41606.4902,1408.294118,6403.803922,5919.705882,15775.68627,1538,430.4509804,4204.098039,30177.56863,469.8627451,364.6470588,569.5098039,36059.68627,596.372549,144.6862745,4409.137255,28007.86275,2024.72549,658.3333333,2821.705882,23440.5098,642.9607843,332.3529412,2652.705882,15925.39216,1083.215686,491.3333333,1338.45098,12683.15686,723.2352941,185.9019608,2555.607843,10480.29412,1454.529412,204.0392157,3249.568627,199.2941176,426.9019608,51,9.692837214,7.251859628,0.66351062,0.894736842,0.579545455,-0.150386648
+1730,57016.44444,966.9166667,605.5833333,1185.333333,53626.55556,803.0277778,501.1666667,1829.555556,29591.52778,627.4722222,565.6666667,1812.944444,40952.11111,1425.611111,6509.583333,6469.333333,14731.36111,1500.305556,436.25,2422.083333,29251.47222,486.25,149.8611111,439.2222222,36685.66667,473.9722222,146.5555556,5043.194444,28050,1606.805556,880.0277778,2863.055556,23821.36111,654.8333333,348.2777778,3570.5,17213.44444,926.7777778,511.4722222,1325.138889,13422.88889,667.1666667,199.9166667,2279.527778,11194.30556,1512.583333,149.5277778,3397.027778,226.6666667,423.9166667,36,8.153554997,6.079801424,0.666323655,0.9,0.571428571,1.336447291
+1731,59305.65116,966.6046512,671.0465116,1180.488372,53669.27907,808.4883721,654.3953488,1769.162791,30084.39535,646.9302326,500.9767442,1782.627907,42471.48837,1467.186047,8849.488372,7050.44186,15269.18605,1564.44186,443.7674419,2406.72093,30879.62791,500.5813953,141.6744186,457.0465116,38508.39535,483.1627907,148.4418605,7902.906977,29685.65116,1619.953488,954.4883721,2850.139535,25112.18605,657.1860465,361.3488372,3237.139535,18881.27907,991.744186,513.627907,1306.44186,14785.18605,684.0232558,197.8604651,2534.255814,12271.51163,1547.186047,140.6744186,3336.627907,245.3488372,424.0465116,43,8.478158663,7.021538627,0.56044527,0.955555556,0.597222222,-0.234223512
+1732,47197.79825,905.9122807,598.5263158,1146.245614,43455.2193,746.7894737,569.1929825,1735.096491,23334.42982,587.2280702,772.4473684,1820.605263,33417.7193,1365.622807,6903.061404,6087.298246,12347.59649,1448.149123,399.0526316,2548.464912,24621.29825,460.7192982,131.0614035,709.1666667,30130.96491,439.0614035,138.5087719,5427.859649,22890.02632,1735.254386,973.6666667,2846.421053,19924.12281,643.7017544,327.5964912,3358.114035,15095.36842,943.8508772,473.2192982,1312.508772,11864.40351,667.2192982,180.5438596,3458.157895,9978.280702,1428.72807,167.1052632,3299.377193,260.7719298,426.8596491,114,14.48070433,10.52834188,0.686573854,0.88372093,0.678571429,0.020382619
+1733,41019.73626,944.4505495,673.3626374,1170.307692,37951.20879,768.1428571,669.1428571,1760.945055,20951.03297,602,840.4615385,1830.395604,28809.49451,1391.472527,8289.813187,7482.472527,10521.83516,1444.472527,407.5054945,2895.549451,21819.76923,477.9340659,181.7912088,713.7912088,25423.1978,453.9010989,140.9010989,5330.978022,19715.48352,1923.153846,1305.021978,2840.164835,17397.14286,643.4615385,331.1758242,3026.384615,13141.16484,1074.692308,492.8461538,1320.21978,10211.8022,681.2747253,209.4835165,5060.076923,8431.406593,1461.406593,178.5824176,3330.857143,275.3736264,425.8681319,91,11.7685018,10.15059346,0.506019311,0.928571429,0.631944444,-0.677671079
+1734,25942.25786,786.3899371,487.8427673,1085.553459,23080.62264,641.8993711,511.9811321,1692.333333,12519.77358,485.6163522,483.6981132,1808.993711,17511.91824,1163.371069,4653.490566,3085.698113,6204.339623,1179.654088,428.2327044,2603.974843,12238.30818,4711.396226,1479.559748,487.0691824,14249.91824,414.0188679,120.2138365,5438.597484,11149.97484,1447.597484,682.7044025,2797.333333,9110.849057,558.2515723,263.1194969,10473.32075,7497.465409,897.8805031,387.5534591,1311.993711,5166.704403,1048.421384,152.5471698,4057.207547,4359.314465,1159.012579,171.2767296,3260.874214,849.7610063,425.8427673,159,19.56772309,10.69631354,0.837373952,0.898305085,0.76076555,1.564415069
+1735,59287.6,999.25,592.95,1195.35,57122.5,806.55,506.5,1794.575,32467.625,631.925,496.05,1770.65,45741.775,1487.575,6634.425,3362.15,16227,1563.075,444.8,2399,32730.775,493.05,158.9,439.625,40161.875,475.5,149.275,4979.425,31411.55,1653.5,792.1,2886.575,26524.325,687.225,372,5504.075,19428.125,951.85,509.45,1314.025,15134.125,702.125,193.975,2339.775,12673.95,1537.375,161.35,3374.925,239.5,426.4,40,9.339061098,5.985143091,0.767647728,0.930232558,0.571428571,0.410312937
+1736,42875.02,1035.64,578.32,1135.58,36622.94,873.08,754.06,1810.5,22418.54,643,648.04,1837.06,31388.28,1551,6040.66,2961.04,10223.66,1478.08,408.58,2467.1,21827.78,540.32,328.26,589.6,25712.9,484.2,158.56,4512.02,20748.66,1707.66,729.58,2829.06,18048.5,802.42,350.06,2041.42,14358.92,1001.6,506.98,1317.16,10960.82,746,199.72,3222.48,9717.16,1546.34,300.02,3360.18,521.68,426.46,50,9.61767134,6.933714588,0.693002829,0.980392157,0.625,-0.330755344
+1737,35288.65116,825.1162791,427.8139535,1067,30176.97674,695.8837209,520.4651163,1541.325581,19264.46512,558.255814,551.5813953,1759.813953,26905.16279,1351.325581,5033.627907,3838.302326,9966.581395,1371.511628,389.7674419,2534.418605,18029.51163,459.8837209,146.744186,464.8139535,20923.06977,512.0465116,127.8139535,2150.418605,16800.88372,1402.604651,610.2790698,2798.325581,14908.65116,597.1627907,275.0930233,2324.325581,11963.06977,833.627907,412.0930233,1288.906977,8616.651163,646.9767442,157.4418605,5311.581395,7616.837209,1395.418605,4073.860465,3182.209302,730.4186047,426.3023256,43,9.003509173,6.329777377,0.711155765,0.87755102,0.5375,0.375083912
+1738,52155.35821,945.9552239,587.880597,1173.537313,50137.10448,810.1492537,731.238806,1841.671642,27583.41791,612.5373134,863.8955224,1816.38806,38557.40299,1407.865672,6570.492537,5673.895522,13947.97015,1527.462687,436.0746269,2449,27439.70149,476.3432836,149.9701493,607.119403,34621.80597,467.6865672,144.9850746,4763.746269,25894.9403,1769.940299,840.1791045,2844.044776,22223.62687,659.761194,348.3880597,3719.80597,16003.35821,936.9253731,495.3432836,1330.597015,12631.07463,671.7014925,195.0597015,2685.865672,10580.71642,1482.014925,188.2835821,3355.58209,221.0447761,428.6268657,67,9.836818155,9.185872175,0.357728714,0.943661972,0.67,1.491013933
+1739,29516.42742,887.9677419,544.483871,1105.919355,26806.35484,685.5967742,566.1612903,1627.201613,15123.31452,546.4758065,737.016129,1808.532258,20732.3629,1275.895161,6930.830645,4562.443548,7849.137097,1362.516129,376.8951613,2474.096774,16149.15323,430.2903226,668.7903226,623.5,17718.44355,461.9193548,130.516129,5976.725806,13822.92742,1666.008065,822.8870968,2807.290323,12023.29032,634.2258065,294.2983871,1912.056452,9585.830645,1003.427419,458.0322581,1314.677419,7555.314516,836.7903226,183.4435484,6366.879032,6312.120968,1349.322581,167.5645161,3449.443548,371.4274194,428.5645161,124,15.63673086,11.1059337,0.703953037,0.832214765,0.561085973,-1.285096368
+1740,41181.12752,1101.577181,553.4899329,1131.644295,37568.38926,812.2885906,584.9798658,1663.637584,20760.12752,641.8456376,800.3221477,1782.684564,28483.08054,1437.805369,5247.731544,3841.993289,9819.241611,1441.604027,399.1275168,2558.912752,18086.59732,451.033557,422.1677852,565.442953,20977.95302,734.5973154,137.738255,4414.684564,16308.57718,1575.38255,765.4832215,2820.704698,14119.8255,642.4630872,300.6442953,1683.38255,11143.21477,942.0872483,455.4966443,1311.348993,8705.09396,699.8456376,176.1946309,3757.798658,7303.308725,1359.09396,169.1342282,3404.328859,387.4161074,431.8791946,149,17.074502,14.27279182,0.548862533,0.719806763,0.517361111,-0.395031663
+1741,50572.49561,1088.192982,559.495614,1132.95614,44263.87719,884.7982456,728.4385965,1693.27193,25658.64474,657.9780702,1473.311404,1753.881579,36162.16228,1601.254386,4352.127193,4350.653509,12894.22368,1586.381579,439.4298246,2647.267544,25731.64474,531.1535088,419.8815789,913.9473684,29939.36842,1112.592105,222.4912281,3913.460526,23464.82456,1910.184211,788.5482456,2831.118421,20815.9693,715.245614,353.5570175,1977.921053,16769.52193,1434.837719,529.8070175,1330.508772,12707.22807,809.2982456,202.9254386,5177.381579,11229.55263,1597.921053,296.5526316,3352.337719,436.0526316,430.5438596,228,20.50531723,14.6880076,0.697790009,0.938271605,0.670588235,-1.103380619
+1742,16995.39259,748.362963,405.7111111,1036.162963,14587.94815,617.762963,446.2074074,1440.577778,8095.414815,470.0296296,397.4518519,1741.711111,11821.85926,1208.525926,1848.644444,917.8296296,4268.525926,1171.918519,321.2592593,2431.481481,8372.422222,400.3037037,327.2074074,447.0296296,9885.481481,412.7111111,115.6,889.9555556,7793.437037,1334.511111,641.5703704,2822.177778,6794.02963,676.4962963,245.162963,1780.933333,5482.740741,812.4814815,394.9481481,1324.792593,4285.318519,733.3481481,158.2814815,2861.592593,3844.340741,1292.044444,2573.614815,3109.074074,587.3185185,431.0962963,135,15.44526699,11.43993423,0.671862694,0.957446809,0.610859729,-0.587413102
+1743,23076.93651,846.5555556,392.3492063,1019.714286,20000.47619,670.015873,339.5714286,1417.666667,11937.44444,513.2222222,330.7777778,1671.349206,17311,1320.412698,1600.333333,1274.904762,6002.571429,1249.793651,368.8730159,2358.873016,11285.39683,440.5714286,125.8730159,460.7142857,13230.44444,368.015873,118.8888889,1206.507937,10510.68254,1316.873016,535.5396825,2812.412698,9205.888889,707.8253968,268.6984127,1827.68254,7695.555556,767.2698413,412.5714286,1272.380952,5670.365079,613.3333333,158.0952381,1818.587302,4974.761905,1448.904762,8542.888889,3063.111111,740.8253968,426.4761905,63,11.43768203,7.469517414,0.757304302,0.913043478,0.583333333,-1.427476483
+1744,25563.42268,789.7628866,440.0721649,1063.371134,22621.75258,659.1340206,460.9381443,1586.412371,12810.09278,500.5979381,498.0309278,1717.072165,17650.43299,1217.649485,3930.804124,3751.42268,6351.773196,1204.659794,341.0309278,2418.484536,12614.61856,461.6804124,681.6597938,552.6701031,14620.78351,374.9381443,118,2344.103093,11897.48454,1420.43299,664.7216495,2795.381443,10183.09278,638.3917526,259.6391753,2560.42268,8306.773196,875.1443299,400.5360825,1320.010309,6081.876289,753.6907216,162.6701031,3101.804124,5157.175258,1284.28866,1550.56701,3170.164948,784.4020619,428.0721649,97,13.01442056,9.856518123,0.653005008,0.950980392,0.573964497,0.635662274
+1745,12378.3961,694.9545455,619.0974026,1060.818182,9750.532468,543.4415584,460.4090909,1640.668831,4905.766234,414.9805195,461.8051948,1750.967532,7494.811688,1061.337662,8294.090909,3342.727273,2845.649351,1061.876623,303.4090909,2479.363636,5170.071429,1031.051948,144.7662338,442.7337662,6373.837662,399.461039,112.8441558,11773.46753,5286.266234,1337.714286,949.6363636,2787.396104,4263.850649,682.0064935,247.4220779,18396.44156,3359.032468,728.1753247,357.9350649,1295.422078,2039.753247,615.3571429,150.2077922,6363.993506,2061.701299,1096.350649,183.1883117,3241.396104,998.974026,429.7012987,154,20.53384149,11.26716353,0.836011502,0.855555556,0.48125,0.992904567
+1746,23949.58383,747.0778443,534.4640719,1097.284431,14841.51198,553.3862275,391.248503,1586.155689,6751.146707,416.0568862,419.3712575,1740.176647,10968.41317,1042.658683,5191.580838,2031.913174,4013.601796,1058.886228,330.4431138,2518.631737,7347.44012,5057.392216,562.248503,448.2844311,9048.377246,388.5179641,110.2245509,5934.655689,7105.077844,1314.269461,673.7245509,2807.802395,5555.766467,564.6766467,238.1287425,16250.85329,4234.305389,679.9610778,353.7874251,1306.245509,2359.101796,728.9850299,143.4550898,4971.194611,2276.143713,1000.04491,152.0389222,3095.332335,1035.314371,431.3023952,334,23.89146013,18.89518536,0.611976272,0.943502825,0.642307692,-1.249327828
+1747,47520.64,965.74,674.58,1184.52,44082.58,767.56,597.14,1824.7,23681.96,613.92,521.16,1765.32,33027.96,1409.04,12148.34,8566.46,12048.28,1494.62,423.26,2408.12,24333.64,488.76,142.82,457.08,29309.52,461.98,147.36,7228.76,21880.02,1553.38,975.38,2831.18,18865.5,647,332.88,3787.7,14160.6,922.94,487.5,1312.52,11196.72,674.12,188.42,2451.42,9021.18,1453.14,140.8,3326.54,251.62,427.6,50,10.21370931,6.830061643,0.743518739,0.877192982,0.568181818,-1.355576804
+1748,19631.15596,1018.756881,575.6376147,1082.949541,18121.42661,690.6651376,500.5733945,1476.33945,9795.605505,561.5275229,555.6513761,1753.96789,13840.55963,1281.747706,3506.53211,2239.073394,5161.784404,1308.770642,365.853211,2430.247706,10597.76147,417.5550459,447.3394495,916.9954128,11401.06881,422.3944954,126.5229358,2844.036697,8786.610092,1632.16055,768.2477064,2801.022936,7620.545872,720.5688073,273.3486239,1510.674312,6162.325688,1103.394495,426.3119266,1326.288991,4962.587156,660,178.0229358,3361.752294,4340.119266,1296.568807,456.8027523,3396.747706,348.4449541,433.6651376,218,18.16189314,15.51590792,0.519761916,0.935622318,0.674922601,0.167409533
+1749,24229.7602,755.3622449,534.0408163,1100.086735,20768.22449,623.6071429,535.5102041,1775.168367,10581.82653,463.2193878,576.0663265,1790.132653,16188.0051,1182.918367,6878.265306,2999.397959,5833.612245,1180.918367,333.0153061,2917.147959,10696.35714,2763.612245,150.2704082,500.6326531,12789.54592,423.3520408,119.7959184,8543.117347,10813.43367,1471.602041,745.4795918,2814.040816,8672.954082,976.8928571,264.9132653,17487.06633,6842.132653,801.627551,384.2959184,1296.709184,4390.744898,628.4081633,148.8673469,4122.658163,4013.117347,1132.877551,167.994898,3222.260204,972.6632653,435.3622449,196,18.82254855,14.63299049,0.628984143,0.907407407,0.549019608,-0.350783585
+1750,35722.82143,840.9642857,513.9880952,1105.285714,34131.92857,702.25,946.1666667,1604.738095,18606.27381,585.75,1883.75,1823.857143,26164.61905,1300.321429,9604.404762,5338.857143,9288.238095,1373.166667,433.8928571,4481.785714,19640.7619,465.3333333,1056.880952,793.1309524,22805.20238,459.5714286,129.1190476,2728.678571,17777.91667,2106.380952,823.5714286,2803.154762,15551.59524,611.9404762,302.4166667,1748.059524,11709.52381,1367.511905,445.9047619,1364.285714,9333.178571,845.25,311.6666667,3142.464286,7918.25,1361.642857,269.0952381,3311.47619,283.3928571,430.2738095,84,13.067441,8.283759436,0.773395662,0.923076923,0.583333333,-0.773586015
+1751,41748.32258,884.1774194,549.516129,1125.532258,36632.85484,732.4516129,601.016129,1678.193548,21221.90323,577.7903226,585.6774194,1813.225806,28675.01613,1314.774194,4753.274194,5480.435484,10822.3871,1412.419355,400.5483871,2579.274194,21537.01613,451.516129,382.6935484,456.2741935,25322.29032,431.4193548,136.3387097,3834.274194,19508.82258,1678.306452,1082.548387,2802.225806,17241.87097,614.516129,313.1774194,1971.129032,13197.01613,949.7903226,480.3064516,1304.467742,10016.14516,720.5322581,198.0483871,2824.741935,8738.612903,1404.354839,122.5322581,3295.677419,298.8225806,428.516129,62,13.62891014,6.441035596,0.881276552,0.805194805,0.52991453,1.271105222
+1752,20463.07463,893.238806,590.5373134,1056.19403,17962.8806,671.8358209,700.3283582,1516.716418,10078.38806,546.0298507,1143.746269,1806.328358,14458.61194,1256.104478,9552.716418,4772.716418,5371,1320.149254,358.6567164,2572.253731,10678.50746,401.1492537,3428.671642,1329.895522,12630.43284,441.9701493,266.8656716,6490.761194,9442.268657,2120.910448,776.3880597,2808.149254,8096.850746,676.6119403,280.9701493,1473.119403,6517.164179,1168.701493,435.8208955,1422.701493,5205.38806,1443.626866,170.1641791,6364.761194,4474.537313,1295.910448,478.6119403,3281.776119,360.5970149,429.3432836,67,10.30739386,8.355303456,0.585582781,0.957142857,0.8375,-0.281653777
+1753,40271.8,1040.075,541.375,1094.55,38310.75,861.1,958.675,1604.55,21427.95,659.525,2311.175,1875.925,31434.95,1485.825,3015.475,3384.125,10179.55,1487.725,401.6,2533.325,20306.3,485.225,312.2,1771.125,25149.475,482.525,537.875,2124.975,19228.4,2325.675,733,2878,16831.2,662.3,309.8,1739.2,13539.6,1572.25,460.725,1313.45,11031.675,731.025,181.1,2976.475,9211.9,1449.975,359.1,3466.875,514.55,428.5,40,7.816537549,6.961446742,0.454777846,0.869565217,0.714285714,-0.944771944
+1754,33789.50394,798.3779528,473.503937,1074.834646,28698.6063,719.1417323,651,1568.692913,16402.77165,519.4251969,1444.645669,1817.96063,23592.55906,1282.440945,5605.212598,3574.897638,8528.755906,1288.417323,345.8425197,2622.133858,17343.88976,440.3228346,936.0393701,1277.102362,20067.19685,519.3779528,118.1811024,2475.84252,16075.09449,1772.968504,678.503937,2824.952756,13998.23622,695.9133858,272.480315,1729.889764,11070.89764,1155.03937,406.2440945,1333.92126,8790.818898,903.3700787,160.4645669,3451.503937,7500.574803,1349.992126,546.6220472,3241.480315,614.5905512,431.8267717,127,15.99760831,10.5979055,0.749090108,0.933823529,0.604761905,-0.636949093
+1755,30755.91026,854.4358974,552.0512821,1088.410256,26793.28205,681.1282051,862.0512821,1656.25641,15486.79487,517.5,1276.051282,1768.24359,22111.85897,1254.435897,5134.102564,3153.641026,7817.307692,1251.576923,356.474359,2548.064103,15736.01282,619.8974359,1201.038462,588.5,17930.44872,1022.153846,127.4358974,2899.038462,14647.82051,1542.25641,592.0384615,2822.641026,12556.42308,640.3076923,276.9358974,11919.60256,10324.30769,1311.448718,415.1538462,1375.435897,7436.064103,1072.448718,159.1923077,5743.307692,6278.474359,1292.282051,1040.5,3252.192308,803.3333333,430.8076923,78,11.7292113,8.697462401,0.670929101,0.951219512,0.709090909,-0.512373583
+1756,23113.61878,754.3425414,487.1104972,1053.430939,19945.03315,623.1491713,716.1104972,1582.486188,10630.37569,468.4751381,1368.762431,1747.171271,14981.12155,1160.867403,9050.287293,3875.751381,5297.889503,1127.381215,345.4143646,4048.149171,10341.85635,778.1767956,445.8895028,1440.232044,11750.92265,397.3535912,116.3370166,7083.464088,9337.867403,1769.226519,686.1767956,2836.458564,7643.944751,562.3038674,245.3149171,10305.65746,6042.40884,1099.895028,370.359116,1298.535912,4098.98895,675.5469613,150.9226519,4737.618785,3490.657459,1099.928177,256.480663,3212.513812,873.9226519,432.4696133,181,15.74864564,14.8250216,0.33742571,0.937823834,0.70703125,0.807058253
+1757,36734.9,995.1857143,731.5571429,1238.471429,33909.38571,732.5714286,857.0428571,2082.071429,15617,592.5714286,838.1428571,1926.614286,22952.84286,1296.057143,10134.01429,5246.442857,8464.157143,1356.785714,389.8571429,2877.057143,16397.88571,7687.014286,284.1857143,489.1857143,20220.97143,532.3714286,139.5571429,16545.67143,13941.12857,1797,715.9,2865.271429,11226.8,603.5714286,300.4428571,6755.742857,6249.257143,835.0571429,427.5142857,1293.342857,4846.457143,625.9428571,163.6285714,2682.228571,4301.142857,1195.2,213.3285714,3280.185714,144.3571429,430.2142857,70,10.51792679,8.787848278,0.549473033,0.95890411,0.583333333,1.455894746
+1758,52330.39167,952.4583333,626.625,1153.291667,52126.83333,798.3833333,700.3833333,1841.05,27982.35,619.925,609.7666667,1784.425,39817.45,1414.725,9627.058333,6457.3,14496.91667,1526.366667,427.5583333,2540.075,28271.3,467.15,482.8416667,474.4583333,34363.99167,484.9833333,145.725,7584.975,26296.33333,1671.616667,898.7083333,2815.591667,22593.75,669.05,340.9416667,5503.116667,15405.43333,911.2833333,479.9333333,1317.45,12246.89167,741.325,189.0833333,3878.658333,10169.58333,1463.933333,185.2916667,3364.075,208.2083333,432.5333333,120,17.45937858,8.910174552,0.859974243,0.916030534,0.615384615,-1.031134246
+1759,47471.60839,911.9370629,614.5384615,1138.482517,40723.20979,703.993007,431.8391608,1665.475524,22154.5035,560.6573427,479.8391608,1753.594406,31319.81119,1310.699301,8678.153846,5543.524476,11077.83916,1399.608392,387.9020979,2379.342657,22441.73427,429.5944056,123.2447552,435.1398601,27083.98601,419.4405594,130.4335664,6911.020979,21051.11189,1469.482517,1023.671329,2841.587413,17931.95105,639.3706294,312.4895105,3663.846154,12654.88811,891.7902098,446.6993007,1303.916084,9974.93007,639.3426573,171.1468531,2483.300699,8432.433566,1350.391608,141.6223776,3257.251748,233.027972,433.2727273,143,14.78492249,13.00916716,0.475169699,0.928571429,0.600840336,-0.054722877
+1760,20360.00658,1165.322368,637,1089.592105,18268.48026,757.4868421,615.0657895,1514.138158,9934.401316,606.4539474,665.5394737,1769.052632,13610.82895,1327.657895,3423.828947,2846.256579,4988.460526,1366.756579,363.7434211,2523.585526,9648.881579,445.625,1148.296053,554.0263158,10842.38158,632.3026316,128.4934211,6518.881579,8411.578947,1808.552632,727.25,2845.921053,7352.789474,861.7171053,271.7763158,1831.177632,5855.868421,931.8552632,434.2960526,1378.453947,4715.743421,920.9078947,175.7236842,6090.921053,3939.776316,1282.921053,154.0065789,3437.605263,399.5657895,432.5723684,152,16.02403015,12.20541468,0.6479364,0.95,0.775510204,0.832406395
+1761,35457.84158,890.3960396,496.5148515,1098.356436,30030.0099,738.6138614,737.4257426,1661.831683,17718.43564,659.6039604,1170.792079,1844.227723,24703.37624,1378.633663,6214.80198,3693.336634,8519.673267,1388.50495,412.7920792,2590.524752,16396.44554,488.1683168,923.5445545,1032.138614,19094.48515,455.8415842,136.0693069,2814.50495,14830.46535,2176.722772,771.9009901,2826.089109,13100.18812,791.5544554,291.7722772,1796.693069,10516.11881,1922.831683,461.8811881,1359.514851,7979.188119,1035.009901,177.8712871,3036.415842,7139.128713,1411.930693,241.2970297,3308.09901,497.3960396,431.8415842,101,12.44747124,10.66180684,0.516073998,0.943925234,0.601190476,-1.395784084
+1762,21360.20979,825.9230769,577.3006993,1070.132867,18680.60839,722.4825175,586.2727273,1559.825175,10623.87413,542.4545455,713.4965035,1765.79021,15075.16084,1302.93007,5588.216783,3508.755245,5317.559441,1434.643357,387.9020979,2511.405594,9764.706294,430.3986014,2103.20979,476.3636364,11588.71329,482.993007,127.0559441,3895.706294,9122.132867,1703.72028,881.2657343,2805.615385,8079.797203,653.0769231,269.4545455,1882.363636,6450.251748,892.4545455,439.2447552,1390.636364,5150.181818,1212.251748,175.8601399,5796.881119,4609.181818,1358.258741,382.4265734,3121.769231,559.2517483,433.5174825,143,17.1428324,11.03393533,0.765322375,0.910828025,0.600840336,1.038990684
+1763,21635.06098,806.5365854,483.7073171,1071.439024,20229.53659,729.9390244,556.2560976,1541.365854,10546.30488,505.9390244,788.4634146,1810.109756,16048.64634,1239.743902,4158.402439,2875.219512,5807.036585,1604.317073,346.097561,2833.060976,11410.06098,426.6341463,965.4268293,696.6585366,13212.45122,418.0365854,116.6585366,2185.646341,10283.45122,1785.353659,715.9634146,2885.54878,9058.073171,968.0121951,254.4512195,1897.47561,7243.536585,917.7195122,383.1829268,1355.170732,6138.463415,868.0365854,149.6463415,3555.195122,5028.914634,1310.060976,1090.378049,3170.390244,622.7073171,434.1585366,82,16.10365275,7.63637663,0.880416332,0.788461538,0.465909091,-0.271546605
+1764,20907.47853,766.208589,578.993865,1075.613497,18365.11656,634.202454,617.6871166,1502.687117,10257.74847,494.4969325,904.202454,1786.067485,15621.04908,1204.147239,5073.239264,2051.490798,5536.226994,1389.92638,333.196319,2523.067485,10844.74233,482,1048.398773,917.3558282,12879.51534,392.5337423,164.3251534,1493.03681,9862.07362,1901.300613,610.2208589,2795.441718,8572.153374,1044.619632,245.3558282,1634.417178,7070.644172,969.8282209,394.4662577,1332.588957,5488.865031,869.1717791,153.9631902,3384.944785,4743.748466,1262.484663,1042.042945,3128.09816,695.3803681,431.3865031,163,18.41109115,11.61267833,0.77599129,0.953216374,0.75462963,1.47056118
+1765,33584.01418,943.0851064,579.1631206,1121.219858,31614.19858,757.0141844,745.248227,1661.340426,16851.01418,595.177305,558.3687943,1763.531915,23869.19149,1361.567376,7034.595745,4614.893617,8318.283688,1391.141844,391.0992908,2432.652482,16782.95745,508.6666667,626.8510638,499.0141844,19986.53191,450.8723404,135.5390071,3793.631206,15106.98582,1568.879433,884.5248227,2802.914894,13332.00709,687.177305,304.3333333,3280.93617,10221.97872,910.8085106,460.4255319,1316.851064,8256.64539,785.8510638,183.3546099,4272.659574,6777.049645,1416.092199,519.2340426,3347.446809,312.2269504,433.7801418,141,15.86678196,11.57318042,0.684090834,0.927631579,0.626666667,-0.925210428
+1766,26121.23171,894.7317073,513.2804878,1074.182927,22202.29268,712.3536585,492.7682927,1567.280488,13022.37805,560,504.6585366,1773.231707,18679.14634,1316.402439,7348.914634,2945.792683,6525.95122,1322.987805,362.402439,2428.804878,13130.41463,435.1707317,1393.597561,463.2560976,15168.60976,508.0731707,129.6585366,6340.170732,12099.43902,1532.109756,786.5609756,2811.987805,10661.41463,761.2926829,280.7804878,1654.97561,8622.987805,855.402439,446.6097561,1380.243902,6666.609756,961.4756098,174.7804878,4461.268293,5946.170732,1351.780488,294.4634146,3172.390244,527.7195122,431.5487805,82,12.42343527,8.654362732,0.71744426,0.953488372,0.683333333,-0.887097658
+1767,18694.90435,820.3043478,557.7913043,1073.669565,15824.47826,654.7913043,467.0956522,1469.721739,8833,520.6086957,442.3913043,1772.443478,12723.70435,1270.947826,4178.86087,2523.678261,4502.095652,1333.173913,371.1217391,2453.478261,9100.521739,438.7478261,1769.069565,485.2173913,11041.2087,389.5826087,124.5217391,3434.547826,8490.826087,1539.2,890.9565217,2808.417391,7424.417391,671.4695652,272.4956522,1626.121739,6009.434783,888.4521739,439.3913043,1381.147826,4842.921739,1094.295652,172.9043478,5329.634783,4328.208696,1331.034783,1058.417391,3087.426087,538.1217391,433.3913043,115,12.97641288,11.43239212,0.473091529,0.927419355,0.680473373,0.057427264
+1768,34773.18056,830.9861111,461.9305556,1079.75,29371.25,693.5694444,571.25,1559.513889,17332.36111,524.4166667,1190.055556,1750.513889,23939.34722,1280.569444,3957.125,3459.458333,8865.055556,1292.861111,361.3333333,2664.236111,17591.26389,453.1527778,672.1805556,652.9444444,20459.34722,1200.208333,119.1111111,2480.138889,16477.375,1506.277778,636.5138889,2796.888889,14577.33333,635.0277778,268.6805556,1880.805556,11586.88889,1152.888889,412.0138889,1307.958333,8470.805556,784.6111111,167.5694444,4289.736111,7351.513889,1346.555556,1093.583333,3191.319444,723.2916667,431.1527778,72,11.85167506,7.97377001,0.739827248,0.935064935,0.615384615,-1.345902807
+1769,36066.55556,840.0350877,536.5672515,1108.982456,7758.292398,390.9122807,194.5497076,1105.812865,3168.380117,325.2163743,296.4093567,1583.204678,5759.017544,827.2573099,2033.836257,1075.432749,2086.842105,878.8596491,244.502924,2471.093567,3732.807018,430.4385965,193.7192982,415.3625731,4479.666667,250.8596491,98.89473684,2179.853801,3387.245614,1191.964912,509.3450292,2778.795322,2611.824561,424.8304094,170.6959064,1849.906433,1801.906433,556.4327485,290.5497076,1242.900585,861.1754386,509.128655,122.2046784,704.6725146,942.1111111,781.0760234,113.1052632,2798.432749,1100.830409,437.0526316,171,20.58454255,10.94404453,0.846955844,0.886010363,0.7125,0.002316882
+1770,53966.55882,964.4495798,562.2310924,1177.189076,8547.983193,386.8403361,204.3193277,1121.235294,3346.462185,326.7647059,418.4789916,1590.941176,6311.264706,860.0546218,2315.651261,1190.352941,2232.432773,847.8067227,243.6722689,2472.668067,3997.201681,239.5672269,120.4411765,455.8655462,4731.718487,336.6722689,100.8781513,1740.441176,3495.764706,1151.52521,485.4159664,2774.714286,2652.504202,418.289916,170.1806723,1107.306723,1756.735294,576.2731092,288.6260504,1242.605042,811.789916,474.1176471,121.2941176,750.5672269,902.0462185,769.5714286,75.82773109,2796.651261,1112.739496,436.3193277,238,21.75095141,14.63542268,0.739766601,0.901515152,0.74375,-0.059654843
+1771,28998.40789,784.1578947,404.3552632,1053.828947,25877.14474,640.0789474,595.3684211,1525.131579,14448.61842,500.4210526,1348.315789,1786.25,20127.02632,1215.263158,3757.276316,1996.802632,7015.657895,1226.460526,351.1578947,2520.684211,14618.63158,419.3684211,290.5263158,1903.513158,17029.09211,398.0921053,601.4605263,1646.868421,13741.84211,1606.486842,633.2894737,2816.342105,12125.19737,646.9342105,255.5131579,1570.539474,9584.421053,902.3421053,388.0657895,1306.578947,7448.776316,733.8815789,159.9736842,3166.315789,6377.105263,1432.644737,906.1973684,3100.894737,639.5526316,433.4078947,76,13.32936892,7.528225866,0.825238179,0.904761905,0.575757576,-0.937755631
+1772,33260.60465,816.4651163,424.7209302,1081.139535,28992.51163,667.7674419,370.3488372,1515.511628,16886.02326,528.627907,394.6976744,1735.767442,23202.95349,1262,1273.651163,1148.209302,8335,1252.674419,339.6511628,2448.372093,17025.44186,443.5581395,125.9767442,445.255814,19723.90698,393.627907,120.3023256,1203.651163,15734.86047,1368.930233,520.8604651,2973.162791,13773.37209,602.6511628,264.2093023,1711.069767,11104.51163,801.372093,411.2093023,1288.534884,8113.674419,629.5813953,158.6046512,1272.837209,6889.744186,1512.465116,14881.11628,3174.255814,735.3023256,432.3488372,43,7.861057568,7.389744035,0.341051775,0.955555556,0.530864198,1.036608798
+1773,35294.81429,796.9571429,411.5285714,1064.371429,30355.81429,655.5,795.6714286,1563.171429,18277.72857,536.1285714,1795.585714,1822.514286,24831.77143,1250.071429,2924.071429,3132.628571,8888.342857,1250.928571,348.2428571,2508.671429,18008.84286,463.7428571,286.8285714,1433.571429,20971.54286,422.3714286,119.9571429,1859.057143,17381.62857,1809.742857,584.4571429,2828.057143,14916.65714,607.4428571,266.3428571,2017.214286,12172.24286,1713.657143,421.2571429,1310.357143,8745.371429,686.6571429,164.9285714,2828.557143,7603.314286,1324.8,547.3714286,3427.085714,777.8285714,433.1857143,70,11.14579663,8.645760613,0.631105554,0.909090909,0.53030303,0.779293662
+1774,24175.39394,785.9848485,457.9242424,1039.469697,20687.83333,632.0454545,591.4545455,1487.454545,12014,513.9242424,1263.363636,1782.151515,17041.09091,1204.348485,5477.863636,4164.136364,6302.80303,1217.045455,341.1363636,2435.69697,11956.77273,446.8181818,297.6818182,835.9545455,13807.25758,681.530303,127.6969697,3247.424242,11318.01515,1777.606061,762.7878788,2791.878788,9560.969697,721.6515152,261.6666667,3171.106061,7715.954545,1478.954545,391.9393939,1313.015152,5818.530303,660.4393939,159.0606061,4243,4860.984848,1270.348485,929.6969697,3164.772727,793.9848485,432.2878788,66,9.959049752,8.68836393,0.488776698,0.929577465,0.733333333,-0.241668601
+1775,23946.15244,730.1341463,458.7621951,1058.152439,13027.59756,524.3170732,385.0487805,1436.359756,6872.158537,407.6280488,470.2804878,1732.079268,9942.396341,1019.408537,5945.810976,3424.585366,3729.847561,1070.780488,297.6280488,3033,7083.27439,591.0487805,666.2256098,530.8902439,8435.073171,360.5731707,110.2804878,7911.603659,6642.664634,1375.347561,852.7621951,2775.628049,5640.310976,572.8353659,221.3902439,6721.646341,4617.634146,756.445122,350.1585366,1289.530488,3087.652439,721.195122,151.4512195,3393.170732,2688.5,1031.75,162.4085366,3162.884146,895.4878049,435.4817073,164,14.91750265,14.4051783,0.25982337,0.964705882,0.602941176,0.114407083
+1776,22078.91398,803.2258065,545.4247312,1111.731183,11925.59677,493.7096774,370.1344086,1375.758065,6116.790323,387.6129032,440.0645161,1695.564516,8795.311828,955.5322581,4413.016129,2292.956989,3287.935484,1008.61828,288.5860215,2975.123656,6257.946237,725.7150538,1093.102151,505.6344086,7109.413978,372.6075269,103.3870968,5377.973118,5970.569892,1338.580645,643.6236559,2799.344086,4910.822581,573.4946237,207.1451613,4400.795699,3932.752688,775.5322581,340.8548387,1290.268817,2581.026882,809.1666667,139.4139785,2232.005376,2300.580645,978.9354839,117.9301075,3032.505376,926.172043,435.1344086,186,16.27428273,14.6741721,0.432406918,0.953846154,0.688888889,1.331226757
+1777,20220.7037,656.9351852,392.7314815,1025.361111,16434.72222,508.2685185,379.5185185,1402.361111,8310.018519,398.3981481,342.3240741,1687,13145.23148,1053.138889,4157.814815,1164.333333,4665.342593,1030.574074,293.1111111,2385.481481,8290.731481,10308.33333,125.712963,405.8611111,9934.851852,410.6203704,110.1388889,3344.990741,8357.814815,1251.416667,580.8055556,2785.990741,6674.203704,1037.416667,218.3333333,4013.12963,5314.87963,663.0092593,347.3240741,1266.944444,3189.972222,562.0092593,139.9537037,1486.333333,2968.481481,996.4444444,108.2962963,3023.203704,990.1481481,434.2592593,108,13.10209193,10.58043535,0.58981573,0.947368421,0.639053254,0.881357035
+1778,46773.74766,909.2897196,604.5981308,1176.364486,29519.15888,650.8785047,637.6635514,1761.084112,15816.92523,531.2523364,739.3738318,1776.719626,21886.71028,1206.616822,10198.66355,5509.588785,8593.233645,1280.327103,363.7383178,2502.990654,16369.81308,413.0560748,132.2242991,531.6168224,20035.51402,750.3271028,130.8971963,8275.915888,14990.28037,1430.065421,656.9439252,2798.401869,12446.63551,578.1588785,300.9252336,11244.5514,8412.588785,875.728972,435.1214953,1326.196262,6993.71028,621.7102804,171.9158879,4189.429907,5772.056075,1264.140187,357.728972,3306.981308,186.5794393,434.6728972,107,14.82027581,10.07471024,0.733404629,0.87704918,0.587912088,-0.765472646
+1779,33227.32886,1064.644295,550.0738255,1114.496644,28762.48993,826.2281879,631.6644295,1666.456376,16448.38255,616.2885906,758.442953,1782.919463,23259.69799,1472.147651,3323.758389,3798.718121,8119.080537,1444.395973,407.3355705,2663.308725,15639.91946,477.885906,594.7449664,710.1543624,18063.07383,488.3288591,221.8389262,3702.563758,14010.14094,1929.644295,787.5704698,2845.375839,12408.36913,825.6912752,309.3020134,1906.147651,9918.832215,1079.087248,482.033557,1420,7619.684564,826.6040268,195.0805369,7660.107383,6665.040268,1460.288591,363.1409396,3357.825503,420.1812081,435.7583893,149,16.03280492,12.05634873,0.659185916,0.949044586,0.764102564,0.675299457
+1780,23680.9,1142.65,512.6642857,1090.642857,23754.34286,840,569.0071429,1501.257143,11632.86429,660.9571429,489.6857143,1729.235714,17265.02857,1567.235714,1208.964286,1254.085714,5774.728571,1533.457143,403.9571429,2459.992857,11306.88571,498.3357143,488.2357143,604.1428571,13072.85,466.6785714,137.7285714,1102.1,10299.62143,1687.921429,717.25,2813.342857,8966.092857,672.4285714,300.95,1494.6,7295.207143,921.8571429,463.2714286,1338.671429,5834.328571,808.4571429,182.6142857,1706.3,4924.557143,1519.428571,570.0142857,3334.421429,472.8785714,434.8214286,140,14.05900921,12.67611344,0.432495008,0.965517241,0.769230769,-1.041235675
+1781,25187.08197,799.5819672,443.3442623,1074.598361,20677.21311,667.8196721,470.9590164,1476.778689,12195.2377,513.0409836,487.9672131,1767.696721,17278.2623,1287.418033,3361.581967,2341.877049,6112.418033,1251.729508,340.3770492,2432.590164,12182.2623,424.0163934,544.2377049,649.5327869,14111.40984,393.6229508,116.147541,2016.5,11272.45902,1466.836066,777.7786885,2815.819672,9737.45082,641.2213115,266.0081967,1840.229508,7774.778689,868.6311475,409.1311475,1306.131148,6057.909836,757.1721311,155.3606557,2474.07377,5411.147541,1347.696721,1844.581967,3127.418033,600.9098361,435.4590164,122,16.89226518,9.502510645,0.826772656,0.938461538,0.67032967,0.906155153
+1782,31635.69333,865.36,463.64,1083.626667,26763.56,696.0666667,609.6533333,1574.2,15772.97333,553.16,1645.893333,1749.586667,21484.22667,1338.173333,3553.72,3124.04,7797.493333,1267.853333,367.5733333,2633.56,15677.97333,469.8666667,450.48,1577.666667,18173.06667,439,121.0533333,1881.426667,14849.89333,1794.826667,641.32,2819.2,12929.64,650.4666667,273.56,1978,10552.88,1583.613333,435.4666667,1321.653333,7638.36,750.8266667,165.64,3167.013333,6560.4,1396.48,2124.28,3224.2,767.44,433.1733333,75,13.65095549,7.180977404,0.850458524,0.9375,0.694444444,-1.023602231
+1783,29888.87574,776.8402367,453.147929,1062.656805,26227.13018,641,1096.224852,1626.994083,14549.40828,492.0295858,1310.461538,1782.313609,20704.60355,1176.863905,5449.710059,3304.04142,7334.757396,1205.461538,341.3905325,4973.35503,14471.75148,8236.757396,208.8106509,1111.923077,16968.31361,686.556213,126.3668639,3132.804734,13465.55621,1863.390533,553.5976331,2814.011834,11037.99408,582.6627219,261.6982249,4581.023669,9086.798817,1791.349112,398.1656805,1299.556213,6355.775148,647.3550296,158.6923077,3143.792899,5455.384615,1193.822485,267.183432,3253.029586,841.8934911,436.1242604,169,16.98563016,13.30237959,0.621826659,0.871134021,0.662745098,1.315194643
+1784,19544.32515,841.5644172,633.2453988,1082.95092,16931.30061,673.5398773,692.4785276,1659.453988,9002.251534,501.4601227,1020.981595,1787.453988,13867.69939,1198.331288,6607.932515,4091.128834,4757.748466,1198.202454,444.4662577,3619.257669,9219.723926,1950.226994,2359.871166,696.4355828,10609.74847,435.6196319,123.7239264,9797.95092,8380.631902,1973.361963,707.8466258,2795.619632,6773.797546,552.0490798,272.0490798,11276.96319,5560.104294,1296.202454,391.0490798,1352.846626,3891.797546,1235.674847,155.9325153,5593.773006,3318.306748,1171.705521,238.006135,3250.766871,857.4969325,436.208589,163,17.71887835,11.95986209,0.737837389,0.931428571,0.639215686,-1.013098386
+1785,25296.62416,925.9060403,563.9261745,1121.402685,19556.21477,573.0134228,296.8590604,1459.288591,10739.10738,432.9127517,345.0268456,1697.483221,15914.86577,1116.731544,4581.657718,2293.442953,5660.174497,1147.798658,349.2684564,2519.181208,10963.47651,638.8590604,2888.255034,426.1812081,12774.73154,331.8322148,115.261745,4424.671141,10633.98658,1366.95302,629.7181208,2774.120805,8892.597315,532.6778523,255.0604027,5319.785235,7330.449664,767.9865772,376.9597315,1321.402685,4781.885906,1314.697987,147.3825503,3405.557047,4300.966443,1130.248322,169.4899329,3140.214765,909.409396,436.8322148,149,16.26387544,11.78577872,0.689106666,0.937106918,0.62605042,0.483169418
+1786,17610.41463,731.8397213,516.3797909,1106.174216,14136.8676,579.6968641,438.2229965,1685.031359,6705.996516,434.0487805,434.1811847,1769.794425,10652.06969,1094.630662,5212.885017,2054.923345,3897.526132,1169.355401,320.4599303,2394.609756,7243.358885,3498.250871,521.4355401,445.7212544,8946.125436,478.6132404,116.3379791,6824.069686,7166.947735,1314.651568,645.4041812,2797.15331,5655.351916,738.5156794,255.1498258,18914.26829,4481.480836,738.9930314,365.543554,1326.66899,2630.45993,706.6724739,148.9860627,4282.533101,2520.839721,1075.006969,188.3101045,3226.362369,1020.432056,440.7456446,287,24.81306667,15.00930938,0.796304954,0.931818182,0.703431373,0.231764839
+1787,29173.8843,859.5619835,520.9256198,1105.760331,9639.049587,403.4793388,179.7768595,1189.966942,3292.38843,321.7520661,206.1322314,1585.371901,5973.876033,807.5454545,915.661157,802.7272727,2062.77686,849.5041322,243.4876033,2273.421488,3555.099174,215.0991736,114.5206612,364.5454545,4228.983471,234.3884298,90.47933884,1146.520661,2996.958678,1076.68595,459.0330579,2754.504132,2209.727273,421.5371901,164.6033058,1001.157025,1322.884298,522.9338843,286.0495868,1250.099174,600.9008264,459.4628099,113.9504132,471.9834711,689.3801653,750.1322314,86.79338843,2782.619835,1130.603306,434.5785124,121,13.03369889,11.88243055,0.410923412,0.9453125,0.720238095,-1.439140493
+1788,48703.89381,940.6637168,600.2566372,1154.477876,46634.97345,791.699115,845.0265487,1892.619469,24367.36283,608.8495575,1056.132743,1833.973451,34305.30973,1417.619469,9158.141593,7161.035398,13010.69912,1508.548673,431.7699115,3838.451327,24598.53982,486.0707965,995.300885,769.079646,29811.74336,716.0884956,144.6371681,6755.823009,22417.36283,1959.327434,743.2566372,2837.424779,19005.04425,640.9026549,334.0884956,4742.212389,12512.09735,1119.530973,477.3274336,1337.106195,10160.61062,862.9646018,189.6371681,4210.106195,8321.079646,1437.973451,301.7433628,3323.00885,195,437.9115044,113,16.08555032,9.502521189,0.806855461,0.856060606,0.588541667,-0.309363774
+1789,49090.54198,907.3587786,562.9541985,1142.587786,37908.42748,686.8167939,542.740458,1679.961832,21297.17557,550.9923664,501.0152672,1786.610687,29893.12977,1279.938931,6754.916031,4854.89313,10729.89313,1366.641221,383.4045802,2435.59542,21880.74809,421.7633588,131.7557252,450.2671756,25705.72519,416.3664122,130.9618321,6107.053435,20743.98473,1497.961832,843.3358779,2827.427481,17662.9771,636.5954198,309.8091603,3911.564885,13076.91603,869.5954198,452.9541985,1302.061069,9867.290076,648.5267176,173.4732824,2182.160305,8614,1329.21374,143.5419847,3273.587786,249.6793893,435.2137405,131,18.3728034,9.575910611,0.853434385,0.891156463,0.606481481,1.458591256
+1790,40490.85185,876.287037,574.1944444,1138.601852,35215.35185,707.9537037,614.6018519,1673.611111,19666.50926,563.7407407,821.7037037,1818.944444,27347.35185,1298.287037,8771.907407,5333.740741,9964.972222,1362.796296,381.0092593,2659.638889,20238.96296,504.2037037,268.7685185,662.3148148,24200.58333,445.1759259,133.0740741,5100.87037,18605.59259,1676.935185,970.3981481,2812.583333,16383.65741,611.8425926,313.3148148,2588.898148,12265.72222,928.7962963,450.712963,1316.805556,9429.305556,679.0462963,182.287037,3269.805556,8124.212963,1371.907407,164.4907407,3321.490741,272.6111111,436.0462963,108,14.83768371,9.633094157,0.760590718,0.923076923,0.6,1.157943833
+1791,35387.28662,860,555.089172,1107.764331,32104.35669,701.0828025,524.9808917,1707.828025,18157.6242,556.4968153,621.5095541,1813.33121,24938.40764,1286.828025,6665.375796,4836.961783,9395.356688,1370.095541,387.2929936,2517.006369,18796.59236,473.0254777,261.388535,494.9490446,21987.86624,433.2738854,132.1210191,4717.917197,16683.74522,1591.713376,1091.643312,2806.280255,14838.00637,619.8471338,303.7324841,2173.343949,11405.64331,968.7515924,464.3057325,1300.923567,8851.350318,686.0191083,183.4203822,3552.828025,7484.070064,1372.649682,142.2101911,3290.821656,295.0509554,437.1910828,157,15.82291738,13.55585233,0.51577731,0.892045455,0.654166667,-0.953269655
+1792,16328.88679,908.3207547,446.6981132,1015.45283,14650.69811,583.3207547,321.0943396,1310.311321,7788.226415,466.5283019,354.7735849,1657.349057,11678.0283,1125.075472,1162.311321,1349.688679,4126.849057,1100.745283,313.8962264,2367.716981,8075.896226,375.1886792,92.23584906,443.2358491,9307.783019,365.254717,104.5566038,1108.09434,7569.113208,1225.679245,508.4622642,2792.490566,6629.981132,554.8773585,223.1603774,1594.283019,5438.122642,700.5283019,362.0566038,1282.622642,4114.792453,569.6037736,147.4716981,1387.330189,3511.669811,1212.518868,4704.037736,3166.273585,743.4433962,435.8301887,106,13.80484366,10.15021484,0.677780021,0.938053097,0.582417582,-0.910151913
+1793,27859.50955,843.2993631,518.2038217,1087.993631,23833.01274,707.0318471,862.8917197,1658.477707,13459.17834,512.4522293,1803.477707,1807.509554,18726.94268,1284.968153,5379.713376,3597.936306,6614.10828,1227.038217,364.611465,4166.165605,13019.05096,879.388535,2745.019108,1887.140127,15008.41401,754.2101911,391.2611465,3457.566879,12022.80892,2124.216561,583.1910828,2871.471338,9922.057325,615.7133758,268.4840764,9707.11465,8005.248408,2521.802548,406.3503185,1346.917197,5678.993631,1399.624204,207.9235669,8044.127389,4795.783439,1222.382166,464.0509554,3330.751592,827.4840764,436.4012739,157,15.18769119,13.46671355,0.462372026,0.93452381,0.801020408,-0.312335838
+1794,23528.70118,763.4467456,525.6153846,1114.923077,15707.66568,532.0769231,403.1893491,1492.650888,7345.878698,409.2899408,663.8076923,1720.201183,12271.98521,1023.615385,3913.683432,1586.763314,4450.467456,1069.994083,319.2426036,2888.801775,8273.911243,531.0828402,767.8106509,595.7751479,10216.83136,352.964497,108.2544379,3966.677515,8118.177515,1370.819527,526.204142,2882.905325,6420.920118,531.5443787,231.1775148,9057.769231,4868.893491,745.8402367,347.8550296,1301.381657,2651.997041,788.6242604,144.2988166,2615.224852,2666.071006,992.387574,167.8698225,3058.920118,1047.718935,442.5414201,338,23.73311937,19.08105571,0.594650504,0.949438202,0.638941399,-0.914008877
+1795,17750.82883,746.5945946,525.8828829,1074.981982,9684.855856,394.8918919,178.0990991,1113.846847,3979.072072,322.6846847,482.009009,1579.531532,6674.189189,817.3873874,1497.45045,798.8828829,2445.252252,883.5225225,242.9369369,2585.63964,4347.432432,369.7027027,72.22522523,450.6396396,5202,259.8738739,89.27027027,1538.648649,3905.477477,1112,499.2252252,2768.54955,3098.441441,455.3153153,200.2252252,1426.153153,2096.747748,556.9009009,293.2882883,1254.972973,976.4414414,465.4864865,124.1261261,544.6216216,1037.846847,783.4684685,70.98198198,2809.126126,1090.45045,436.8378378,111,13.43279262,10.71670671,0.602919745,0.948717949,0.720779221,-0.121831494
+1796,21334.80435,810.2065217,554.5,1210.5,20091.16304,629.826087,628.0326087,1905.945652,9450.902174,535.25,846.8369565,1905.163043,14166.51087,1212.717391,5686.945652,3928,5319.293478,1235.836957,356.1413043,3303.826087,10448.56522,7515.847826,789.4565217,512.076087,12395.29348,521.0543478,126.6304348,7495.771739,8944.26087,1768.304348,697.25,2783.380435,7478.445652,603.6304348,253.6304348,5508.206522,4385.315217,887.7717391,415.3043478,1300.380435,3495.923913,727.1086957,161.1521739,3217.869565,3096.25,1150.152174,186.8043478,3229.173913,151.1630435,435.7282609,92,14.34180039,8.2573735,0.817621771,0.968421053,0.643356643,-0.954512184
+1797,31893.66225,865.7615894,464.9139073,1065.211921,25289.36424,661.9072848,558.4039735,1541.192053,14428.51656,569.7615894,920.4370861,1804.046358,20119.12583,1269.807947,4025.807947,2703.980132,7314.039735,1619.337748,374.0927152,2616.649007,14971.37086,536.0066225,901,695.7483444,17192.75497,716.2913907,130.3774834,1672.450331,13299.87417,1838.980132,806.0596026,2852.715232,11781.11258,681.8145695,279.9072848,1569.900662,9376.635762,1168.483444,442.4172185,1328.07947,7442.887417,1298.503311,168.2781457,2075.211921,6378.231788,1330.178808,150.3642384,3354.271523,512.2251656,436.5496689,151,19.22401567,10.3346553,0.843205821,0.904191617,0.580769231,1.426316993
+1798,37282.57432,890.3581081,477.3108108,1099.533784,31288.63514,718.9324324,526.1824324,1593.067568,18158.87162,554.6418919,1374.891892,1748.155405,24475.93919,1362.722973,5357.364865,3716.412162,8886.094595,1313.472973,364.277027,2517.256757,17842.89865,487.3040541,249.9054054,973.5810811,21198.18919,1135.425676,170.1554054,2676.655405,16072.89865,1843.614865,708.5405405,2796.310811,14011.47297,639.4527027,286.9662162,1753.844595,11084.33784,1332.614865,421.2635135,1300.594595,8483.108108,677.8310811,165.222973,3851.331081,7258.337838,1395.506757,1491.182432,3141.236486,672.0135135,437.3175676,148,15.56564173,12.54988823,0.591567119,0.925,0.758974359,-0.42119021
+1799,32067.29661,825,648.6864407,1099.720339,28010.5,686.7372881,714.7033898,1628.355932,16071.27966,521.9661017,951.5932203,1759.635593,22808.20339,1293.262712,4656.745763,2939.525424,8060.728814,1298.415254,354.5762712,2545.355932,16301.5339,498.7033898,513.3813559,1275.016949,19610.99153,523.9237288,170.8898305,2341.618644,14729.78814,1703.016949,696.6694915,2794.101695,12791.55085,626.8983051,273.6610169,1782.29661,10381.42373,1100.016949,423.7966102,1323.050847,7974.677966,744.0084746,161.1864407,2435.194915,6919.889831,1346.686441,303.7966102,3160.762712,684.1694915,437.7711864,118,13.13742166,11.7751092,0.443442332,0.944,0.648351648,0.473480608
+1800,22344.08696,750.1521739,574.6195652,1075.853261,11792.81522,464.8804348,368.8043478,1304.777174,5261.11413,372.5652174,301.375,1643.065217,9243.211957,999.0978261,6516.597826,2508.875,3322.190217,981.9456522,281.3423913,2440.48913,6165.054348,789.7554348,929.2880435,388.798913,7329.195652,303.75,102.326087,10249.58152,5804.413043,1205.461957,594.25,2811.418478,4597.413043,475.9184783,201.5597826,5756.413043,3494.179348,628.0380435,327.1793478,1265.706522,1809.858696,779.7445652,135.8478261,2978.445652,1863.907609,893.6847826,123.7880435,2960.831522,1063.222826,439.0923913,184,18.76749794,12.87658888,0.727496764,0.948453608,0.691729323,0.148756463
+1801,48181.55556,1087.472222,560.5833333,1137.611111,42161.16667,838.9444444,693.9444444,1735.388889,24705.41667,653.0555556,496.8333333,1804.888889,33993.69444,1498.5,5019.972222,3216.25,11217.08333,1495.555556,416.7222222,2388.972222,22360.91667,455.6666667,352.3333333,451.7222222,26985.02778,445.7777778,138.6388889,3684.166667,21606,1597.888889,764.25,2822.805556,18307.66667,647.1944444,319.5,1438.777778,14058.16667,913.8611111,482.9444444,1294.972222,10997.08333,740.0277778,176.75,2847.305556,9860.305556,1444.861111,110.7777778,3528.722222,377.2222222,435.6111111,36,8.379386426,5.917807957,0.707978443,0.87804878,0.642857143,0.209539576
+1802,44243.87234,849.9148936,437.6382979,1095.851064,37363.17021,700.893617,677.6808511,1582.659574,22652.61702,558.3617021,626.6595745,1754.170213,30651.89362,1332.787234,4291.085106,2130.851064,10930.51064,1371.234043,361.6808511,2498.021277,22463.10638,445.3191489,183.106383,600.7021277,25688.23404,394.9787234,141.0638298,2266.638298,21258.51064,1618.06383,777.3404255,2817.553191,18695.44681,651.4680851,287.2553191,1755.510638,14614.34043,903.5319149,438.1276596,1311.12766,11225.2766,680.893617,164.9574468,2012.276596,9742.297872,1398.851064,414.3191489,3225.234043,629.5957447,434.9787234,47,8.939110964,6.793463427,0.649957201,0.94,0.734375,-0.827503348
+1803,19744.47191,752.6067416,618.5280899,1110.94382,16805.98876,615.3370787,486.7303371,1733.224719,8006.764045,439.1123596,420.1235955,1741.786517,12226.06742,1101.651685,3567.797753,1549.438202,4479.438202,1187.808989,327.1797753,2439.876404,8152.876404,829.494382,137.0674157,464.1797753,10097.34831,432.0786517,112.1573034,3971.438202,8029.404494,1366.47191,668.0224719,2814.235955,6353.426966,609.9550562,251.2921348,12061.64045,4990.191011,696.5505618,369.8651685,1298.449438,2904.123596,629.1460674,145.9662921,3651.820225,2828.382022,1138.191011,144.247191,3233.213483,1007.640449,438.247191,89,12.85949237,10.16895277,0.612108171,0.917525773,0.618055556,-0.811425817
+1804,35133.56021,821.5759162,544.1937173,1118.340314,27419.13089,595.6387435,362.2774869,1559.413613,14284.48168,490.026178,503.3455497,1795.507853,20572.68586,1126.089005,5779.34555,2646.120419,7371.094241,1230.21466,336.1413613,2366.539267,14726.71204,360.1780105,128.6492147,434.6282723,17458.38743,371.2931937,117.5549738,4096.848168,13642.58639,1346.958115,665.0732984,2825.827225,11691.11518,604.1256545,259.4712042,3698.293194,8100.774869,726.5445026,388.7329843,1294.062827,6500.513089,599.0890052,157.2094241,1880.340314,5407.937173,1176.209424,160.7696335,3195.287958,223.0314136,441.6125654,191,19.15062997,15.05898625,0.617788674,0.734615385,0.589506173,0.378971687
+1805,42520.61538,884.3333333,490.3846154,1094.153846,36678.17949,709.5641026,509.2307692,1592.974359,21923.28205,569.2820513,496.2564103,1705.564103,29892.5641,1375.538462,4126.74359,3075.410256,10787.94872,1348.102564,391.4358974,2464.179487,21997.82051,493.6153846,141.2564103,467.3846154,25802.69231,449.1538462,127.7692308,3219.974359,20547.05128,1471.871795,673.7692308,2792.820513,18100.30769,618.2820513,307.2051282,1771.820513,14559.71795,913.8205128,422.0512821,1308.358974,10517.23077,632.7179487,174.7692308,2059.923077,9133,1506.435897,5091.538462,3207.025641,730.7948718,437.6153846,39,9.276405824,5.864756541,0.774786524,1,0.65,-0.064324491
+1806,7304.903226,634.1935484,422.7096774,1053.612903,7585.225806,519.9677419,882.4193548,1480.064516,2865.516129,400.6129032,963.8064516,1762.483871,6096.645161,1122.193548,8273.83871,3103.516129,2208.83871,1033.225806,282.3225806,3828.967742,3913.677419,2701.387097,157.7096774,644.6774194,4802.064516,441.5806452,111.483871,6847.548387,3936.225806,2224.129032,683.3870968,2814.16129,3165.225806,1377.677419,207.8064516,9450.064516,2613.709677,978.3548387,339.9032258,1310.032258,1850.419355,595.516129,138.6129032,4642.870968,1613.064516,1019.387097,229.4193548,3091.967742,981.5483871,436.2580645,31,6.73831506,6.330303123,0.342688836,0.885714286,0.632653061,0.059466447
+1807,43417.76531,983.7142857,536.6734694,1132.153061,39224.57143,766.8061224,573.8265306,1702,22447.20408,610.4387755,566.7653061,1833.744898,31101.44898,1422.510204,4498.918367,3051.357143,11195.92857,1503.734694,400.6428571,2487.5,21000.19388,454.255102,380.5816327,631.3571429,24292.69388,453.2040816,137.6734694,3811.193878,19031.57143,1656.204082,752.4081633,2830.77551,16273.16327,724.5204082,316.2040816,1589.928571,13069.19388,912.7959184,476.9183673,1331.459184,10124.19388,746.7755102,184.1836735,4720.081633,8776.795918,1427.653061,126.0306122,3358.479592,369.6632653,439.7959184,98,11.43792205,11.1428315,0.225683463,0.91588785,0.579881657,0.292406411
+1808,22979.8593,763.9849246,574.9246231,1130.055276,13639.15075,564.8743719,573.9447236,1689.366834,7123.562814,423.0452261,698.2864322,1806.638191,10749.56281,1076.552764,7561.773869,3860.502513,3931.005025,1104.673367,314.6432161,3485.321608,7433.447236,3418.58794,427.6633166,476.0452261,8582.231156,405.4673367,116.1105528,9920.623116,7126.763819,1528.728643,928.8844221,2911.090452,5841.592965,622.6030151,257.8994975,23976.21608,4814.301508,840.7386935,369.5477387,1332.356784,3131.788945,700.1256281,182.678392,6282.522613,2877.482412,1097.944724,181.2713568,3209.427136,941.6532663,441.2914573,199,19.69924637,13.24427106,0.740257242,0.9342723,0.663333333,1.53480431
+1809,21298.48718,922.2222222,800.1880342,1211.581197,19266.17949,685.8547009,811.4358974,1821.880342,9148.042735,562.9487179,1537.717949,1951.547009,13656.88889,1253.410256,13740.28205,6362.145299,5203.230769,1314.076923,399.034188,7480.521368,10517.80342,584.9145299,3118.495726,690.7606838,12803.64957,479.3162393,137.4786325,19493.5641,9355.777778,2540.529915,993.5726496,2806.871795,7950.307692,586.6495726,301.034188,18730.77778,4974.760684,1451.897436,425.1282051,1365.017094,4253.239316,1254.854701,171.008547,7496.059829,3787.735043,1274.051282,362.4615385,3371.905983,158.5897436,441.8461538,117,14.55209547,10.51831448,0.691052974,0.959016393,0.6,-0.485915258
+1810,33222.67647,845.9411765,660.7058824,1118.352941,31485.77941,690.7794118,621.8382353,1717.573529,16049.17647,554.4852941,693.7205882,1819.411765,23446.76471,1280.985294,13652.36765,9658.75,8459.382353,1325.044118,363.9705882,2596.426471,16932.57353,437.2941176,136.8235294,581.5,20550.11765,427.3970588,126.4264706,8104.279412,15290.22059,1632.808824,1113.720588,2810.661765,13312.79412,633.25,292.6176471,3187.441176,9895.573529,864.8970588,433.2352941,1287.029412,7946.5,630.5147059,173.3088235,4448.25,6489.882353,1326.838235,171.3382353,3271.676471,262.5735294,440.0588235,68,10.60685591,8.377127708,0.613384743,0.906666667,0.618181818,-0.046169943
+1811,31455.91667,966.5079365,589.1349206,1113.107143,28668.09921,747.5634921,632.5,1665.75,16126.63095,595.6865079,540.4801587,1791.992063,21554.4246,1355.777778,7048.555556,4386.904762,7981.757937,1376.555556,389.2142857,2429.634921,16040.35317,616.8809524,886.7380952,465.1150794,18705.44444,452.6507937,136.4761905,7001.285714,14141.99603,1609.730159,924.9444444,2834.698413,12462.43651,655.6746032,304,2158.337302,9902.103175,950.8095238,461.3849206,1335.357143,7830.079365,956.4365079,184.7936508,5086.833333,6525.22619,1400.940476,330.4206349,3418.222222,324.5198413,442.797619,252,21.18132701,16.01460384,0.654488692,0.919708029,0.636363636,-1.029594843
+1812,37189.52727,939.3090909,510.3090909,1113.781818,33077.09091,765.6,613.6181818,1614.2,19436.01818,584.8,603.0545455,1741.272727,26209.76364,1380.327273,3481.8,2648.381818,9120.181818,1624.581818,398.4181818,2500.927273,19540.92727,470.4,1118.872727,626.2363636,21907.18182,437.7272727,141.2909091,2488.145455,17803.18182,1781.654545,740.2545455,2828.763636,15341.85455,993.9818182,322,1471.163636,12038.10909,965.6,497.3090909,1419.109091,8962.418182,902.6,186.0363636,4256.927273,8099.690909,1476.436364,244.6,3326.236364,359.8181818,438.9090909,55,10.12463796,6.998285774,0.722650668,0.948275862,0.679012346,-0.708021818
+1813,20834.99487,781.9282051,403.5897436,1054.707692,18284.45128,642.9692308,436.2974359,1441.85641,10223.39487,494.4820513,408.1435897,1754.784615,14758.24103,1273.45641,1474.830769,1050.241026,5322.466667,1214.266667,331.4512821,2419.902564,10013.50256,414.825641,142.0923077,443.1641026,11623.38974,393.025641,117.774359,968.5948718,9267.220513,1338.717949,633.5846154,2846.117949,8180.34359,712.0923077,254.4102564,1582.779487,6551.835897,813.2923077,401.5384615,1300.671795,5165.266667,689.2820513,160.1538462,2104.558974,4594.066667,1320.276923,1827.466667,3110.005128,592.0974359,445.0512821,195,19.15107979,13.52892859,0.707781285,0.928571429,0.663265306,0.263976889
+1814,15569.91176,805.4159664,502.4159664,1022.57563,14205.39916,655.9537815,520.8529412,1416.096639,7573.512605,497.1344538,1043.382353,1784.710084,11437.37815,1177.39916,5629.596639,3959.953782,4074.798319,1206.302521,317.9621849,2590.252101,8026.327731,391.2521008,350.3613445,1230.310924,9201.315126,382.7689076,175.7352941,3443.033613,7328.058824,1680.554622,747.1596639,2781.798319,6422.621849,693.2647059,242.4705882,2134.731092,5074.663866,932.8613445,371.5336134,1293.361345,4150.172269,670.5546218,155.0420168,5001.369748,3471.302521,1207.718487,871.3655462,3199.865546,639.6008403,446.5084034,238,22.74895507,14.54873709,0.768762562,0.817869416,0.636363636,-0.405678521
+1815,34653.05747,833.2758621,505.9770115,1082.137931,29882.65517,685.183908,562.3563218,1602.390805,17490.44828,535.137931,501.2183908,1748.551724,23884.48276,1276.965517,5096.528736,3867.137931,8822.091954,1279.574713,360.8735632,2523.206897,17704.54023,493.2068966,696.3333333,537.2758621,20475.85057,543.137931,127.6666667,4152.862069,16429.1954,1488.770115,827.8735632,2800.298851,14350.93103,633.9885057,282.5977011,2082.954023,11331.55172,926.9655172,421.091954,1321.793103,8470.137931,803.0229885,169.1149425,3602.494253,7271.517241,1341.045977,626.3563218,3192.367816,723.8045977,440.816092,87,13.37661626,9.195528692,0.726247714,0.828571429,0.608391608,0.336338542
+1816,15471.58491,809.2641509,469.3679245,1033.858491,14685.54717,654.9716981,478.8490566,1420.650943,7512.867925,513.5471698,881.6037736,1766.943396,11696.92453,1240.575472,3444.981132,3104.273585,4188.235849,1259.764151,357.7358491,2817.150943,8201.95283,454.5660377,548.4150943,767.5943396,9639.188679,419.9433962,117.2075472,2020.915094,7712.754717,1676.358491,628.990566,2790.622642,6661.084906,617.1415094,253.8207547,2214.556604,5555.169811,1122.179245,397.9716981,1308.528302,4321.169811,750.6603774,165.9150943,3966.235849,3638.358491,1301.698113,1014.830189,3126.603774,771.0754717,440.8113208,106,16.78150764,8.755778902,0.853097439,0.841269841,0.56684492,-1.502467346
+1817,40874.35484,855.1048387,553.3306452,1128.08871,37627.82258,699.6612903,633.7580645,1769.129032,19819.79839,540.1532258,621.9354839,1806.83871,28062.51613,1271.75,7441.806452,5414.322581,10206.18548,1363.443548,368.75,2426.104839,20084.91935,418.6290323,139.4758065,632.5564516,24428.04032,425.0645161,139.733871,6394.991935,18330.1371,1490.629032,723.4677419,2856.774194,15823.70968,631.9193548,298.2016129,5610.564516,10810.37097,833.6370968,430.6532258,1314.072581,8726.83871,651.2983871,170.7903226,4287.596774,7110.693548,1305.153226,171.8467742,3236.604839,211.6532258,443.1370968,124,16.13725041,9.984335935,0.785616642,0.939393939,0.635897436,-0.510625955
+1818,39326.31746,1063.380952,570.1825397,1171.539683,31631.77778,815.547619,582.7857143,1758.412698,19441.69048,640.9444444,811,1794.634921,28530.79365,1544.52381,4312.730159,4405.873016,10607.01587,1573.642857,423.7857143,2468.015873,18436.64286,565.9047619,552.2777778,626.6746032,20306.61111,471.952381,152.3333333,3793.357143,16697.80952,1833.674603,825.1746032,2819.039683,14564.53175,679.4206349,322.2777778,1886.952381,11699.37302,1180.761905,498.3888889,1325.293651,8899.968254,797.1349206,196.0555556,4588.15873,7793.047619,1509,302.9285714,3389.47619,459.9444444,442.1904762,126,14.71753383,11.44909501,0.628360714,0.863013699,0.646153846,0.135787869
+1819,17809.58871,766.9032258,452.1451613,1036.104839,15041.33871,613.7822581,482.8951613,1376.298387,8542.975806,491.0241935,408.516129,1721.185484,12255.10484,1201.556452,2289.58871,1155.564516,4400.782258,1242.016129,334.2983871,2416.379032,8879.040323,406.5241935,262.7741935,437.3709677,10161.96774,389.5564516,118.3709677,1447.951613,7964.016129,1338.943548,665.3709677,2818.395161,7165.112903,816.7903226,250.5967742,1509.193548,5778.435484,768.9516129,412.9677419,1318.395161,4541.58871,658.6048387,160.2903226,2439.274194,4007.58871,1227.266129,833.1129032,3127.379032,528.9274194,443.1693548,124,14.9686452,10.97400268,0.680085658,0.939393939,0.645833333,-0.20419287
+1820,18208.29365,857.468254,476.1666667,1043.706349,15265.98413,631.6587302,379.8571429,1436.492063,8941.293651,510.047619,378.1349206,1734.650794,12399.18254,1233.579365,3284.603175,1636.047619,4436.333333,1168.642857,321.047619,2352.087302,8805.777778,400.6349206,112.9285714,445.3253968,10293.8254,382.1428571,112.9761905,1452.230159,8208.365079,1301.730159,597.5873016,2784.809524,7016.404762,750.5793651,231.6825397,1470.261905,5566.666667,741.8968254,374.968254,1288.960317,4353.18254,599.3095238,155.5238095,2287.68254,3790.880952,1251.111111,2387.912698,3158.619048,660.5,442,126,13.76905386,11.6918292,0.528170776,0.954545455,0.807692308,0.371895462
+1821,32843,836.25,482.6785714,1084.178571,27558.80357,684.625,526.5892857,1597.375,16699.19643,528.4464286,970.9285714,1787.196429,22871.89286,1253.482143,4156.053571,4537.125,7991.071429,1238.982143,353.4464286,2387.125,16241.5,475.9464286,555.5535714,780.2142857,18974.30357,419.1071429,127.6607143,3340.785714,15370.85714,1750.446429,622,2803.392857,13137.44643,616.1785714,288.6607143,2192.803571,10739.23214,1229.839286,418.0892857,1310.375,7708.714286,759.8928571,178.0357143,4377.053571,6633.5,1318.803571,501.1964286,3175.464286,783.4107143,440.6785714,56,10.90451515,6.960875964,0.769747861,0.888888889,0.565656566,-0.456753392
+1822,47004.45977,929.3448276,605.0804598,1158.781609,15611.62069,447.7241379,234.4252874,1191.689655,8322.850575,379.4597701,436.9770115,1679.241379,11845.44828,915.7241379,7056.471264,3460.965517,4539.678161,1010.298851,271,2324.206897,8625.942529,273.8735632,78.71264368,367.2758621,9950.137931,273,101.8735632,4851.827586,7984,1119.701149,701,2782.551724,6806.011494,459.5747126,201.1034483,1635.482759,4871.724138,603.7471264,330.9770115,1263.758621,3848.011494,514.8505747,138.2298851,1336.62069,3314.195402,963.5517241,87.56321839,3060.298851,239.1264368,442.2068966,87,11.42132541,9.803412657,0.513076606,0.966666667,0.659090909,-1.053317015
+1823,32571.41791,1011.298507,542.4079602,1089.99005,29061.89552,743.4228856,740.3034826,1551.333333,15808.79104,677.4378109,1112.094527,1816.467662,22820.00995,1383.970149,4047.089552,2987.507463,8266.338308,2184.562189,437.8706468,2528.791045,16869.54229,1324.338308,568.4975124,671.6616915,18118.61692,458.1492537,154.0099502,2499.870647,14398.63184,1914.283582,884.3631841,2832.78607,12725.20398,660.4975124,288.4577114,1797.273632,10135.57214,1452.402985,451.5721393,1344.925373,7810.19403,793.3830846,178.3781095,3708.865672,6886.378109,1398.746269,346.3283582,3395.437811,446.1940299,445.761194,201,20.53747672,13.43422237,0.756380342,0.901345291,0.67,-0.504455591
+1824,34021.01064,845.2340426,479.0425532,1102,27684.43617,667.7340426,562.2234043,1574.659574,16902.71277,526.9787234,503.5212766,1750.010638,23081.85106,1299.37234,3878.212766,2404.43617,8352.223404,1254.882979,359.7234043,2425.893617,16627.42553,506.8723404,905.2978723,529.5425532,19091.76596,478.9574468,126.7021277,2499.265957,15564.51064,1496.542553,672.1595745,2800.287234,13193.39362,720.787234,281.2765957,3014.159574,10760.44681,892.5319149,412.2446809,1310.191489,7657.606383,909.6276596,163.5851064,3434.87234,6474.691489,1343,865.8510638,3241.989362,800.6382979,440.8510638,94,13.53038611,9.390559767,0.719941386,0.912621359,0.657342657,-1.138519061
+1825,41884.2732,1006.56701,530.6237113,1112.046392,38096.51031,775.0618557,580.7371134,1697.206186,21551.57732,621.4948454,673.5979381,1837.479381,29838.79897,1381.381443,5518.876289,3989.938144,10280.21649,1416.479381,395.2783505,2395.159794,20471.36082,517.1649485,509.8453608,649.2268041,24273.87113,450.2268041,137.9742268,3927.690722,18950.54639,1710.829897,854.4123711,2818.541237,16548.56186,629.2783505,310.0618557,1691.701031,12762.18557,1086.108247,464.8505155,1330.092784,9868.164948,722.9639175,177.6134021,3584.365979,8514.572165,1418.804124,148.9123711,3391.876289,307.6701031,446.2783505,194,22.2560555,12.53105039,0.826429618,0.81512605,0.513227513,1.085366393
+1826,31823.24603,913.7698413,522.031746,1116.642857,20495.51587,624.1507937,414.5,1442.02381,8083.071429,473.5,481.9047619,1729.484127,11559.02381,1041.349206,2581.214286,2067.809524,4207.81746,1169.785714,294.8492063,2419.293651,8457.626984,353.1031746,533.3809524,555.6111111,9722.142857,313.0793651,109.6904762,2328.547619,7609.769841,1368.801587,741.8809524,2791.261905,6674.325397,668.1349206,222.5873016,1436.571429,5433.349206,768.1746032,363.7301587,1297.960317,4224.134921,662.2857143,148.2936508,2047.31746,3788.492063,1104.071429,187.5952381,3269.992063,488.3571429,444.8333333,126,15.60817436,10.41341994,0.744898935,0.954545455,0.7875,0.10168498
+1827,38565.85787,896.5558376,522.1319797,1098.13198,30870.52538,714.4822335,655.7614213,1609.746193,19439.47462,603.8350254,1411.385787,1834.444162,27271.40355,1405.637056,6081.038071,4265.035533,9519.835025,1417.959391,394.4187817,2620.464467,17723.8198,484.8832487,350.5913706,1056.916244,20451.23858,490.8857868,179.7461929,3822.611675,15735.81472,2111.502538,806.1167513,2829.664975,14004.90355,737.2969543,300.1269036,1715.200508,11201.13198,1382.218274,455.3730964,1324.30203,8716.228426,811.4822335,176.713198,3369.098985,7640.850254,1379.763959,267.893401,3315.020305,500.9416244,449.9847716,394,26.95464319,20.86670633,0.633012661,0.829473684,0.656666667,-0.568429207
+1828,18867.02817,973.5352113,478.8309859,1035.43662,16090.5493,709.7887324,454.6619718,1438.56338,9274.464789,547.6478873,623.0140845,1738.704225,12939.14085,1281.605634,2929.225352,1959.788732,4239.323944,1255.183099,337.6197183,2423.408451,9004.985915,410.4929577,134.6197183,634.3661972,10280.69014,376.056338,139.7605634,2926.84507,8252.309859,1398.901408,630.4788732,2791.338028,7055.549296,571.1549296,245.3380282,1698.915493,5602.521127,768.028169,371.3661972,1305.788732,4334.507042,614.3239437,156.028169,3671.591549,3792.507042,1243.577465,2435.197183,3241.619718,650.1408451,442.8732394,71,11.03281544,8.627565628,0.623289351,0.8875,0.645454545,0.244402222
+1829,35645.35754,892.4078212,634.5530726,1157.446927,30406.45251,738.7988827,706.2793296,1702.22905,17794.0838,557.9441341,462.3687151,1776.357542,24374.38547,1386.446927,4292.100559,2302.379888,8673.798883,1393.03352,369.7653631,2413.173184,17607.48603,508.2234637,641.150838,502.9888268,20689.77654,435.9553073,130.3240223,2710.49162,16038.7933,1546.72067,768.3854749,2819.01676,13975.22346,1114.067039,297.1731844,1888.195531,11229.85475,981.2960894,430.5083799,1317.396648,8494.463687,822.9832402,164.7039106,2797.893855,7317.24581,1422.351955,479.6703911,3238.385475,698.8044693,445.5418994,179,19.8843283,12.15617396,0.791364613,0.87745098,0.621527778,-0.444838763
+1830,27732.58559,770.8963964,481.9189189,1083.738739,23988.82883,632.7612613,804.8108108,1595.486486,12438,471.0900901,1302.495495,1753.783784,18293.80631,1166.373874,7160.31982,3265.292793,6446.630631,1160.256757,323.7207207,3348.671171,12905.06306,2106.342342,788.4324324,1004.963964,15125.93243,419.463964,580.463964,4964.022523,11812.06306,1633.932432,667.6846847,2812.04955,9971.171171,642.9099099,261.2072072,9234.369369,7949.108108,1208.274775,388.4189189,1312.621622,5530.207207,823.7072072,154.6486486,3361.864865,4677.702703,1141.288288,257.9774775,3217.954955,886.4279279,446.2792793,222,19.73222668,15.37202526,0.626984842,0.850574713,0.556390977,0.700149663
+1831,39816.12245,826.0204082,489.0816327,1130.306122,37029.69388,701.4285714,516.8979592,1749.040816,20160.65306,558.1020408,682.6122449,1850.918367,29147.06122,1282.734694,5732.877551,4655.55102,10640.40816,1444.204082,384.1428571,3725.632653,20650.5102,432.5918367,168.8367347,600.1020408,24669.65306,442.8163265,131.6326531,3229.653061,19112.2449,1654.571429,630.3265306,2884.693878,16271.22449,619.8367347,293.6122449,3869.816327,10739.06122,939.5714286,420.5306122,1317.653061,8599.142857,643.9183673,168.3061224,2430.102041,7183.959184,1322.55102,202.5306122,3305.306122,202.9795918,443.0204082,49,9.591319455,6.957113381,0.688374784,0.907407407,0.6125,-0.075034569
+1832,39487.1954,1039.850575,582.8275862,1113.022989,35874.05747,788.8735632,829.0344828,1642.689655,20202.91954,613.9885057,1421.333333,1810.413793,28383.67816,1402.287356,4705.54023,3579.137931,10311.64368,1408.781609,396.1034483,2491.114943,20155.34483,459.8505747,353.5517241,1183.057471,22842.25287,504.3678161,397.045977,4887.942529,17832.49425,1790.356322,750.8275862,2850.206897,15500.56322,680.3218391,308.6781609,1543.551724,12157.90805,979.4597701,456.4252874,1319.333333,9436.287356,697.4252874,177.3333333,3605.229885,8175.206897,1391.229885,247.6091954,3437.850575,388.5977011,442.2528736,87,13.93551022,8.107351861,0.813348724,0.966666667,0.725,1.380338419
+1833,20530.9661,881.2033898,445.9830508,1040.084746,12982.79661,553.6271186,355.440678,1171,7160.559322,514.8813559,417.4576271,1668.355932,10264.40678,1041.372881,1841.644068,1458.033898,3722.220339,1196.372881,326.3559322,2473.79661,7325.050847,382.9830508,758.779661,410.6271186,8747.474576,305.559322,102.0338983,1418.254237,6794.067797,1353.728814,704.2033898,2781.254237,5849.694915,583.2542373,214.0847458,1237.966102,4843.932203,699.6949153,360.8983051,1313.20339,3751.915254,753.2033898,144.6610169,2202.322034,3400.372881,1080.59322,116.3389831,3220.372881,479.5762712,443.559322,59,11.36295871,7.561379837,0.746450354,0.967213115,0.614583333,0.26032589
+1834,33180.38525,986.2704918,576.4590164,1133.57377,28414.02459,776.4508197,656.7295082,1710.92623,16233.03279,627.5819672,1131,1797.565574,22513.34426,1419.196721,4817,4128.647541,8067.622951,1424.721311,390.1885246,2508.04918,13985.54918,473.8032787,1226.868852,728.1229508,16624.30328,462.8032787,131.7377049,3874.795082,12869.90164,1807.040984,870.2868852,2822.565574,11375.51639,700.442623,293.0901639,1919.57377,8838.467213,1084.704918,453.4836066,1377.090164,6916.352459,954.9180328,178.352459,5129.97541,5842.92623,1383.680328,249.2295082,3263.606557,558.8114754,443.6393443,122,18.68698047,8.915783637,0.87884247,0.847222222,0.677777778,1.568508551
+1835,35632.72549,813.4509804,425.5882353,1065.27451,31148.7451,692.1764706,906.8039216,1506.490196,18825.2549,547.4509804,1250.352941,1768.843137,25436.07843,1308.098039,5323.431373,2681.862745,8838.196078,1291.333333,334.6666667,2999.333333,18336.23529,443,251.3333333,472.5490196,21016.19608,389.254902,125.2156863,2826.803922,17234.96078,1872.980392,648.3529412,2825.980392,15089.01961,644.7647059,259.9019608,1862.294118,11744.56863,1038.078431,394.5098039,1351.960784,9073.823529,684.9019608,162.0588235,3172.627451,7884.196078,1317.627451,610.2352941,3244.490196,629.0588235,443.1568627,51,8.581763352,7.937400011,0.380174429,0.927272727,0.708333333,-0.573997551
+1836,24131.80247,791.5555556,448.4444444,1061.111111,21363.34568,656.2222222,1216.728395,1496.123457,12011.67901,515.7160494,2268.320988,1738.777778,16948.5679,1224.580247,5077.222222,2995.37037,6086.37037,1205.728395,338.7530864,3295.518519,12456.19753,472.7037037,432.0123457,2608.45679,14555.65432,624.5555556,429.9506173,1871.333333,11242.8642,1901.62963,574.8888889,2788.209877,9858.395062,653.4320988,256.9135802,1676.135802,7940.716049,1809.814815,396.2716049,1303.283951,6063.271605,703.9012346,157.8888889,5509.62963,5194.185185,1261.061728,1415.876543,3159.518519,715.6666667,444.1728395,81,11.86904315,9.15603757,0.636324245,0.931034483,0.613636364,0.488479922
+1837,45515.41935,861.2741935,458.5483871,1104.967742,38959.90323,707.6935484,651.7419355,1649.387097,23231.85484,547.2096774,805.0322581,1745.177419,31714.83871,1336.774194,5102.758065,3332.677419,11121.19355,1309.370968,375.0967742,2624.241935,22626.30645,486.4677419,127.5967742,800.3225806,25960.93548,456.6774194,133.016129,2667.467742,21102.59677,1772.419355,604.1774194,2808,18360.75806,622.0483871,296.7096774,1954.935484,14631.59677,1016.870968,432.5322581,1312.258065,10499.93548,632.2419355,169,2345.532258,9084.580645,1392.596774,1312.548387,3306.451613,736.2096774,443.3387097,62,11.01253251,7.435178553,0.737674884,0.898550725,0.574074074,1.489901748
+1838,25431.83815,777.5606936,537.6705202,1113.306358,15481.96532,522.283237,564.4913295,1426.219653,7827.884393,407.6358382,1060.884393,1711.491329,12174.6763,1045.49711,7199.687861,2239.66474,4415.942197,1064.907514,297.7109827,4342.023121,8225.427746,490.5953757,126.3063584,634.3988439,9878.236994,348.1734104,106.0231214,3691.734104,8378.601156,1614.040462,563.3352601,2797.982659,6738.046243,676.1907514,237.2254335,10106.41618,5338.00578,974.9710983,353.6589595,1306.369942,3363.791908,564.8034682,155.6705202,3102.50289,3160.843931,1019.988439,249.1213873,3062.554913,985.0635838,446.2196532,173,15.72353645,14.08408678,0.444592863,0.945355191,0.720833333,-1.530220504
+1839,33786.74658,901.1849315,595.3493151,1173.828767,20072.94521,578.8287671,380.260274,1631.061644,10056.86301,479.2054795,640.9041096,1823.308219,13678.53425,1090.917808,6349.89726,3064.561644,5390.842466,1168.089041,341.9726027,2718.965753,10357.92466,2498.369863,1403.630137,431.6575342,12238.81507,391.260274,119.8630137,8316.417808,8953.356164,1496.773973,644.0547945,2792.835616,7484.917808,518.3424658,242.4041096,8197.739726,4697.575342,753.0547945,380.2876712,1304.924658,3876.219178,868.4246575,156.6438356,3530.410959,3209.479452,1123.390411,270.109589,3163.60274,166.9794521,448.609589,146,20.45400584,10.01966255,0.871799375,0.863905325,0.54887218,-0.315200144
+1840,50033.01389,897.7777778,555.4305556,1121.083333,35297.29167,651.6527778,510.375,1585.416667,19661.36111,513.2222222,485.9583333,1771.597222,26823.55556,1196.388889,6037.277778,3866.805556,9618.319444,1258.416667,354.1944444,2423.972222,19586.23611,389.4722222,127.1527778,438.2916667,23285.88889,366.7777778,124.3888889,4838.319444,18867.65278,1395.194444,659.0694444,2815.430556,16111.06944,576.8888889,287.1944444,2677.083333,11785.29167,792.3194444,426.6944444,1294.652778,8772.75,617.1944444,170.6666667,2679.388889,7828.861111,1252.5,158.8333333,3243.638889,252.5972222,443.9583333,72,12.41380337,7.582628254,0.791767697,0.947368421,0.6,-0.996884852
+1841,46550.00943,920.4433962,597.8018868,1142.216981,43144.26415,755.7358491,727.5,1768.830189,24074.46226,605.4339623,659.0849057,1788.54717,34015.36792,1377.5,7558.311321,6172.188679,12475.53774,1463.037736,407.0471698,2529.990566,24724.89623,479.5566038,737.0754717,548.490566,30467.51887,444.2924528,139.745283,5802.207547,22623.61321,1659.103774,1017.924528,2833.971698,20201.13208,669.1792453,325.2075472,2085.90566,15207.82075,966.3490566,479.3679245,1313.377358,11963.30189,811.8867925,189.9811321,3707.933962,10053.23585,1450.169811,153.5849057,3379.792453,278.7264151,445.5754717,106,14.59562052,9.993389118,0.728839969,0.868852459,0.627218935,-0.603454601
+1842,26160.64901,841.7615894,497.192053,1067.377483,23012.89404,694.1721854,519.4370861,1503.251656,12662.93377,549.1192053,554.7218543,1727.543046,17943.5894,1305.649007,5764.801325,3229.629139,6371.695364,1466.980132,368.5298013,2447.059603,12552.56291,447.0463576,1337.589404,582.0264901,14709.9404,558.4503311,130.3245033,2623.695364,11221.05298,1608.84106,797.8344371,2805.940397,9935.516556,691.3443709,282.8741722,1779.251656,7925.761589,942.0860927,438.0198675,1346.834437,6371.145695,952.8211921,177.0397351,5119.708609,5444.549669,1348.278146,698.9536424,3186.172185,518.1258278,449.0198675,151,16.31871625,12.3795974,0.651540985,0.915151515,0.634453782,-0.469359794
+1843,41005.73333,906.2166667,491.15,1105.733333,34809.66667,753.65,754.4,1620.683333,21451.85,555.4166667,810.1,1804.733333,29238,1378.65,4194.033333,3069.566667,10516.06667,1348.033333,365.9666667,2660.366667,21077.58333,473.55,1159.933333,655.0333333,24513.21667,440.7333333,126.2666667,2134.033333,19720.38333,1857.033333,662.8,2788.633333,17185.4,681.9833333,298.9166667,1764.283333,13535.88333,1000.783333,431.6666667,1364.166667,10409.71667,1022.966667,172.35,4032.416667,8897.133333,1413.933333,197.65,3215.283333,619.0333333,443.5833333,60,11.9955606,6.550646554,0.83772701,0.909090909,0.625,1.200216072
+1844,20730.52033,959.8861789,466.3658537,1032.341463,18271.15447,678.5934959,651.0081301,1448.95122,10335.5935,547.8943089,572.2276423,1726.479675,14349.41463,1253.235772,2618.455285,2777.00813,5140.146341,1204.674797,340.4065041,3342.878049,10176.99187,454.203252,134.6829268,779.4796748,12297.3252,393.5609756,114.4471545,1906.243902,9636.243902,1609.804878,587.9349593,2784.650407,8320.601626,653.8861789,242,1822.552846,6879.747967,929.7723577,400.8373984,1294.113821,5161.756098,599.398374,150.6341463,2649.105691,4402.081301,1263.577236,3032.495935,3360.333333,756.3577236,445.8943089,123,14.0365646,11.51460222,0.571891764,0.897810219,0.727810651,1.134744664
+1845,32140.55319,826.8404255,450.393617,1059.212766,27631.87234,693.8297872,544.3829787,1516.446809,16089.1383,518.287234,535.2021277,1724.308511,22996.96809,1250.957447,4192.553191,2565.159574,7926.680851,1250.734043,361.9468085,2424.106383,15975.82979,460.7553191,1030,532.3829787,18356.44681,391.9574468,129.4042553,2036.904255,15015.32979,1584.946809,564.1276596,2783.478723,12754.84043,639.3723404,270.0531915,1907.37234,10513.47872,945.8191489,414.5425532,1318,7527.531915,906.6595745,161.4255319,3134.446809,6422.095745,1314.308511,683.4255319,3157.085106,790.4893617,445.5,94,12.05798372,10.55719099,0.483154065,0.912621359,0.657342657,1.181624557
+1846,27005.52549,755.6470588,460.8901961,1081.223529,23642.99608,604.1372549,489.3568627,1628.011765,12793.88235,473.3647059,671.5176471,1791.988235,18222.7451,1169.505882,5143.235294,3085.54902,6415.223529,1153.411765,330.4313725,3717.164706,12407.70196,3445.788235,658.2156863,637.5294118,14685.42745,430.572549,117.3843137,5491.090196,11394.65098,1568.74902,704.6627451,2854.392157,9147.2,562.1294118,246.2588235,4562.494118,7507.898039,976.1176471,377.6078431,1296.866667,5099.67451,747.4117647,150.3607843,2920.694118,4207.960784,1119.996078,169.6117647,3226.435294,867.4745098,450.0705882,255,22.30563752,14.71453143,0.751548631,0.944444444,0.674603175,-0.497178582
+1847,14863.04225,781.4788732,568.6338028,1096.239437,13430.33803,631.1690141,463.1690141,1707.521127,6502,467.6901408,488.943662,1781.84507,10446.8169,1179.661972,9733.830986,4145.408451,3629.464789,1215.549296,342.1971831,2537.070423,6807.549296,616.7887324,1615.690141,491.6760563,8102,421.1690141,124.0704225,11021.87324,6370.816901,1429.225352,1085.619718,2816.140845,5202.591549,551.4647887,281.1830986,29834.85915,4188.647887,937.028169,385.8169014,1356.338028,2954.028169,1140.774648,152.9577465,7535.957746,2501.690141,1164.915493,238.9577465,3334.43662,902.6338028,444.8732394,71,10.32570289,8.997165828,0.490685262,1,0.591666667,1.326806782
+1848,31309.62252,866.4039735,664.0662252,1167.97351,16819.31126,541.4370861,337.5430464,1598.033113,8118.18543,453.1655629,540.2384106,1774.072848,11339.31788,1008.423841,5902.072848,2862.609272,4294.490066,1060.97351,309.4304636,2950.635762,8425.238411,757.3509934,167.2317881,417.2251656,9967.139073,351.2715232,109.5364238,10876.49669,7211.966887,1334.298013,625.602649,2811.900662,6006.264901,518.8410596,234.5629139,6757.668874,3459.940397,705.794702,358.2317881,1286.794702,2780.516556,564.2119205,146.4834437,2822.622517,2474.450331,1012.18543,154.602649,3058.456954,147.0331126,448.1655629,151,14.33325612,13.45617093,0.344441781,0.974193548,0.719047619,0.000748546
+1849,53450.80829,950.5803109,585.2642487,1185.61658,42842.23834,745.7564767,611.2124352,1893.145078,22135.33679,565.9119171,633.1398964,1775.663212,30414.90674,1317.663212,9241,6291.839378,11850.03627,1417.870466,398.4145078,2441.440415,22634.38342,470.2020725,253.5803109,540.4248705,27566.92228,433.2227979,137.4093264,10214.51295,20591.78238,1552.056995,689.8031088,2817.507772,17023.78238,609.4974093,315.6528497,5533.435233,10700.6114,830.9378238,442.9170984,1306.740933,8887.393782,675.5388601,176.1554404,3482.393782,7265.580311,1325.53886,195.9585492,3334.38342,177.9948187,448.388601,193,21.64349116,12.14859187,0.827609273,0.893518519,0.534626039,-0.709026984
+1850,49377.12308,933.4615385,663.2153846,1162,44892.41538,743.0923077,648.4769231,1754.661538,22254.93846,581.0923077,544.7384615,1790.323077,31572.89231,1333.676923,9235.092308,7583.030769,11350.8,1387.723077,386.8,2407.646154,23039.03077,447.4153846,158.0615385,446.6153846,28302.36923,435.7384615,138.0769231,8612.230769,21248.07692,1513.646154,1194.307692,2813.184615,18709.09231,649.4,326.7846154,2921.692308,13971.32308,890.8307692,457.7846154,1315.107692,11085.4,664.8,187.9538462,4084.169231,9317.030769,1412.384615,231.5538462,3353.015385,269.5076923,446.4615385,65,11.46548648,7.464449374,0.759046486,0.866666667,0.601851852,0.348553485
+1851,38120.6125,1027.6125,573.05,1128.1,33955.425,782.1,762.1,1669.05,19657.9125,620.525,1475.2375,1837.7125,27299.55,1414.05,5129.1375,4130.2625,9957.95,1431.6,396.2,2605.2375,20708.975,471.1375,493.475,1306.725,23379.875,481.0875,145.5875,3916.4125,18465.625,2197.85,764.75,2824.2125,15963.0875,671.0375,314.025,1707.025,12563.3625,1149.8375,470,1338.225,9890.7,767.8,185.6625,3820.8375,8730.8625,1436.9625,161.2625,3402.8125,378.05,445.45,80,12.32507817,8.832465567,0.697458144,0.930232558,0.683760684,-1.391601058
+1852,21519.22047,950.1889764,576.7874016,1075.07874,19270.24409,640.0393701,491.2125984,1508.244094,10907.48031,501.2677165,490.3385827,1765.787402,15186.4252,1206.141732,5969.23622,3331.708661,5802.015748,1320.165354,345.5590551,2454.047244,12265.71654,440.5433071,2123.031496,461.3070866,14554.04724,430.8188976,129.0551181,3889.007874,10850.71654,1688.559055,798.7244094,2801.228346,9750.149606,776.1889764,278.0944882,1660.023622,7913.685039,853.3228346,440.3070866,1406.244094,6298.433071,1188.283465,175.2913386,5579.645669,5411.700787,1314.283465,163.3622047,3235.582677,404.0944882,446.8267717,127,13.08485629,12.38769136,0.322058674,0.954887218,0.75147929,-0.536433649
+1853,33762.03371,878.258427,553.0224719,1096.044944,30944.10112,731.4044944,629.1685393,1575.483146,16707.83146,608.0674157,596.258427,1784.438202,24296.8764,1340.438202,4770.52809,4977.674157,9037.730337,1786.741573,407.3820225,2493.876404,18240.32584,493.1573034,815.4606742,538.5280899,20109.68539,473.3932584,137.1235955,4180.707865,15614.98876,1644.483146,989.6179775,2839.05618,13877.8764,651.9775281,304.4606742,2697.808989,11383.93258,950.3595506,481.8539326,1348.865169,8586.94382,884.7078652,182.4269663,6875.348315,7583.617978,1449.41573,235.1348315,3277.696629,434.7303371,447.1011236,89,11.35841843,10.62521439,0.353463271,0.87254902,0.622377622,-0.458283869
+1854,24262.9505,776.0792079,511.009901,1065.386139,20956.58416,641.0792079,434.2970297,1511.465347,11694.42574,501.6138614,538.6237624,1788.584158,16631.80198,1240.673267,2449.831683,2225.386139,6148.277228,1512.524752,346.7425743,2536.366337,12079.65347,430.4158416,623.9306931,604.2475248,14135.53465,395.7029703,124.4059406,2073.009901,10643.30693,1562.435644,764.3861386,2887.910891,9439.574257,761.8910891,269.950495,1658.227723,7483.089109,863.7128713,447.7821782,1403.673267,5954.871287,755.3465347,167.3168317,6690.079208,5123.673267,1283.693069,375.6435644,3146.435644,536.9405941,446.8019802,101,19.079596,7.506961372,0.9193439,0.855932203,0.420833333,-0.746641565
+1855,45091.71053,929.3421053,566.8684211,1148.657895,41223.76316,751.4210526,555.6315789,1745.263158,23487.10526,605.2894737,520.1315789,1829.657895,32362.28947,1366,8611.368421,5223.552632,12183.39474,1462.894737,405.2368421,2410.815789,23767.23684,478.7368421,270.2631579,492,29192.34211,450.6578947,145.9736842,4521.894737,21799.97368,1535.842105,1127.131579,2838.763158,19477.57895,647.1842105,328.1842105,2091.631579,14826.78947,924.7105263,480.2368421,1291.921053,11343.39474,700.3157895,194.0526316,3004.236842,9923.578947,1452.789474,122.2368421,3455.078947,287.0263158,446.1052632,38,8.376197279,6.288536422,0.660572009,0.926829268,0.678571429,-0.400504949
+1856,18583.94074,840.8222222,488.1481481,1038.740741,17549.85926,655.037037,551.637037,1427.022222,9717.377778,520.0666667,537.5925926,1759.051852,13530.44444,1196.874074,3075.081481,2353.081481,4927.711111,1587.748148,342.7185185,2481.192593,9986.866667,469.6888889,1628.622222,496.8592593,11323.03704,450.0962963,122.1925926,3318.074074,9003.185185,1589.866667,729.162963,2910.177778,7784.511111,902.7851852,263.4962963,1464.792593,6221.97037,804.3703704,419.4,1396.651852,4806.807407,1014.103704,166.8222222,5724.918519,4298.57037,1249.311111,161.7555556,3382.948148,364.4740741,449.8962963,135,14.18737564,12.49779204,0.473285003,0.957446809,0.649038462,0.48843739
+1857,27411.63107,824.5631068,433.2330097,1048.786408,24699.96117,698.9708738,456.8058252,1463.834951,13559.30097,535.9320388,398.038835,1714.757282,19918.32039,1362.398058,2089.524272,1724.902913,6706.669903,1414,367.0679612,2398.281553,13598.33981,450.2815534,421.4757282,442.7281553,15767.91262,383.0582524,125.4854369,1637.203883,12553.06796,1459.728155,784.631068,2817.747573,11602.82524,627.8737864,294.1165049,1553.407767,9025.650485,847.2330097,444.038835,1313.796117,7351.961165,715.3786408,175.9708738,2515.932039,6308.708738,1427.805825,1965.854369,3124.466019,576.1747573,447.2621359,103,12.76645016,11.08889739,0.495519574,0.895652174,0.525510204,-0.596418643
+1858,33484.36522,830.3478261,451.8521739,1089.147826,28213.85217,712.7304348,563.9652174,1529.356522,16869.11304,529.9652174,493.1565217,1735.304348,23654.13043,1342.208696,4323.669565,2901.382609,8275.643478,1290.365217,354.4782609,2401.756522,16232.18261,447.7478261,540.7130435,566.8521739,19079,399.3217391,122.5826087,2830.321739,15154.93913,1527.93913,807.773913,2787.304348,13235.13913,627.4869565,279.6347826,2039.930435,10395.83478,866.5826087,416.1304348,1324.843478,8245.408696,775.3130435,166.0608696,3176.695652,7127.252174,1360.930435,348.7826087,3185.565217,607.4086957,446.9478261,115,13.88504178,10.86049797,0.623061928,0.927419355,0.804195804,-1.248661053
+1859,31076.11236,797.4157303,494.258427,1064.134831,26362.73034,672.6516854,753.6629213,1531.224719,15583.05618,517.7752809,1036.786517,1733.629213,21708.73034,1232.977528,5608.606742,3186.831461,7780.303371,1248.808989,343.494382,2624.224719,15542.42697,453.7977528,300.0449438,1155.775281,18373.24719,537.8539326,167.0898876,5318.696629,14492.24719,1626.292135,693.8988764,2796.123596,12633.77528,642.5730337,263.5730337,1952.325843,10067.48315,1318.426966,401.7191011,1284.41573,7603.146067,716.0561798,159.8202247,4929.157303,6678.247191,1312.393258,359.5280899,3155.955056,707.8651685,448.752809,89,12.45219891,9.616818825,0.635259392,0.917525773,0.622377622,-0.22905199
+1860,20063.29508,773.5409836,459.4262295,1044.655738,18009.22951,615.9180328,509.2131148,1487.377049,9529.508197,480.9836066,1044.081967,1809.803279,14328.96721,1189.868852,4033.983607,4752.295082,4933.786885,1181.540984,326.0819672,2663.262295,9914.196721,473.7377049,134.0327869,1179.163934,11539,534.9836066,114.7868852,2094.983607,9138.967213,1824.508197,639.0163934,2819.836066,8015.983607,583.3278689,246.6557377,2572.180328,6520.213115,1178.688525,391.6721311,1282.52459,4937.967213,606.2786885,157.3278689,3850.606557,4144.836066,1239.377049,806.4754098,3234.065574,745.5737705,447,61,9.953661455,7.953853141,0.601213849,0.910447761,0.616161616,0.389897277
+1861,20794.85567,712.9175258,424.8659794,1055.010309,18592.38144,588.5876289,836.628866,1524.309278,10271.46392,456.3298969,586.6907216,1743.453608,14602.24742,1192.010309,4764.474227,2534.226804,5404.268041,1148.71134,319.814433,3495.42268,10195.83505,4112.309278,571.6185567,687.2268041,12210.72165,430.257732,116.9072165,3781.484536,9504.515464,1587.154639,609.1649485,2780.536082,7890.247423,767.8350515,240.5257732,3707.494845,6552.742268,847.4948454,386.2268041,1314.670103,4578.164948,739.3505155,148.7525773,3215.680412,3905.731959,1129.268041,187.9072165,3256.886598,837.7319588,447.5051546,97,13.93144231,9.069150369,0.759091185,0.932692308,0.621794872,0.50794398
+1862,19890.00826,894.2066116,507.7933884,1042.471074,18559.38843,617.5619835,413.768595,1413.31405,9743.396694,482.0413223,512.2479339,1764.991736,13443.77686,1149.661157,7720.917355,3208.512397,5174.008264,1219.033058,345.7520661,2417.14876,9320.165289,378.6942149,1833.570248,454.4876033,11380.72727,424.6198347,121.9834711,4426.768595,8650.669421,1424.239669,732.785124,2800.190083,7556.123967,905.3471074,243.8677686,1282.264463,6057.991736,800.785124,395.1818182,1340.884298,4832.280992,1011.14876,162.7272727,4724.876033,4137.024793,1216.85124,494.9256198,3301.85124,349.8347107,449.7024793,121,14.81848763,10.61016155,0.698091669,0.937984496,0.733333333,0.128753339
+1863,33475,827.1896552,461.2586207,1092.413793,29543.83621,700.4051724,517.4051724,1562.301724,17199.24138,576.5344828,721.0258621,1763.241379,23316.43103,1283.732759,4426.793103,2620.344828,8432.939655,1306.706897,378.7758621,2422.5,16975.25,481,403.2931034,801.9137931,20501.25,713.8965517,152.7241379,3311.905172,15564.80172,1581.603448,695.6293103,2788.732759,13513.76724,670.7844828,268.75,1814.034483,10716.00862,907.7155172,407.0258621,1321.663793,8345.956897,741.2155172,166.5948276,4776.827586,7199.163793,1347.603448,495.7241379,3193.318966,672.8017241,449.4396552,116,15.95059024,9.630859926,0.797140903,0.913385827,0.591836735,-0.959469477
+1864,39201.30081,834.9756098,497.195122,1100.138211,33469.07317,678.3658537,621.4634146,1585.780488,20202.02439,544.9512195,766.6260163,1776.455285,27874.30894,1260.186992,4237.138211,3731.276423,9744.634146,1297.560976,364.300813,2745.739837,19782.88618,470.601626,510.8455285,576.3495935,23525.6748,413.8861789,122.7886179,2690.585366,18969.79675,1728.113821,786.3089431,2828.105691,16377.66667,603.195122,278.6829268,2121.333333,13385.17073,1094.707317,428.8211382,1304.845528,9635.325203,757.804878,166.5447154,3085.569106,8387.95935,1341.861789,365.7154472,3262.569106,766.1056911,452.4552846,123,18.59108109,10.04129719,0.841592071,0.809210526,0.473076923,-0.381230372
+1865,28045.86432,811.6331658,505.5879397,1078.025126,24118.92462,654.4874372,474.6030151,1542.527638,13846.15075,507.7085427,429.2462312,1734.728643,19308.67839,1237.723618,3801.61809,3117.638191,6849.964824,1210.477387,352.321608,2398.919598,13555.24121,468.7236181,1068.542714,482.1055276,16081.77387,410.8190955,125.3517588,3011.256281,12518.15578,1461.040201,637.0954774,2834.628141,10558.79397,709.3467337,263.7889447,3357.648241,8579.120603,813.718593,406.4472362,1326.819095,6274.939698,934.0452261,159.8643216,3032.085427,5293.457286,1262.904523,948.4522613,3226.261307,808.4974874,450.3417085,199,17.72222875,15.5001702,0.484813725,0.880530973,0.581871345,-0.702785135
+1866,19675.5,726.5635593,502.4745763,1058.868644,17599.01695,597.6440678,538.3855932,1549.173729,9398.737288,459.1864407,831.9364407,1752.877119,14110.57203,1107.161017,5281.254237,3057.461864,5055.966102,1141.576271,330.7711864,3399.419492,9632.25,5970.622881,759.1144068,747.0805085,11564.5339,421.2118644,115.4576271,5314.622881,8982.728814,1592.199153,626.4364407,2784.512712,7359.576271,689.7542373,249.8305085,8910.966102,6216.90678,979.4915254,376.7584746,1307.266949,4340.868644,791.5127119,148.1355932,3228.334746,3714.588983,1130.826271,241.7923729,3227.385593,851.6737288,454.0338983,236,26.4475166,11.83045968,0.894374803,0.861313869,0.570048309,0.494301945
+1867,18235.50685,926.3561644,896.7899543,1165.100457,15252.46119,722.4611872,660.8493151,1790.657534,7676.077626,524.1689498,479.7762557,1795.990868,11826.86758,1347.771689,4598.589041,2369.821918,4104.926941,1325.077626,373.7853881,2566.520548,8193.630137,526.7214612,2233.045662,505.3835616,9488.178082,440.4794521,130.8812785,4630.799087,7821.543379,1581.977169,606.8675799,2841.703196,6570.995434,607.0730594,285.5890411,11140.57534,5473.995434,994.4885845,425.4840183,1362.739726,3803.420091,1179.283105,173.2328767,5939.493151,3309.958904,1349.182648,191.0365297,3206.210046,921.9817352,451.8949772,219,19.71491082,14.48156827,0.678555634,0.952173913,0.684375,-0.305393067
+1868,21781.46479,759.2676056,630.8309859,1129.295775,13784.30986,523.6197183,598.943662,1610.070423,6889.380282,408.8732394,407.3098592,1766.535211,10393.46479,1025.098592,5350.112676,1939.732394,3882.478873,1048.056338,305.0704225,2510.746479,6940.28169,3731.492958,239.6619718,426.3943662,8302.338028,413.028169,107.3802817,7910.690141,6904.605634,1292.098592,729.4507042,2809.929577,5569.873239,711.1267606,233.8873239,13051.42254,4366.859155,666,362.5492958,1278.901408,2543.422535,621.2394366,146.5774648,4179.084507,2593.394366,1089.098592,174.2676056,3211.661972,1007.507042,446.8028169,71,13.02310392,7.079117184,0.839356451,0.922077922,0.739583333,1.42719497
+1869,42104.07865,877.8314607,587.3483146,1141.651685,41387.40449,717.4157303,598.7752809,1847.651685,20867.30337,568.2696629,623.2022472,1827.775281,29273.24719,1311.314607,10140.53933,5798.730337,11284.70787,1433.370787,395.6292135,2810.168539,21686.92135,444.2359551,153.8426966,494.6741573,26480.82022,439.1348315,133.247191,6960,19328.33708,1650.573034,639.8426966,2859.157303,16333.17978,637.6629213,325.0337079,7463.303371,10728.94382,875.3033708,443.6966292,1346.033708,8927.269663,655.6629213,174.7865169,3212.651685,7041.168539,1325.134831,237.7303371,3286.797753,195.5842697,449.1573034,89,12.52790441,10.44097647,0.552643687,0.847619048,0.529761905,1.403337923
+1870,27043.77483,997.205298,505.4039735,1085.304636,23925.07285,746.0066225,1163.370861,1529.198675,13530.49669,637.7549669,978.807947,1778.84106,19242.71523,1385.317881,4096.490066,1973.622517,6621.238411,1385.86755,394.0463576,2786.384106,9573.907285,5436.807947,665.4966887,612.1589404,11340.35762,469.7880795,230.5165563,1354.423841,9020.662252,1947.953642,703.1721854,2809.761589,7843.794702,722.5629139,256.5298013,1270.377483,6450.562914,919.9602649,410.794702,1341.569536,5043.695364,769.4966887,162.4834437,2510.476821,4464.688742,1259.97351,179.013245,3331.880795,475.1721854,452.0596026,151,16.82533593,11.59267489,0.724760299,0.974193548,0.592156863,0.691884969
+1871,43129.40602,888.443609,548.4586466,1107.827068,32587.38346,677.4661654,627.5789474,1625.045113,17617.02256,522.7368421,488.406015,1793.030075,24531.07519,1236.902256,11150.74436,3550.082707,9094.353383,1307.646617,372.2105263,2397.578947,18261.54887,410.1052632,126.3007519,438.962406,21552.45865,413.481203,129.3909774,5030.308271,16819.26316,1422.646617,725.6165414,2812.255639,14670.75188,580.9323308,292.8796992,2029.714286,10882.95489,809.5789474,448.5263158,1300.451128,8456.804511,648.6691729,168.2105263,3415.120301,7287.894737,1320.827068,213.9398496,3242.654135,259.4887218,451.4285714,133,14.62241586,12.00735086,0.570697269,0.917241379,0.633333333,-1.165237636
+1872,38228.47826,1001.536232,618.8405797,1126.028986,36133.73913,764.7246377,577.9855072,1695.144928,19557.89855,601.884058,541.0869565,1832.478261,27164.02899,1358.826087,9711.318841,6106.014493,9445.710145,1414.130435,385.6956522,2394.434783,19203.6087,450.7101449,162.9275362,501.7971014,23259.4058,442.2318841,132.2898551,6567.086957,17315.18841,1558.26087,999.4927536,2822.927536,15316.31884,598.7246377,295.7826087,2144.42029,11663.88406,929.9275362,447.5797101,1301,9370.710145,668.173913,178.9130435,4763.927536,7670.942029,1394.681159,120.0289855,3395.15942,294.5652174,450.6666667,69,12.03888731,7.693528204,0.769159862,0.8625,0.663461538,-0.067816813
+1873,29576.35238,1023.295238,505.1428571,1074.495238,26716.60952,736.4285714,676.1142857,1512.342857,15109.2381,605.0380952,1550.580952,1757.247619,19991.90476,1310.761905,4943.095238,3285.104762,7389.52381,1312.552381,356.2761905,2721.72381,15021.20952,541.3428571,274.5333333,419.7809524,17832.13333,435.7904762,126.5714286,2859.228571,13894.58095,1441.514286,703.0857143,2800.32381,12160.38095,637.6952381,288.952381,1433.47619,9654.314286,1054.380952,437.3619048,1324.495238,7524.438095,649.4761905,168.0571429,3370.866667,6487.12381,1317.142857,219.2952381,3442.514286,339.6380952,452.0380952,105,14.15994112,9.706458776,0.728084652,0.92920354,0.681818182,-0.363032029
+1874,31398.61745,796.5637584,469.5704698,1075.221477,26824.55705,635.3422819,630.2751678,1529.275168,15669.11409,503.3154362,1006.456376,1777.563758,22085.52349,1211.114094,4884.657718,4200.395973,7886.838926,1232.187919,343.9932886,2577.583893,16001.20805,2224.174497,344.8187919,700.261745,18501.83221,1480.208054,120.7785235,3088.221477,14881.42282,1515.697987,662.3221477,2778.060403,12771.49664,623.1409396,263.6845638,2045.677852,10257.07383,1227.221477,398.9328859,1304.161074,7606.47651,693.5838926,157.0738255,4574.020134,6625.469799,1278.416107,334.4228188,3135.214765,726.6040268,451.8791946,149,16.66142077,12.28863474,0.675292274,0.903030303,0.591269841,-1.332770358
+1875,19069,770.4845361,457.3092784,1055.020619,17101.31959,634.5979381,588.628866,1486.680412,9741.453608,489.2268041,930.814433,1717.371134,14557.06186,1221.989691,4969.402062,4210.773196,5211.793814,1191.783505,338.7835052,2776.381443,10035.20619,433.0927835,344.4948454,867.0824742,11867.85567,404.5670103,114.9175258,2689.123711,9465.587629,1723.268041,662.8247423,2802.43299,8144.185567,613,250.3298969,2243.71134,6750.443299,1021.412371,389.5463918,1310.309278,5109.402062,669.1340206,161.5257732,4486.298969,4368.989691,1265.907216,1082.57732,3138.85567,778.2061856,449.6597938,97,13.2085808,10.62147742,0.5944472,0.843478261,0.587878788,1.407923607
+1876,25693.95349,801.372093,474.5,1087.790698,22600.16279,652.3488372,772.0465116,1604.465116,12884.98837,501.5581395,575.3023256,1752.790698,17924.63953,1272.988372,6424.093023,2976.639535,6554.244186,1204.453488,349.1860465,2599.081395,12849.67442,2519.116279,386.1162791,561.4418605,15217.54651,467.3953488,125.5697674,3159.581395,11796.80233,1509.872093,619.4651163,2790.837209,9888.127907,724.5116279,261.1046512,6385.755814,8068.883721,1144.895349,407.5581395,1309.77907,5718.55814,703.5581395,158.872093,4970.976744,4951.790698,1218.406977,284.7790698,3217.5,827.1162791,449.4302326,86,11.52439727,9.664661523,0.544707345,0.966292135,0.651515152,-0.933329803
+1877,58121.375,931.8392857,607,1167.375,53738.875,785.75,468.8571429,1918.839286,29273.14286,610.9464286,521.9464286,1818.714286,41202.78571,1408.071429,9994.464286,5670.857143,15613.80357,1536.321429,416.25,2435.642857,29394.05357,462.9821429,158.5,435.5892857,36057.58929,452.2857143,139.4464286,8261.053571,27800.73214,1574.196429,844.4642857,2816.142857,22797.375,630.1964286,331.7857143,4398.714286,14389.625,893.0178571,469.9107143,1327.767857,11576.14286,671.5,186.8392857,2562.839286,9930.732143,1393.053571,191.4821429,3373.857143,186.5178571,451.9821429,56,10.79485719,7.032841113,0.758649298,0.918032787,0.518518519,-0.395657627
+1878,33637.5443,871.164557,526.6582278,1070.164557,29633,714.6455696,781.0126582,1544.405063,17035.59494,571.1392405,879.2531646,1764.531646,23731.10127,1353.734177,3502.177215,2691.481013,8502.063291,1599.506329,377.7848101,2763.392405,16545.32911,470.0253165,465.9240506,1073.151899,20181.06329,436.5189873,148.1772152,2267.113924,15438.56962,1853.35443,755.6455696,2834.696203,13564.5443,675.8227848,291.9367089,1648.417722,10702.59494,998.0379747,473.2911392,1368.088608,8392.126582,752.556962,180.4177215,4326.78481,7328.860759,1347.607595,173.8860759,3292.670886,543.0886076,451.164557,79,13.62362004,7.753487814,0.822253808,0.929411765,0.598484848,-0.973401644
+1879,29262.2782,851.0977444,452.2481203,1061.473684,25043.80451,707.8345865,644.1278195,1500.93985,14455.69925,542.8120301,981.2631579,1792.330827,20122.10526,1349.195489,4812.135338,3469.969925,7285.781955,1295.203008,356.075188,2678.180451,13399.20301,444.0601504,689.4210526,674.3383459,15606.92481,392.481203,121.8120301,2303.62406,12170.75188,1758.518797,828.518797,2811.338346,10720.3609,610.5714286,282.9849624,1851.631579,8615.360902,1360.932331,429.5488722,1352.323308,6763.015038,792.7894737,166.3533835,3631.368421,5944.699248,1374.917293,673.0676692,3160.909774,585.5639098,454.8270677,133,16.9502545,10.89915813,0.76585902,0.886666667,0.488970588,0.951817038
+1880,27795,807.8208955,509.3283582,1078.731343,24794.53731,651.2985075,596.5373134,1542.701493,14169.41791,521.0298507,733.5970149,1727.283582,21131.74627,1278.223881,8198.701493,4935.373134,7136.298507,1251.014925,343.2985075,2692.850746,14459.38806,432.9552239,270.880597,598.3283582,17022.47761,772.3880597,120.7462687,5216.761194,13205.20896,1528.641791,802.3731343,2810.059701,11473.23881,688.238806,258.4626866,2307.41791,9160.597015,1062.970149,399.9850746,1299.537313,7345.477612,681.4477612,159.7910448,5030,6296.38806,1318.059701,1021.597015,3187.029851,627.6119403,452.7164179,67,13.57012135,7.352965947,0.840475414,0.817073171,0.598214286,0.052650729
+1881,44421.13208,1010.037736,516.0377358,1078.509434,40732.62264,750.1320755,1147.509434,1574.339623,22603.84906,612.4716981,1987.584906,1806.943396,31862.92453,1379.90566,5191.377358,3509.735849,11480.41509,1524.132075,387.0377358,2587.245283,22105.32075,445.509434,246.8301887,775.3962264,25641.58491,454.6792453,145.1886792,2641.811321,20208.5283,2100.754717,716.490566,2816,17669.83019,638.7735849,291.4528302,1398.283019,14007.77358,1407.245283,456.5849057,1308.358491,10718.16981,675.6792453,179.2830189,3167.113208,9463.415094,1400.886792,245.5660377,3281.566038,386.3584906,451.1132075,53,11.74685846,6.738723219,0.81909231,0.85483871,0.481818182,-0.668355565
+1882,46040.05128,988.5042735,557.1709402,1140.119658,39831.00855,804.8632479,814.3675214,1699.717949,23291.44444,627.1794872,760.1709402,1791.247863,32168.17094,1501.65812,4754.299145,4130.119658,11373.2735,1482.709402,415.5555556,2524.094017,23127.35897,544.0854701,356.6153846,702.8376068,27161.5812,470.7777778,149.3675214,2878.794872,21134.35043,1841.905983,978.8034188,2848.974359,18595.81197,680.6752137,344.6581197,1996.555556,14713.88034,1073,506.3076923,1354.34188,11389.41026,749.0769231,193.5811966,4059.179487,9899.837607,1527.555556,189.5641026,3336.068376,557.3931624,451.8547009,117,18.38482848,9.942091588,0.841166026,0.764705882,0.541666667,-1.482092231
+1883,13621.31707,799,479.3902439,1077.170732,15397.90244,717.8292683,642.5609756,1500.414634,6818.487805,500.804878,812.2439024,1768.146341,12343.41463,1248.585366,4176,3504.585366,4243.195122,1199.853659,360.0731707,2689.658537,7931.634146,410.7317073,2316.195122,779.3414634,9444.878049,820.5365854,117.097561,2904.585366,7016.658537,1770.634146,790.6341463,2792.731707,6408.682927,738.0487805,246.4634146,1964.634146,5221.756098,1001.853659,383.5121951,1432.390244,4548.170732,1319.853659,160.0243902,5808.634146,3944.487805,1297.02439,309.7073171,3133,615.1463415,451.5853659,41,10.77991958,5.047813871,0.883590298,0.854166667,0.585714286,-0.325884079
+1884,22764.04808,729.125,447.3846154,1078.221154,19829.39423,599.0480769,450.1153846,1635.038462,10194.90385,473.2788462,404.5096154,1757.067308,15030.98077,1107.182692,5152.778846,3630.913462,5316.596154,1133.644231,327.1538462,2491.855769,10313.20192,7411.692308,2835.182692,449.3557692,12215.93269,464.9807692,121.4423077,6534.596154,9584.884615,1355.644231,748.9038462,2785.961538,7948.028846,721.5384615,248.4134615,5317.192308,6487.028846,1342.192308,371.8365385,1339.971154,4360.673077,1533.971154,148.5576923,2836.423077,3654.201923,1145.778846,149.1730769,3267.009615,896.9903846,454.9134615,104,15.11709834,9.028060812,0.802085977,0.912280702,0.65,-0.156455682
+1885,47273.7963,924.287037,534.4444444,1134.074074,40435.75,792.0555556,771.9259259,1680.37037,23951.9537,628.3055556,1202.037037,1806.675926,33073.26852,1480.898148,3080.157407,3357.037037,11677.12963,1497.712963,395.3148148,2454.694444,23050,537,231.5648148,516.7222222,27408.89815,466.5648148,188.3981481,2381.101852,21540.88889,1807.37963,870.4074074,2837.425926,18921.24074,680.3425926,330.7037037,1771.546296,15174.43519,1104.416667,495.2592593,1333.12963,11749.7037,739.0740741,190.9907407,3965.666667,10294.84259,1506.675926,312.5648148,3238.5,568.3333333,455.25,108,14.4300181,10.71328977,0.669922771,0.87804878,0.519230769,-1.22735992
+1886,30069.70707,799.2828283,461.4141414,1063.282828,25635.67677,661.8787879,518.7272727,1532.030303,15138.51515,511.010101,908.6969697,1766.20202,20652.83838,1243.555556,4061.30303,4038.353535,7286.939394,1267.767677,348.3838384,2639.10101,15065.32323,431.5050505,147.2222222,536.969697,17510.11111,413.5656566,118.3333333,2750.585859,13979.41414,1660.151515,858.6161616,2789.828283,12212.63636,618.5454545,269.5757576,2071.626263,9629.181818,966.1818182,400.959596,1322.777778,7414.929293,640.8686869,158.2020202,3285.959596,6354.686869,1317.717172,1596.868687,3182.464646,651.1515152,452.8585859,99,16.46128754,7.960467238,0.875296214,0.876106195,0.5625,-1.18496441
+1887,40320.88889,943.1851852,511.5740741,1125.092593,32653.2963,702.2777778,484.8888889,1637.62963,20112.05556,537.6481481,561.9074074,1741.111111,27402.7037,1291.055556,5033.166667,3487.87037,9703.222222,1333.518519,376.2407407,2444.259259,19703.2963,478.3148148,144.0185185,547.7407407,22513.12963,462.6851852,122.2777778,2242.925926,18704.74074,1550.296296,678.8888889,2816.703704,16276.18519,620.7592593,289.9444444,2122.259259,12852.27778,959.4444444,429.962963,1278.962963,9289.685185,646.4444444,161.9814815,3427.814815,8149.833333,1349.444444,218.7222222,3226.555556,738.1851852,451.5740741,54,10.43118925,7.30538276,0.713809071,0.915254237,0.6,-0.962628964
+1888,20510.208,769.416,589.576,1108.88,16633.28,606.864,471.616,1752.176,8796.888,455.048,522.608,1807.792,12763.576,1133.536,6613.888,3444.84,4760.04,1167.544,327.624,2799.616,9165.808,592.248,798.84,484.232,10607.32,428.312,120.144,10288.312,8683.728,1456.176,1106.664,2825.44,7144.28,585.864,261.136,19128.344,5948.152,803.84,383.2,1317.144,3842.776,825.16,157.864,5880.784,3505.112,1172.592,189.552,3267.448,942.24,453.152,125,17.31506365,9.429385279,0.838710856,0.939849624,0.600961538,-0.990372585
+1889,23522.1105,768.3314917,602.2099448,1134.303867,20405.87845,624.7845304,756.5911602,1789.486188,10443.93923,464.2762431,1258.546961,1866.359116,15609.16022,1147.790055,7055.513812,3865.359116,5784.104972,1155.745856,326.6077348,3011.972376,11042.74586,3952.292818,174.558011,903.441989,13002.65746,435.2596685,423.5359116,8242.104972,10678.83425,1647.585635,806.4751381,2825.690608,8753.679558,602.2265193,272.3149171,21727.70718,7160.066298,937.6187845,394.7237569,1318.18232,4734.027624,661.6519337,153.1546961,4548.569061,4312.607735,1159.569061,259.7955801,3270.519337,956.7513812,455.8563536,181,20.05979727,12.11356442,0.797080757,0.905,0.635087719,-0.322108548
+1890,37695.58491,820.8584906,564.0471698,1121.745283,22403.33962,537.3679245,474.1603774,1453.433962,11529.25472,407.7264151,1040.584906,1691.95283,16541.68868,1020.735849,5512.113208,2553.264151,6151.556604,1077.377358,306.9433962,3667.90566,11615.73585,534.3962264,160.9056604,631.9811321,14245.53774,894.4433962,110.7169811,3190.990566,11540.12264,1441.301887,559.9339623,2837.660377,9268.216981,543.1603774,220.1981132,3436.537736,7380.367925,899.7641509,360.4339623,1307.679245,4415.273585,569.3490566,142.8018868,2143.481132,4182.433962,1032.915094,191.254717,3083.518868,995.8584906,453.8962264,106,12.91991945,10.92590647,0.533716179,0.938053097,0.582417582,-0.506050888
+1891,49056.5566,871.3584906,587.1603774,1142.90566,33620.79245,577.8962264,384.745283,1394.971698,17477.45283,471.8584906,540.9433962,1746.235849,24219.43396,1090.896226,5881.075472,2538.198113,9033.556604,1235.377358,336.5943396,2384.783019,17386.27358,344.509434,117.6320755,416.5188679,20764.30189,337.3018868,120.9528302,6570.235849,16380.33019,1299.518868,648.4433962,2821.216981,13814.42453,541.2924528,257.7264151,2538.820755,8928.924528,699.245283,386.7735849,1279.415094,7091.745283,575.3396226,154.1981132,2529.95283,6034.792453,1126.971698,118.8207547,3113.764151,204.4339623,455.6698113,106,12.74055847,10.9068025,0.51686086,0.954954955,0.582417582,0.44815847
+1892,50941.15541,912.3445946,572.4932432,1159.72973,24776.06081,547.9459459,292.9864865,1418.547297,13027.95946,440.2635135,551.4189189,1711.675676,18535.37162,1035.662162,7044.202703,3297.452703,6703.871622,1133.912162,313.0135135,2366.236486,13201.83108,605.75,113.5472973,426.472973,15800.70946,319.2905405,174.3040541,4502.783784,12305.55405,1272.581081,604.3648649,2794.108108,10394.16216,525.5675676,233,2268.351351,7158.837838,687.0945946,368.0675676,1276.560811,5689.459459,552.6216216,148.1689189,1954.75,4751.358108,1077.77027,113.1554054,3098.513514,218.2837838,454.972973,148,16.1337243,11.88333,0.676380712,0.925,0.711538462,-1.436776164
+1893,39835.22857,889,616.5428571,1123.4,38181.94286,731.0142857,645.5571429,1692.157143,21271.17143,576.8857143,503.1,1811.128571,29751.87143,1337.514286,9230.157143,6285.128571,10809.6,1410.4,389.0571429,2430.242857,21450.08571,456.2428571,169.7857143,451.5142857,26069.47143,451.7285714,140.9142857,6518.014286,19794.11429,1508.642857,1045.357143,2817.842857,17709.05714,627.1142857,320.3571429,2450.885714,13496.14286,886.3428571,465.1571429,1315.957143,10419.28571,677.4857143,185.8428571,5011.985714,8966.371429,1431.328571,170.1428571,3375.885714,286.2285714,453.7142857,70,11.25332414,8.951812147,0.605977759,0.886075949,0.636363636,1.042480299
+1894,26431.26829,871.9837398,537.5447154,1053.203252,24845.14634,691.195122,758.8861789,1516.731707,13357.6748,544.1869919,1211.300813,1791.260163,19076.54472,1259.869919,6704.560976,3961.845528,6891.536585,1319.601626,357.1138211,2502.829268,13768.17886,466.1788618,2195.609756,583.203252,16097.58537,603.5284553,127.9837398,3288.837398,12321.18699,1968.406504,821.3333333,2800.065041,10878.43902,775.4308943,283.9349593,1656.03252,8545,1303.195122,435.601626,1363.138211,6788.414634,1133.934959,171.1300813,4857.560976,5880.796748,1321.918699,196.5934959,3227.292683,394.0081301,455.601626,123,14.01660526,11.79855382,0.539859025,0.911111111,0.585714286,1.259348983
+1895,32642.58654,901.1634615,507.8269231,1102.701923,29625.64423,706.7115385,811.2692308,1579.298077,16491.17308,592.6538462,1072.788462,1832.961538,23443.36538,1344.971154,3951.240385,3470.557692,8371.778846,1460.163462,413.625,2449.048077,17663.89423,8314.807692,734.1923077,662.9615385,19238.93269,492.1153846,131.2980769,2356.009615,15393.00962,1694.394231,789.9326923,2817.884615,13536.48077,671.8557692,301.875,1697.25,10785.625,2171.769231,457.5769231,1323.307692,8270.346154,955.0480769,188.1826923,4344.221154,7385.971154,1415.682692,262.2115385,3371.038462,454.6346154,453.6923077,104,12.75061199,10.69515736,0.544446439,0.945454545,0.727272727,1.403922036
+1896,44940.65789,905.1842105,523.2894737,1128.552632,37949.68421,740.6315789,564.1052632,1667.157895,23500.86842,571.4210526,518.2631579,1773.447368,31763.26316,1407.631579,4181.657895,3552.315789,11251.31579,1377.763158,384.2631579,2481.578947,22972.34211,490.4473684,868.1052632,575.8947368,27128.89474,672.5526316,129.2894737,4697.921053,21560.39474,1561.526316,760.8684211,2798.131579,19075.39474,630.5,311.4473684,1734.842105,14903.89474,1020.684211,444.5,1337.236842,11737.92105,891.6842105,172.7894737,3510.447368,10040.68421,1448.421053,406.5,3207.842105,621.4736842,451.9736842,38,7.93278366,6.12126093,0.636058333,0.974358974,0.904761905,0.471655978
+1897,26087.12463,774.9940653,531,1095.186944,22393.87834,626.0801187,500.4005935,1729.578635,11450.45994,462.5637982,448.1958457,1797.418398,17291.65875,1151.522255,6869.029674,3176.560831,6219.329377,1166.462908,328.0623145,2571.442136,11764.98813,4989.403561,773.0356083,456.305638,13926.14837,451.2047478,119.6439169,7921.25816,11587.32641,1433.293769,793.7744807,2819.818991,9353.228487,850.3353116,256.5964392,11325.70623,7487.970326,787.9732938,388.5875371,1314.421365,4850.667656,788.9020772,150.462908,3842.465875,4364.347181,1155.032641,174.4332344,3237.88724,971.2967359,460.1008902,337,23.68732371,18.68934245,0.614390809,0.893899204,0.63705104,-0.513214642
+1898,36024.68085,1143.787234,597.0319149,1127.776596,32153.5,796.1276596,675.0212766,1638.446809,18378.48936,644.712766,795.2978723,1837.170213,24388.58511,1440.840426,6756.882979,4784.074468,8485.202128,1423.978723,388.6595745,2375.787234,17019.08511,453.212766,510.4893617,748.6489362,19504.37234,455.0744681,134.8829787,5609.085106,15058.34043,1747.319149,809.0212766,2825.574468,13082.80851,604.0957447,299,1607.010638,9903.585106,1048.659574,453.8723404,1303.989362,7713.446809,722.2340426,173.1489362,3065.87234,6499.170213,1342.585106,137.1276596,3458.882979,305.7234043,455.4787234,94,12.52114581,9.738616178,0.628544578,0.959183673,0.657342657,1.159105164
+1899,28757.55446,936.3366337,531.9009901,1083.584158,25973.52475,707.3564356,655.2475248,1527.237624,14966.9802,577.4356436,729.009901,1754.376238,20560.33663,1310.366337,3741.712871,3109.059406,7425.138614,1391.49505,359.6633663,2434.633663,15440.42574,420.6732673,440.2178218,506.2475248,18497.92079,418.1287129,131.2772277,3109.960396,14407.61386,1640.267327,734.2574257,2808.534653,12486.11881,657.5445545,291.0891089,1478.217822,10056.94059,933.9009901,458.6039604,1317.207921,7720.435644,717.0990099,175.8316832,3284.742574,6855.584158,1350.70297,134.6831683,3317.693069,377.0792079,455.2376238,101,12.02790867,10.91773222,0.419619807,0.935185185,0.701388889,-0.637316634
+1900,31501.42073,819.4329268,522.2804878,1086.560976,27638.71951,661.5243902,620.8963415,1591.865854,15447.21951,505.6158537,556.7134146,1753.060976,22568.59756,1232.79878,6348.579268,4295.95122,7912.72561,1240.213415,344.902439,2437.835366,15471.80488,474.4817073,688.554878,649.804878,18387.20732,413.4207317,123.5365854,4198.292683,14120.31707,1563.091463,797.7073171,2807.670732,11707.82927,589.0060976,266.2439024,5047.445122,9567.52439,857.695122,403.3353659,1329.652439,6929.02439,854.3902439,160.3719512,4413.621951,5816.536585,1240.390244,970.5182927,3245.829268,819.3780488,458.402439,164,15.72232126,13.74431428,0.485581933,0.931818182,0.643137255,0.628086139
+1901,19785.47287,748.0620155,566.0155039,1089.852713,17847.65116,610.2015504,756.124031,1799.403101,9167.302326,459.0697674,591.2868217,1820.79845,13902.44186,1136.953488,8647.356589,4243.565891,4853.899225,1138.767442,324.6976744,2695.914729,9604.503876,2901.868217,516.875969,491.7674419,11361.75969,461.4418605,122.8682171,13408.16279,9058.348837,1441.155039,855.9844961,2793.658915,7519.821705,586,271.4341085,23116.89922,6197.248062,912.1937984,395.1162791,1320.379845,4238.565891,780.9534884,161.124031,6215.860465,3691.697674,1148.271318,273.7364341,3274.968992,906.5968992,457.4496124,129,14.66045973,11.69162179,0.603327497,0.902097902,0.661538462,-0.088641762
+1902,22199.9845,852.751938,618.2015504,1153.077519,18673.5814,644.5116279,454.3875969,1804.728682,8692.449612,516.1627907,619.5116279,1871.713178,12229.51938,1155.689922,6770.573643,3433.372093,4709.356589,1224.217054,471.7054264,2615.906977,9115.55814,1566.387597,2246.596899,496.3023256,10827.3876,463.2790698,120.8294574,12651.0155,7696.705426,1535.224806,683.6821705,2823.186047,6285.186047,569.4186047,263.8217054,9650.302326,3776.418605,808.8449612,402.5891473,1325.44186,3070.170543,950.0232558,161.8992248,3972.829457,2701.379845,1152.232558,201,3227.868217,157.0155039,457.2093023,129,14.13443228,11.88353841,0.541421939,0.984732824,0.658163265,0.560395489
+1903,30726.91707,761.9463415,461.4878049,1053.907317,26530.82439,671.9414634,672.8634146,1502.097561,15473.73171,526.3365854,1286.634146,1744.878049,21548.55122,1214.863415,5947.897561,3757.585366,7631.902439,1244.980488,340.2390244,2688.258537,15490.88293,428.9853659,385.4292683,919.595122,18316.21951,941.5463415,169.8439024,3002.229268,14287.94146,1737.453659,668.4780488,2794.019512,12397.78537,762.1902439,260.204878,1944.082927,9859.092683,1039.214634,401.595122,1313.756098,7560.878049,713.8390244,156.6,4977.570732,6548.512195,1282.682927,499.6341463,3184.892683,662.6829268,460.6878049,205,19.62126404,13.58241072,0.72167778,0.949074074,0.650793651,0.209116406
+1904,37075.07,886.47,496.6,1095.35,30890.7,719.28,617.29,1634.21,18349.13,546.17,888.46,1727.85,25555.95,1319.31,4285.65,4021.84,8978.81,1319.47,407.26,2719.84,17900.2,489.59,120.6,651.93,20925.56,626.97,124.18,2273.54,16777.52,1765.54,638.25,2807.46,14549.49,663.71,288.28,2281.28,11690.7,1349.98,430.48,1301.7,8464.53,633.17,168.11,4601.21,7260.93,1369.49,481.66,3253.04,752.06,455.24,100,16.57081778,8.09622122,0.872517376,0.854700855,0.625,-1.433257163
+1905,33764.65116,869.9883721,488.3837209,1069.616279,28085.45349,715.2325581,501.127907,1611.686047,16394.7907,545.2790698,550.3372093,1763.581395,23119.97674,1307.895349,3770.372093,4118.465116,8124.5,1290.569767,367.4883721,2450.5,16160.19767,474.1744186,1514.837209,598.5348837,18612.81395,427.372093,128.7790698,2312.488372,15403.86047,1626.639535,794.4651163,2801.406977,13096.45349,598.2209302,272.755814,2131.569767,10533.69767,890.1162791,411.3023256,1341.930233,7667.383721,1023.186047,167.5116279,4086.267442,6640.744186,1324.94186,601.0116279,3239.639535,787.5116279,455.3953488,86,13.61230181,9.089602274,0.744386419,0.87755102,0.521212121,-1.041976243
+1906,27658.30682,820.5909091,524.5113636,1057.727273,23784.46591,675.7727273,628.1477273,1544.261364,13210.92045,495.8409091,758.7272727,1758.965909,19052.23864,1191.011364,6214.375,3673.227273,6645.352273,1201.715909,348.1704545,2433.204545,13178.20455,449.25,1996.886364,750.6477273,15429.28409,465.375,119.1590909,4156.170455,12543.31818,1871.204545,755.0113636,2805.897727,10609.88636,610.5113636,260.2272727,1949.522727,8817.875,925.9090909,404.2386364,1346.522727,6373.147727,1185.909091,158.9204545,3632.909091,5555.931818,1250.465909,1304.511364,3195.670455,797.0795455,456.6704545,88,11.86215012,9.610392425,0.586191002,0.967032967,0.727272727,-0.75341309
+1907,22879.66234,968.012987,616.8311688,1072.246753,19433.94805,642.3506494,816.6493506,1601.376623,11068.77922,502.8441558,992.987013,1788.662338,16317.54545,1230.532468,5220.064935,3178.142857,5734.948052,1183.038961,331.8701299,3603.181818,11151.42857,720.7272727,455.5584416,941.974026,12858.4026,497.1818182,119.7142857,4481.38961,10444.18182,1673.090909,666.038961,2778.194805,8594.805195,662.961039,261.2597403,8447.74026,7075.376623,1219.597403,391.2077922,1327.961039,4996.571429,734.4805195,155.4285714,4144.597403,4462.415584,1146.922078,386.8961039,3357.025974,832.3636364,456.8051948,77,11.11570727,8.924138184,0.596194089,1,0.7,-0.68474821
+1908,30609.75625,792.85,522.54375,1097.9125,23772.075,599.7,742.16875,1662.89375,11710.6375,454.125,1109.78125,1772.1125,17941.3875,1144.575,8592.55,3393.575,6451.0875,1149.175,332.20625,4149.0875,12102.9125,1553.99375,733.28125,691.70625,14827.2,424.275,116.56875,7090.28125,11987.20625,1814.8375,648.3625,2908.775,9479.24375,595.61875,245.18125,6840.83125,7503.6,919.9,381.85,1314.50625,4527.3875,753.90625,157.59375,3553.25,4259.95,1115.76875,284.43125,3162.9375,1003.8625,459.11875,160,22.77176968,9.550831407,0.907794417,0.893854749,0.526315789,-0.584426295
+1909,28094.84348,775.5304348,468.4173913,1042.930435,24361.2,633.1217391,459.5826087,1481.208696,14039.82609,509.7565217,533.573913,1759.278261,20228.14783,1208.982609,4745.356522,3233.46087,7076.678261,1249.973913,343.9217391,2469.330435,14233.05217,568.5565217,320.5043478,674.4869565,17012.30435,412.6782609,118.8347826,2986.878261,13201.41739,1436.921739,744.0434783,2784.6,11295.98261,692.4695652,256.5130435,2340.591304,9047.878261,933.8086957,391.4434783,1320.895652,7011.078261,691.8347826,155.6956522,4565.669565,6117.852174,1277.782609,208.4173913,3126.33913,677.173913,458.2173913,115,14.35768845,10.42026507,0.687945841,0.958333333,0.680473373,-0.698654706
+1910,24853.15534,780.0194175,554.9805825,1070.553398,22045.34951,744.3786408,719.8349515,1555.883495,12542.41748,507.7378641,2375.291262,1885.68932,17925.31068,1219.475728,5496.446602,4148.126214,6416.262136,1238.815534,338.6601942,2734.786408,12861.78641,752.0291262,363.6893204,1794.417476,15279.99029,882.1650485,679.961165,3717.165049,11974.91262,2017.368932,581.1067961,2799.980583,10288.62136,817.5631068,254.223301,1783.23301,8353.757282,1463.475728,406.3980583,1297.048544,6391.504854,695.815534,153.5145631,4695.038835,5566.446602,1295.514563,658.6116505,3184.174757,714.9708738,457.2815534,103,12.8415557,10.44388111,0.581861571,0.936363636,0.668831169,1.484549339
+1911,34865.25556,812.2,439.4111111,1108.066667,28797.5,653.1888889,473.7777778,1729.477778,16528.34444,493.6111111,495.5888889,1785.077778,23095.94444,1230.022222,4715.888889,2449.8,8130.633333,1231.477778,340.4666667,2607.1,16392.84444,7461.911111,315.3666667,490.9333333,19214.71111,468.6111111,126.5222222,3912.566667,15316.08889,1434.8,564.7444444,2807.977778,12756.17778,649.2333333,269.3,4101.844444,10122.36667,841.6888889,400.9555556,1308.311111,6931.311111,687.7333333,150.8,1753.144444,5919.055556,1208.877778,125.1444444,3303.744444,881.4888889,456.1666667,90,14.0088845,8.359576128,0.802439198,0.909090909,0.642857143,1.333096732
+1912,19147.11039,716.7987013,572.0519481,1077.649351,17026.22078,558.9155844,468.7987013,1622.551948,8244.207792,422.6623377,469.6428571,1774.025974,13097.32468,1078.084416,7608.935065,3095.480519,4662.383117,1072.279221,306.512987,2779.909091,8560.714286,5531.058442,882.8051948,463.5519481,10523.98701,423.0519481,114.961039,12124.9026,8459.694805,1418.649351,698.6818182,2802.292208,6645.987013,566.5454545,239.961039,11616.80519,5264.5,732.7597403,351.8831169,1301.61039,3098.980519,762.6623377,143.5844156,3535.883117,2947.337662,1015.785714,163.1298701,3113.116883,1017.954545,459.1233766,154,15.77447628,12.55143985,0.605716829,0.950617284,0.733333333,0.607570523
+1913,38195.36842,1044.842105,530.0789474,1089.381579,34035.26316,774.8157895,679.1315789,1538.421053,18820.59211,607.8552632,576.9342105,1787.315789,26603.28947,1403.078947,3552.618421,2850.052632,9255.368421,1403.473684,377.8289474,2444.592105,18231.85526,476.6710526,578.4868421,558.8684211,21308.77632,491.8684211,133.4342105,2560.513158,16639.80263,1608.25,813.75,2817.381579,14721.67105,660.3947368,305.1447368,1690.315789,11854.77632,959.25,456.8421053,1321.013158,8804.539474,758.8684211,172.1842105,2722.565789,7965.25,1401.144737,529.25,3343.855263,433.8026316,456.6710526,76,12.30916707,8.349178574,0.734794785,0.926829268,0.703703704,-1.355966491
+1914,39002.04,865.032,469.312,1077.912,32486.16,713.848,509,1536.88,19050.4,546.512,430.936,1734.128,26074.056,1382.432,4727.656,2683.904,9548.008,1331.848,364.416,2390.208,18703.696,467.288,236.264,478.704,21789.08,402.528,122.456,2994.408,17003.008,1491.936,978.872,2809.704,14918.64,649.36,290.792,2084.896,11940.24,888.48,426.328,1303.832,9463,670.424,166.344,3391.648,8003.064,1430.464,351.528,3214.44,598.248,460.528,125,16.1379414,11.23326486,0.717966234,0.844594595,0.48828125,-0.723339875
+1915,45383.93617,872.1914894,453.1276596,1097.659574,36192.93617,727.106383,619.5744681,1590.106383,22900.80851,559.212766,483.5957447,1746.93617,30080.53191,1405.170213,3662.978723,2359.234043,10956.57447,1350.829787,374.2553191,2381,21806.87234,482.0425532,308.2340426,592.6170213,25346.6383,432.6808511,129.7234043,2764.361702,20268.10638,1544.680851,1076.808511,2809.361702,17713.93617,630.9574468,306.8510638,1946.787234,13962.85106,923.9148936,431.893617,1313.659574,10894.74468,733.1702128,167.893617,2333.468085,9165.042553,1435.787234,261.6595745,3192.12766,607.6170213,455.6808511,47,9.171187092,6.760185014,0.675771435,0.94,0.671428571,1.338719529
+1916,56955.37333,926.64,576.8666667,1159.96,50643.28,706.0266667,657.72,1651.106667,26162.37333,564.9333333,506.7866667,1718.253333,36476.16,1325.72,7630.626667,4049.12,13789.92,1484.52,391.1733333,2424.266667,26540.6,426.1866667,142.36,412.3866667,32540.65333,413.8933333,132.7866667,5666.706667,24820.57333,1485.24,549.8133333,2816.32,20560.16,595.4,306.72,2834.28,12966.6,818.7466667,442.1066667,1308.786667,10681.34667,625.5066667,166.28,1503.626667,8847.066667,1308.32,145.2666667,3248.626667,189.3333333,459.8133333,75,13.3744934,7.354883004,0.835218239,0.949367089,0.568181818,-0.608438025
+1917,40256.12791,885.7209302,580.5232558,1123.569767,37488.65116,711.5232558,675.3139535,1642.627907,21816.46512,577.0813953,700.5232558,1812.255814,30876.22093,1345.72093,7540.604651,5591.918605,11132.4186,1432.337209,388.3023256,2560.953488,22060.30233,456.244186,160.9767442,824.7906977,26752.7093,464.255814,138.6860465,5496.27907,20626.10465,1648.872093,1132.476744,2840.139535,18504.87209,644.0465116,318.0465116,2180.523256,13871.06977,1008.081395,476.7906977,1301.872093,10640.55814,671.3255814,182.3837209,4255.372093,9133.709302,1428.709302,173.9302326,3379.953488,278.9186047,458.1627907,86,13.21374127,8.492516662,0.766115082,0.945054945,0.614285714,1.179657104
+1918,31475.93269,896.3653846,527.5,1093.4375,27867.55288,721.8413462,717.875,1548.399038,15098.24519,562.3269231,1228.711538,1787.048077,21424.375,1325.177885,4471.399038,4266.576923,7703.927885,1365.894231,370.75,2630.201923,15244.44231,454.6682692,974.0192308,714.9471154,18114.04327,480.6778846,131.5192308,3643.375,13675.22115,1996.451923,977.9423077,2838.389423,12122.85096,861.7980769,300.1201923,1829.014423,9636.701923,1117.350962,465.4326923,1389.701923,7595.831731,886.3557692,178.7163462,4911.884615,6578.826923,1403.206731,277.7596154,3313.860577,419.5480769,461.3557692,208,18.75319633,14.34015735,0.644412523,0.932735426,0.729824561,1.483742463
+1919,30992.74,906.73,512.92,1087.71,25637.23,705.34,726.91,1530.27,15992.46,553.43,1103.63,1785.85,22416.55,1340.86,2819.88,2555.15,7793.04,1441.12,375.93,2487.01,15787.93,457.43,450.43,1173.95,18560.31,482.8,315.95,1681.28,14677.32,1978.35,682.69,2834.3,13052.9,739.04,285.43,1510.65,10333.1,1076.88,472.42,1369.15,7820.45,743.57,177.62,3745.39,7239.99,1447.74,177.7,3262.85,534.81,459.88,100,12.07734181,10.76521318,0.453303619,0.961538462,0.699300699,0.195635987
+1920,24732.61682,818.7943925,542.7570093,1080.009346,22184.24299,671.7383178,512.1869159,1546.196262,12480.14019,518.7943925,475.1121495,1752.841121,17525.6729,1253.299065,4671.308411,3135.242991,6347.775701,1245.392523,351.411215,2416.850467,12610.45794,475.0934579,471.6448598,594.9439252,15426.72897,404.5981308,118.2429907,3542.149533,11500.62617,1484.299065,769.5327103,2787.635514,10022.80374,941.7663551,267.635514,2054.570093,8164.878505,883.5420561,407.1962617,1335.813084,6292.588785,752.3925234,159.3084112,4936.401869,5469.224299,1329.971963,328.9252336,3162.682243,687.953271,459.728972,107,13.72322038,10.3361897,0.657803249,0.906779661,0.636904762,-0.493508701
+1921,27361.34694,887.0204082,473.9591837,1065.040816,23207.4898,639.8163265,693.5714286,1516.653061,13750.32653,508.4489796,511.244898,1702.816327,19479.95918,1203.102041,6940.204082,2784.244898,6997.44898,1211.591837,356.0408163,2467.285714,13853.40816,452.5918367,442.5918367,503.3061224,16621.69388,426.2040816,118.4897959,4080.673469,13256.02041,1485.653061,583.7346939,2784.755102,11494.02041,606.1428571,276.7346939,2015.816327,9281.571429,866.5918367,398.9387755,1290.061224,7031,746.3469388,157.6938776,4576.44898,6241.836735,1284.755102,186.122449,3175.918367,740.3469388,457.7346939,49,9.821206692,6.645698372,0.736288076,0.875,0.6125,-1.341195236
+1922,15047.3125,768.75,487.8333333,1049,15007.02083,621.75,485.2083333,1498.729167,7473.520833,501.3125,1169.479167,1709.9375,12628.41667,1164.375,6994.0625,4636.645833,4435,1151,317.9583333,2631.666667,8277.270833,430.375,1433.125,853.7708333,9655.354167,419.4791667,124.4791667,3338.3125,7513,1740.854167,679.6458333,2765.208333,6488.104167,573.9166667,232.8125,2179.479167,5389.395833,1151.833333,392.4791667,1298.645833,4265.854167,993.4583333,160.1458333,4536.229167,3518.25,1218.229167,474.7708333,3151.708333,770.0416667,458.8333333,48,11.93858997,5.915897843,0.868592336,0.827586207,0.48,-0.665289617
+1923,26442.0814,717.0697674,383.9767442,1084.023256,23383.54651,601.372093,479.244186,1581.453488,12789.89535,470.744186,440.8953488,1714.069767,18715.01163,1107.162791,3224.093023,1400.72093,6696.55814,1156.22093,327.5697674,2541.906977,12984.97674,14077.83721,157.3488372,477.8023256,15470.12791,469.744186,111.0348837,1867.186047,12047.47674,1345.372093,515.0116279,2777.965116,9934.093023,1045.488372,256.4651163,2117.023256,8200.302326,766.9069767,388.3953488,1289.72093,5790.290698,605.0813953,143.1511628,1060.732558,4990.151163,1136.244186,132.9302326,3224.953488,843.3023256,459.1046512,86,12.26146158,9.171256251,0.663727864,0.934782609,0.651515152,0.487252259
+1924,17996.97143,706.5190476,459.4285714,1057.142857,13734.8,557.9761905,395.1142857,1521.428571,6768.252381,423.1809524,532.3047619,1746.97619,10429.69524,1052.852381,4153.233333,1647.128571,3886.42381,1102.161905,306.647619,3052.314286,7112.685714,476.1,743.9047619,546.1857143,8493.52381,428.1761905,108.4904762,2918.595238,7102.161905,1394.828571,541.0904762,2941.271429,5841.509524,559.1333333,241.8904762,9837.095238,4680.666667,769.2190476,365.0380952,1336.87619,2917.590476,754.5857143,147.3809524,3333.828571,2731.833333,1071.109524,213.0190476,3134.8,987.7,463.4380952,210,19.07186138,14.89969408,0.62423123,0.857142857,0.581717452,0.69688624
+1925,40943.91188,884.605364,529.2452107,1117.149425,11118.12644,410.7318008,206.6666667,1209.180077,3798.632184,332.954023,285.8275862,1594.862069,7176.333333,822.4597701,1753.659004,1040.05364,2528.237548,861.3103448,244.9616858,2293.547893,4480.141762,236.2796935,92.44444444,432.1111111,5163.249042,278.0229885,91.24904215,1728.122605,3773.272031,1116.858238,437.4367816,2774.812261,2835.068966,422.2720307,170.3448276,972.8084291,1662.731801,541.6130268,292.0153257,1244.923372,772.045977,465.8275862,120.9118774,614.0804598,870.2643678,773.8314176,80.68965517,2818.666667,1131.467433,463.4942529,261,21.42523127,15.59273991,0.685816359,0.956043956,0.654135338,-0.86922798
+1926,43803.23457,895.4938272,589.7530864,1177.012346,9698.345679,431.7037037,275.0617284,1269.185185,5004.666667,368.617284,496.7160494,1752.740741,7909.938272,913.7654321,9041.987654,4285.246914,3311.82716,989.4814815,279.0864198,2371.111111,6922.580247,293.4938272,193.3333333,428,7425.185185,299.308642,104.0987654,10756.80247,5652.432099,1270.54321,952.7530864,2781.074074,4956.061728,479.345679,210.9135802,5030.234568,3562.024691,640.4567901,350.7407407,1272.728395,3330.876543,555.4074074,151.8518519,3515.259259,2501.469136,1013.160494,210.0617284,3083.802469,178.3703704,459.9135802,81,13.79779219,8.164843784,0.806121527,0.861702128,0.54,-1.354278542
+1927,55117.02778,947.4722222,541.0833333,1156.013889,53011.06944,781.2222222,622.125,1736.097222,29414.20833,617.375,520.2638889,1766.458333,41456.76389,1425.555556,7095.236111,4018.986111,14518.16667,1510.833333,420.3194444,2419.583333,29628.40278,493.4861111,142.1666667,440.6388889,35620.79167,454.3055556,146.3611111,4027.583333,27413.76389,1567.388889,841.4583333,2837.472222,23931.16667,663.1527778,338.4861111,2238.847222,17890.72222,896.125,490.8888889,1306.305556,13868.54167,684.1388889,186.9861111,2874.055556,11757.06944,1484.888889,177.7361111,3386.263889,266.25,458.8888889,72,10.98169754,8.510406006,0.63200697,0.935064935,0.666666667,-1.23758859
+1928,32554.07576,905.9242424,548.2272727,1099.606061,29546.94949,722.0505051,602.2575758,1598.69697,16765.70202,570.8838384,695.4343434,1773.813131,22814.71212,1332.681818,5848.338384,4663.782828,8355.994949,1359.378788,381.9444444,2447.560606,16721.87374,430.0909091,370.2626263,621.979798,19807.48485,431.4646465,149.8383838,6746.424242,15549.61616,1631.732323,928.2070707,2821.575758,13488.07071,664.1616162,295.3333333,2019.212121,10796.77778,968.989899,462.7070707,1313.060606,8410.782828,757.9747475,181.7929293,5114.030303,7305.792929,1448.979798,210.2121212,3401.464646,334.6262626,463.4949495,198,19.12905407,13.8551514,0.689486194,0.864628821,0.647058824,1.032435904
+1929,17725.36709,901.0379747,592.1392405,1105.227848,15377.31646,692.0759494,789.2151899,1591.341772,8387.898734,558.9240506,1115.278481,1837.278481,12400.12658,1342.455696,3770.962025,4223.746835,4520.329114,1380.113924,436.4177215,2711.835443,8427.797468,879.1139241,912.7088608,1015.544304,9930.012658,655.164557,494.6835443,4931.670886,7830.974684,2080.240506,790.7468354,2837.278481,7010.734177,864.3670886,273.3164557,1805.544304,5454.860759,1555.898734,426.2911392,1372.417722,4429.949367,880.0759494,173.8101266,6771.936709,3718.848101,1318.139241,371.0886076,3336.177215,470.0506329,460.7088608,79,12.71473879,8.272356155,0.759410684,0.929411765,0.598484848,0.925711344
+1930,17499.18841,1160.826087,575.1449275,1019.768116,15725.05797,734.9710145,468.826087,1354.405797,8335.797101,614.4057971,523.7246377,1689.072464,10875.31884,1254.42029,1833.971014,1598.594203,4160.275362,1265.231884,326.057971,2436.942029,8024.811594,395.9855072,268.7681159,569.4927536,8455.927536,366.4782609,116.7391304,1792.84058,6771.086957,1397.913043,700.4782609,2788.507246,6261.884058,544.5797101,234.942029,1483.144928,4836.231884,766.2753623,379.3333333,1310.710145,4106.086957,609.6956522,145.6811594,2146.42029,3238.043478,1092.695652,117.2028986,3386.391304,544.826087,460.2753623,69,13.07381377,7.151670226,0.837117907,0.8625,0.638888889,-0.17321812
+1931,43814.83516,876.5934066,469.7692308,1111.021978,36649.65934,716.3076923,846.1098901,1601.472527,22256.36264,564.3846154,1581.087912,1797.164835,30515.31868,1356.56044,3704.692308,3619.56044,10857.92308,1342.175824,360.8131868,2682.912088,22027.9011,479.2087912,294.0989011,1094.934066,25573.93407,1610.428571,125.8461538,3085.648352,20335.35165,1615.054945,685.3956044,2835.89011,17927.32967,625.4835165,301.7362637,1956.087912,14241.38462,1496.978022,437.8571429,1318.901099,10999.46154,725.2197802,169.4505495,4447.505495,9474.637363,1422.527473,379.1208791,3221.450549,618.4395604,460.1318681,91,12.74816468,9.210859383,0.691345475,0.93814433,0.7,-1.476815894
+1932,25489.14737,759.0631579,473.0947368,1085.2,21697.91579,638.1052632,660,1631.863158,11538.32632,455.2210526,426.8526316,1751.484211,16828.56842,1119.526316,4014.757895,2584.736842,6249.547368,1177.431579,385.8105263,2458.463158,11817.28421,2230.021053,2056.336842,473.6421053,13637.89474,423.0736842,121.2736842,4906.768421,11329.89474,1458.494737,746.4105263,2845.094737,9132.894737,588.7368421,254.1894737,11231.11579,7562.568421,759.1263158,392.8526316,1346.557895,4999.368421,1181.084211,154.5894737,3485.989474,4552.284211,1179.178947,189.3368421,3213.789474,945.5789474,461.2526316,95,14.02597272,9.668377251,0.72445742,0.871559633,0.608974359,-1.014542037
+1933,57587.50318,969.2292994,616.6433121,1187.993631,14857.50318,414.9936306,194.910828,1187.305732,6890.815287,360.0573248,431.3121019,1691.89172,10167.43949,859.6178344,5780.019108,2825.687898,4401.573248,1018.910828,268.3630573,5037.235669,8464.821656,255.4203822,83.79617834,366.4267516,9792.974522,267.9617834,97.29299363,4928.745223,7365.210191,1103.993631,557.4649682,2784.828025,6446.254777,448.3694268,193.0636943,2423.082803,4602.133758,600.5477707,325.0828025,1273.280255,4128.598726,505.6687898,136.9936306,1378.44586,3189.350318,952.2038217,92.49681529,3030.146497,197.9299363,465.656051,157,17.88627354,13.10983687,0.68027693,0.821989529,0.534013605,-0.178456525
+1934,50100.58861,935.8417722,570.6835443,1156.481013,22497.40506,500.7468354,291.8924051,1342.78481,11694.12025,427.1708861,472.3037975,1732.278481,15736.42405,1002.208861,6892.272152,3130.227848,6120.208861,1099.670886,301.3924051,2359.822785,11537.91139,310.3734177,115.8924051,387.5443038,14065.33544,305.2911392,105.8481013,5710.487342,10772.08228,1274,628.6835443,2796.018987,9027.556962,487.8227848,222.2278481,1346.202532,6517.272152,665.3227848,358.443038,1275.386076,5183.392405,546.1265823,144.5316456,1190.455696,4344.607595,1030.860759,90.80379747,3112.28481,232.3417722,461.4683544,158,17.97402209,11.37892593,0.774089467,0.934911243,0.774509804,-1.269153045
+1935,15544.3211,1044.256881,517.5504587,1010.53211,15240.30275,710.9449541,700.8899083,1345.495413,7780.357798,573.3853211,846.9174312,1753.256881,10315.88991,1199.477064,4233.651376,2680.183486,4000.93578,1220.587156,335.4678899,2409.238532,7583.844037,381.1834862,430.9908257,786.2110092,8499,401.5229358,156.8256881,4352.926606,6804.908257,1659.073394,650.4587156,2785.357798,5836.522936,600.8256881,249.1284404,1464.917431,4603.798165,876.4587156,383.0275229,1306.779817,3547.605505,659.5963303,154.1009174,3032.862385,3043.816514,1158.091743,314.7522936,3459.376147,347.4770642,463.2385321,109,16.1343034,9.899233991,0.789654325,0.865079365,0.619318182,-0.126505697
+1936,36276.3875,926.4125,524.05,1111.575,32492.0125,747.425,653.4125,1592.8125,18065.8625,584.2625,851.05,1784.125,25162.85,1384.0625,4266.4625,4805.4125,8833.0125,1519.2875,393.5375,2434.275,18089.25,1093.225,338.5625,497.6875,21434.5625,447.1625,137.125,4121.5125,16172.9625,1618.625,856.4,2819.0625,14530.075,666.2375,330.5,2141.8875,11700.4375,1995.6375,479.425,1343.55,8990.3875,746.5125,196.325,5677.275,7994.475,1460.0625,360.5375,3305.95,448.2375,461.6125,80,11.09395366,9.758032192,0.475748938,0.91954023,0.606060606,-0.790782985
+1937,34921.5,901.328125,528.328125,1109.0625,29644.95313,713.4375,546.953125,1572.765625,17384.78125,591.28125,674.09375,1796.515625,24593.25,1398.6875,3066.640625,3910.953125,8551.296875,1795.609375,375.59375,2520.21875,17274.09375,492.5625,391.046875,669.421875,20251.67188,442.71875,131.34375,2696.28125,15905.79688,1686.734375,875.203125,2877.90625,14149.96875,692.109375,304.359375,2258.546875,11059.0625,1003.6875,477.875,1363.765625,8662.953125,741.4375,187.5625,7897.6875,7482.765625,1427.03125,147.140625,3280.1875,552.34375,460.171875,64,10.22512193,8.144544199,0.604608306,1,0.711111111,-0.545118022
+1938,39648.16571,946.4742857,498.1542857,1110.48,33752.65143,746,758.7257143,1623.108571,19805.85143,561.1314286,1572.605714,1800.24,28006.65143,1322.565714,5660.457143,3604.948571,9695.131429,1289.617143,361.8457143,2686.588571,19533.63429,474.7485714,337.3771429,1537.262857,22986.2,426.3314286,423.3257143,2553.554286,18387.4,1958.16,730.6342857,2817.302857,15993.60571,647.3485714,282.04,1912.988571,12872.92571,1036.982857,420.1542857,1320.542857,9250.742857,690.4571429,169.4342857,2530.674286,8030.44,1332.308571,283.72,3242.251429,780.12,464.3314286,175,17.99538482,13.14299079,0.68306946,0.930851064,0.648148148,0.405490213
+1939,18408.7625,915.36875,751.09375,1136.84375,15351.7125,714.95625,556.21875,1717.60625,7716.25,524.525,461.95,1764.41875,11857.425,1362.18125,4023.55625,1899.15,4204.1,1269.96875,389.30625,2496.85,8269.75625,510.9,2867.8625,489.95625,9525.98125,422.98125,128.55,3774.65,7935.06875,1501.51875,584.9,2832.44375,6583.65625,594.85,288.4,16847.4,5535.4125,954.36875,424.5,1362.34375,3794.4125,1311.64375,176.2625,5316.65625,3358.05,1341.375,187.95625,3221.6125,928.375,463.33125,160,17.50532286,11.93557902,0.731514671,0.924855491,0.62745098,-0.949977951
+1940,47740.08654,892.7211538,591.4326923,1136.423077,35951.97115,647.6538462,560.1730769,1619.096154,19075.60577,508.75,503.0673077,1789.980769,25763.91346,1210.673077,10349.41346,4311.875,9594.548077,1291.807692,354.9326923,2386.451923,19469.14423,408.1346154,136.4423077,418.1923077,23411.41346,386.4807692,128.7596154,8630.730769,17825.14423,1418.980769,944.2788462,2818.798077,15463.49038,587.8653846,291.2884615,3277.730769,11381.64423,805.4519231,429.2596154,1309.971154,9027.461538,618.375,173.6634615,2790.692308,7565.278846,1265.769231,175.9519231,3237.192308,250.3942308,462.5,104,12.58429875,10.76652076,0.517717045,0.971962617,0.666666667,-0.387363749
+1941,35342.13873,925.7052023,595.7398844,1114.734104,33443.08092,723.0057803,620.4450867,1645.33526,18604.49711,579.8901734,630.0693642,1810.774566,25355.42775,1305.127168,9288.895954,5417.578035,9167.202312,1381.184971,378.5433526,2479.947977,18262.35838,440.3757225,161.7283237,510.0057803,21523.45087,427.2369942,135.3583815,6463.653179,16408.6185,1553.236994,1147.046243,2995.283237,14649.69364,611.2601156,288.9595376,2354.144509,11161.45087,908.3294798,441.7803468,1302.67052,8817.364162,640.4624277,177.4624277,4815.317919,7509.16185,1371.069364,151.3699422,3394.606936,293.716763,463.5317919,173,17.81085658,13.12345573,0.676085269,0.887179487,0.640740741,-0.941659973
+1942,21576.81982,950.0720721,496.1171171,1042.783784,18295.51351,695.6846847,701.7027027,1443.207207,10309.18018,566.9009009,1248.324324,1799.54955,14546.57658,1276.918919,5048.261261,2763.873874,5171.828829,1363.009009,344.3693694,2870.315315,9370.225225,406.3423423,451.2252252,1266.756757,11102.05405,434.2882883,159.5405405,1695.585586,8293.504505,2091.486486,655.7027027,2799.774775,7307.108108,643.1441441,254.8468468,1454.117117,5891.540541,1195.126126,422.036036,1362.873874,4774.837838,690.9189189,164.8828829,4163.666667,4282.711712,1257.441441,243.6036036,3303.684685,517.1261261,462.0990991,111,13.16099983,11.09816297,0.537503705,0.917355372,0.770833333,-0.908070013
+1943,36306.01389,827.375,491.3055556,1116.791667,30656.23611,735.5138889,614.3888889,1597.569444,18092.95833,538.875,1104,1799.972222,24738.875,1294.083333,4932.625,3602.861111,8793.597222,1885.305556,337.625,2474.236111,17762.95833,448.9166667,164.3611111,656.7638889,20794.01389,441.1944444,280.3611111,2933.5,16278,1932.319444,864.5833333,2799.083333,14293.02778,640.7083333,266.5277778,2123.958333,11232.98611,1127.902778,413.3888889,1308.375,8711.875,648.5694444,159.875,4254.694444,7510.888889,1348.5,923.8472222,3245.166667,631.4583333,461.6527778,72,10.2036599,9.611086251,0.335822237,0.923076923,0.72,-1.059710247
+1944,40846.98969,857.8350515,492.1237113,1118.731959,34635.30928,767.7628866,507.1340206,1617.907216,21576.30928,554.2474227,1017.556701,1778.773196,29293.65979,1357.020619,4357.680412,3521.835052,10446.07216,1368.42268,368.8350515,2446.762887,20766.15464,464.9278351,122.4226804,541.6701031,24387.49485,424.742268,337.814433,2793.597938,19358.64948,1792.525773,821.7216495,2823.247423,17045.64948,726.7319588,288.7216495,1885.175258,13364.08247,1025.618557,422.742268,1300.082474,10288.03093,641.7216495,166.5463918,3184,8880.824742,1402.814433,449.371134,3195.57732,640.6804124,462.8865979,97,13.02035407,9.840560191,0.65482234,0.941747573,0.746153846,0.191838733
+1945,20420.44828,736.8735632,469.7241379,1078.936782,17452.54023,585.4712644,493.316092,1588.597701,9455.178161,461.6321839,555.9137931,1795.252874,14417.50575,1170.787356,5561.425287,2285.517241,5078.005747,1142.241379,316.0172414,2804.988506,9760.281609,7694.568966,436.9195402,492.3735632,11562.95977,469.1551724,123.4885057,5557.068966,9085.827586,1473.965517,664.7701149,2790.965517,7495.034483,727.5574713,251.2816092,7232.54023,6219.95977,812.0804598,377.2356322,1309.632184,4273.017241,718.4310345,153.454023,3070.741379,3598.034483,1139.752874,154.1666667,3280.454023,875.8563218,465.6896552,174,16.5879685,13.79747377,0.555111446,0.925531915,0.644444444,0.506658748
+1946,22117.65,902.5083333,493.1416667,1058.833333,20135.35833,678.8916667,819.4083333,1424.95,10656.61667,540.2,983.5333333,1801.166667,14976.18333,1238.833333,3741.541667,2436.483333,5448.766667,1286.433333,357.4666667,2413.983333,10571.95,474.8416667,1513.791667,559.3333333,12969.64167,403.1666667,127.3166667,1799.85,10160.13333,1814.975,638.3,2833.141667,8664.45,912.3333333,259.2416667,1434.783333,7026.316667,1364.216667,418.5916667,1380.625,5430.433333,946.2583333,167.0833333,3883.016667,4988.941667,1298.608333,502.3166667,3320.725,355.875,466.425,120,16.39173794,9.901393539,0.796948074,0.882352941,0.576923077,-0.451688373
+1947,24684.93793,973.4827586,552.9172414,1072.544828,26104.87586,761.0275862,568.0413793,1597.924138,12794.55862,579.7655172,534.6896552,1789.393103,17837.63448,1332.558621,5067.082759,3927.151724,6371.896552,1381.537931,360.3586207,2411.048276,10218.47586,409.662069,1652.97931,442.262069,12104.70345,385.9862069,124.1655172,4950.841379,9359.565517,1483.103448,754.4344828,2792.42069,8193.089655,682.7862069,266.2,1852.37931,6567.827586,827.4482759,430.0827586,1342.827586,5024.993103,1033.648276,175.4137931,5877.37931,4574.634483,1303.524138,163.4689655,3273.593103,368.8482759,466.1103448,145,15.74416347,11.81230678,0.661136362,0.966666667,0.697115385,-0.468449048
+1948,30599.88889,1073.055556,569.8888889,1070.255556,26828.95556,751.5111111,769.4888889,1502.866667,14587.37778,611.5666667,946.4222222,1790.355556,20897.35556,1372.333333,6001.466667,3091.888889,7329.833333,1372,367.7111111,2557.777778,14214.46667,462.5777778,286.1111111,689.5777778,16686.66667,518.5888889,130.7888889,2874.177778,12643.77778,1781.522222,767.7777778,2810.766667,11007.5,674.0444444,281.3888889,1413.588889,8631.844444,1166.2,431.2333333,1325.155556,6985.322222,672.1333333,168,2487.722222,5836.777778,1312.377778,433.9222222,3431.544444,506.4888889,463.7222222,90,12.92507394,9.031754382,0.715338817,0.927835052,0.692307692,0.396285563
+1949,33103.17518,824.8905109,535.1386861,1098.364964,29174.57664,687.9854015,601.379562,1606.284672,16733.23358,526.0145985,587.0291971,1775.116788,23488.48175,1297.364964,7540.890511,4420.328467,8336.773723,1281.678832,346.0218978,2494.036496,16779.10219,453.0145985,139.0583942,735.8175182,19882.12409,421.5328467,125.2554745,4635.153285,15409.10949,1634.810219,958.0729927,2795.459854,13470.9854,621.6569343,269.7518248,2351.109489,10736.17518,906.4671533,410.2627737,1295.642336,8324.824818,654.810219,165.5620438,4444.963504,7039.59854,1335.321168,213.4963504,3243.948905,651.5912409,465.0291971,137,15.9322585,11.58662496,0.686379985,0.85625,0.702564103,0.457271753
+1950,15680.57143,732,435.8285714,1029.542857,15240.05714,608.2285714,1114.171429,1425.485714,7724.742857,478.5142857,1483.714286,1776.342857,12192.42857,1139.8,5405.542857,4702,4382.6,1148.257143,343.2285714,2837.428571,8397.571429,429.2285714,120.5142857,1043.628571,9926.657143,486.8571429,114.4,2309.914286,7745.685714,2088.371429,677.9714286,2847.914286,6726.314286,617.1142857,234.2285714,2008.742857,5493.257143,2469.771429,381.7428571,1307.171429,4424.857143,597.1714286,156.4,6987.685714,3659.314286,1222.514286,823.9142857,3086.542857,756.7714286,460.6,35,9.848577776,4.894124495,0.867786515,0.853658537,0.583333333,1.565789341
+1951,23600.4055,794.2164948,539.4261168,1161.965636,19445.57045,601.5979381,430.3745704,1777.199313,8794.309278,478.5292096,508.5841924,1813.862543,11603.94502,1097.154639,5050.704467,2060.656357,4376.546392,1131.024055,414.2542955,2467.109966,8313.52921,2122.158076,1442.182131,459.7010309,9641.910653,416.2783505,113.2199313,6941.223368,6879.769759,1405.817869,488.8591065,2798.841924,5484.450172,735.3848797,239.3608247,6536.958763,3029.573883,698.3642612,363.4948454,1296.020619,2377.584192,760.6426117,148.6426117,2751.164948,2074.340206,1026.020619,162.0824742,3119.137457,149.4467354,469.7972509,291,20.83915455,18.26068578,0.481823895,0.966777409,0.729323308,0.206730512
+1952,44241.4139,892.0120846,592.3746224,1124.054381,42387.81571,726.1933535,553.6102719,1712.335347,22677.38973,573.5256798,547.0453172,1792.558912,31512.51662,1335.172205,9880.504532,5987.785498,11486.59517,1416.882175,384.7522659,2466.169184,23799.08459,461.3927492,140.6827795,461.4682779,27875.35045,435.8096677,137.1691843,6464.199396,21617.70091,1531.205438,934.0332326,2821.945619,19073.62236,626.4410876,315.5468278,2568.915408,14251.66465,892.0453172,459.1389728,1306.271903,11302.98489,657.9697885,180.3353474,3898.172205,9327.679758,1405.223565,159.4682779,3347.429003,257.5407855,473.0271903,331,28.0455345,16.18198629,0.816751378,0.848717949,0.533011272,-0.656825654
+1953,25042.35052,980.7525773,516.7319588,1063.257732,22175.7732,719.6597938,683.2061856,1498.061856,12634.28866,561.8762887,813.6494845,1737.278351,17083.38144,1310.556701,5179.958763,3424.680412,6196.979381,1349.092784,398.5670103,2442.690722,14739.54639,471.371134,1499.917526,637.4742268,15189.28866,592.7525773,130.2268041,1970.659794,11696.58763,1807.948454,661.8041237,2840.319588,10271.39175,727.9381443,293.7216495,1366.474227,8157.71134,1380.463918,449.6701031,1323.814433,6244.515464,956.4845361,172.257732,1999.804124,5519.56701,1353.639175,142.5979381,3375.783505,381.7525773,465.2989691,97,13.20301288,9.69284558,0.678999301,0.923809524,0.746153846,-0.115602277
+1954,19782.89,888.34,464.06,1062.94,17895.59,724.125,699.875,1520.395,9539.055,536.01,621.795,1756.57,13740.015,1277.785,5420.395,2034.28,5066.45,1331.44,397.405,2436.815,9732.215,6131.435,2553.825,580.91,11838.1,494.85,131.54,1844.825,9118.565,2037.46,702.725,2832.68,7980.875,1305.01,273.59,1463.98,6375.605,855.765,437.375,1443.24,5149.055,1325.765,172.99,3453.73,4415.54,1350.825,212.885,3360.265,402.645,468.06,200,19.06510706,13.91286069,0.683708544,0.900900901,0.666666667,0.134514882
+1955,23238.26042,856.6145833,505.0625,1072.885417,20731.47917,670.9479167,613.6354167,1524.864583,11712.58333,545.3645833,634.5833333,1778.083333,16538.30208,1306.4375,3063.927083,2648.53125,5842.447917,1599.583333,357.0729167,2463.666667,12328.67708,520.6354167,470.5625,534.9791667,13760.21875,451.9270833,123.5729167,2667.645833,10918.64583,1477.260417,802.4583333,2848.28125,9831.916667,692.125,272.9270833,1740.135417,7770.84375,905.5729167,444.78125,1343.364583,6183.625,739.15625,180.5729167,7439.666667,5288.59375,1352.072917,168.3229167,3187.041667,560.0208333,464.9479167,96,12.99416875,10.78275929,0.558038227,0.806722689,0.527472527,-1.419866999
+1956,14272.17647,762.1176471,494.1470588,1024.411765,14395.52941,632.6470588,595.4705882,1452.352941,6605.882353,468.7647059,931.2941176,1769.029412,11284.26471,1204.411765,6540.294118,4645.588235,3931.735294,1250.558824,326.4705882,2470.088235,7621.647059,430.2647059,1313.588235,1201.529412,8916.441176,413.8529412,110.8235294,3264.382353,6660.352941,1738,1154.558824,2811.117647,6003.205882,615.2647059,250.6764706,2714.058824,4878.705882,1083.705882,385.8823529,1310.176471,4292.411765,968.4705882,154.2941176,6132.941176,3441.588235,1277.794118,552.8823529,3153.411765,609.5882353,462.8823529,34,8.02907179,6.241209122,0.629097556,0.85,0.53125,0.903677068
+1957,26532.92715,829.7284768,553.5165563,1085.675497,22359.11921,651.0397351,817.3907285,1533.92053,13277.70861,519.4503311,1333.84106,1807.317881,18342.56291,1225.596026,3797.072848,2534.152318,6490.403974,1255.496689,351.7417219,3035.006623,13020.04636,965.7549669,584.3443709,503.4039735,15345.03974,440.4635762,117.0728477,1598.165563,12230.61589,1841.629139,596.8609272,2802.556291,10719.11258,994.192053,263.7284768,1634.602649,8708.172185,1179.231788,410.4039735,1359.774834,6412.728477,777.205298,161.9470199,4803.430464,5662.231788,1295.264901,309.2781457,3188.476821,733.0993377,468.5165563,151,20.24149033,10.11984122,0.866051186,0.877906977,0.580769231,-0.343527976
+1958,48299.35385,904.8461538,542.5846154,1112.969231,39581.76923,729.5846154,727.5538462,1719.2,24064.75385,575.4923077,1533.2,1742.169231,31680.86154,1340.661538,4543.2,3556.876923,11518.98462,1340.169231,370.4769231,2512.769231,22738.24615,498.6461538,803.8769231,626.7538462,26965.72308,1234.046154,137.8615385,3381.292308,21794.64615,1596.553846,626.5076923,2814.107692,18590.01538,625.5076923,295.5384615,2071.246154,15083.46154,1113.984615,437.6923077,1317.292308,10564.10769,904.6923077,170.3692308,4204.076923,9148.476923,1362.446154,533.0615385,3338.107692,805.0769231,463.2153846,65,10.36741711,9.052991905,0.487333823,0.902777778,0.492424242,1.552247833
+1959,28038.85714,730.3303571,473.4285714,1061.125,23237.58929,612.4196429,649.4375,1571.5,12956.34821,472.5982143,1205.991071,1740.5,19309.67857,1132.517857,8503.901786,4102.303571,6742.339286,1149.383929,329.1964286,4842.633929,13377.47321,2608.017857,153.3214286,638.9732143,15685.50893,436.4285714,119.5178571,5804.133929,12719.05357,1862.169643,652.3571429,2789.821429,10623.75,945.0982143,259.8392857,6425.642857,8564.6875,1022.526786,383.0982143,1294.705357,5938.723214,607.5089286,151.6964286,3729.241071,5164.116071,1155.5625,215.7946429,3225.607143,888.9821429,465.7053571,112,13.12945188,11.11346368,0.532463475,0.933333333,0.666666667,-0.42979845
+1960,33490.42857,820.4142857,497.3428571,1106.014286,27194.24286,635.7,747.5285714,1621.314286,14881.15714,482.2571429,1086.285714,1703.771429,20869.42857,1166.528571,5162.157143,2512.614286,7598.071429,1204.957143,336.6142857,3118.8,15202.22857,601.2285714,241.5428571,584.9857143,17859.34286,430.9285714,169.5571429,3756.628571,14776.74286,1483.857143,551.5857143,2831.314286,12411.54286,567.2714286,262.9285714,8396,10070.42857,1075.5,405.7,1306.728571,6704.2,668.1,151.0714286,4758.614286,6055.685714,1208.271429,652.1,3241.342857,913.8,464.7857143,70,11.22979011,8.675250856,0.634988981,0.897435897,0.578512397,-1.022075487
+1961,18998.98077,680.6602564,434.3717949,1040.692308,9487,466.0641026,286.6730769,1391.410256,4267.698718,364.025641,300.8525641,1665.621795,6540.910256,928.3910256,3747.634615,1461.737179,2384.467949,910.6217949,262.7051282,2401.891026,4419.961538,4471.429487,1276.666667,399.0192308,5135.275641,330.8012821,97.79487179,4854.512821,3938.487179,1206.596154,508.8653846,2784.134615,3057.269231,470.9294872,184.9423077,2359.551282,2184.371795,664.2692308,310.1474359,1259.730769,1100.820513,764.4679487,126.6282051,1473.307692,1098.147436,844.9487179,109.8012821,2934.5,1069.903846,466.0512821,156,15.93644578,12.66101212,0.607304709,0.957055215,0.742857143,-0.536529496
+1962,37431.52985,875.1902985,574.2164179,1159.988806,29940.63806,612.738806,594.9067164,1590.149254,15190.50746,496.5708955,1000.317164,1803.626866,20509.48134,1181.906716,9837.910448,4706.589552,8080.268657,1266.5,399.8246269,2867.097015,15257.04851,592.1828358,649.8432836,667.5708955,18039.89552,415.9402985,125.511194,9583.503731,13061.04478,1686.958955,653.9776119,2843.395522,10719.93284,545.3208955,268.2686567,8571.134328,6367.843284,920.8059701,395.6940299,1305.787313,5268.156716,738.2052239,162,4181.36194,4334.895522,1169.130597,282.8507463,3186.563433,169.4626866,469.9029851,268,20.62500028,17.47118962,0.531452699,0.914675768,0.609090909,0.126067958
+1963,39205.0922,846.5460993,507.4184397,1100.12766,38354.70213,687.7092199,724.9716312,1612.48227,20627.22695,558.751773,933.2624113,1791.177305,28448.92199,1355.496454,8949.87234,4176.978723,10464.06383,1451.815603,379.4751773,2616.382979,21157.79433,455.3617021,137.248227,1115.234043,25178.58156,449.3829787,129,3476.170213,19421.41135,1668.510638,830.4964539,2852.588652,17349.87943,611.2340426,302.9007092,1810.248227,13245.23404,1007.205674,458.6028369,1300.609929,10211.82979,648.035461,174.1914894,2664.879433,8740.446809,1381.496454,147.9361702,3381.347518,280.5673759,468.8723404,141,17.26175892,12.08230042,0.714195695,0.754010695,0.518382353,0.74238037
+1964,35933.06173,917.7592593,588.0987654,1125.858025,29856.84568,691.8888889,709.8888889,1577.450617,16548.84568,567.6296296,926.5246914,1793.765432,22720.64198,1287.024691,7050.450617,5783.851852,8302.123457,1355.092593,366.3148148,2487.228395,14832.14815,442.1728395,717.5432099,590.2839506,18779.09259,737.6666667,138.1049383,7516.253086,14412.7037,1494.41358,906.1234568,2852.790123,12621.40741,620.2839506,291.7901235,2199.641975,9867.666667,1141.506173,446.382716,1318.537037,8003.981481,759.3580247,174.4938272,4555.04321,6744.08642,1376.246914,355.4444444,3423.351852,315.6851852,468.345679,162,16.05243077,13.90823902,0.499305975,0.835051546,0.635294118,-0.270290314
+1965,41368.21978,995.7362637,508.5384615,1074.010989,37552.45055,772.6373626,879.956044,1562.857143,21256.31868,619.4175824,1454.065934,1752.923077,29644.58242,1383.582418,4637.043956,3578.659341,10219.47253,1403.89011,384.1208791,2545.758242,21565.42857,518.7472527,960.6813187,815.967033,25578.84615,935.5494505,134.4505495,2209.67033,20133.07692,1732.956044,685.6043956,2830.901099,17573.27473,675.8131868,315.7252747,1361.164835,13813.83516,1079.318681,473.6813187,1371.142857,10590.49451,811.1648352,180.3516484,3999.989011,9662.505495,1406.494505,212.8351648,3410.384615,390.4945055,466.4725275,91,13.89737128,8.785225265,0.774845917,0.919191919,0.722222222,-0.052047743
+1966,28838.45882,1069.364706,528.2470588,1085.035294,24154.31765,736.8705882,751.3411765,1513.964706,13346.10588,595.4588235,661.4117647,1793.329412,19012.27059,1328.270588,5598,3838.611765,6561.152941,1326.211765,353.4588235,2595.435294,12375.50588,444.1647059,392.1058824,564.8588235,14404.21176,703.1764706,125.5411765,3692.082353,11020.52941,1563.023529,766.9647059,2805.835294,9857.494118,574.7647059,271.0588235,1949.035294,7611.188235,1029.741176,431.8823529,1324.011765,5957.588235,695.7294118,165.7294118,3775.011765,5027.152941,1264.964706,179.7529412,3383.752941,436.8588235,464.3882353,85,12.59015231,8.916865308,0.705970482,0.923913043,0.787037037,-1.505465273
+1967,38261.40385,864.1153846,552.3846154,1132.519231,31849.40385,699.6346154,560.6923077,1667.057692,19162.69231,538.9230769,432.8076923,1740.807692,25667.11538,1305.576923,4792.326923,2996.75,9343.423077,1281.442308,354.1153846,2386.942308,18822.80769,645.7307692,140.7307692,468.75,22416.32692,433.5769231,122.75,2669.923077,17551.82692,1444.75,741.9615385,2818.269231,15210.28846,788.4038462,292.7884615,1991.269231,12238.82692,830,427.3846154,1306.307692,9002.980769,653.1730769,160.9423077,3383.865385,7901.557692,1361.673077,207.4807692,3231.557692,694.4807692,464.4038462,52,9.675151515,7.216907291,0.666033435,0.896551724,0.641975309,-0.652159659
+1968,27724.60194,946.7184466,834.6407767,1183.737864,24396.98058,748.6116505,831.1456311,1794.485437,14025,558.7378641,552.6601942,1780.747573,19655.25243,1351,2031.834951,1351.524272,7019.417476,1323.466019,372.7864078,2441.456311,13995.59223,6560.563107,507.5533981,487.592233,16444.80583,518.9126214,129.9902913,1420.271845,12963.03883,1555.660194,549.3980583,2816.524272,11310.95146,3634.291262,284.1650485,1715.640777,9243.15534,923.0776699,428.5533981,1327.980583,6884.058252,757.3883495,167.1067961,3996.699029,5920.213592,1397.456311,265.7669903,3292.970874,723.815534,464.5048544,103,13.12450781,10.57835069,0.591915804,0.911504425,0.613095238,-1.452828468
+1969,29035.46296,806.0864198,518.345679,1047.746914,25310.98765,678.8271605,767.8209877,1541.185185,13639.7037,504.5061728,1342.950617,1757.54321,19620.64815,1167.62963,5930.265432,3225.222222,6931.265432,1179.666667,332.4259259,3784.524691,13919.83333,1015.388889,791.5679012,1304.555556,16588.38272,481.8580247,120.6049383,4098.407407,12962.62346,1962.382716,577.5,2795.228395,10845.67284,680.8765432,250.0987654,4668.518519,8932.555556,1114.87037,391.2592593,1314.975309,6264.024691,799.7407407,151.5123457,3243.283951,5462.91358,1157.962963,254.9382716,3290.228395,841.1851852,468.6419753,162,19.31485813,11.36774122,0.808461518,0.895027624,0.595588235,0.961399438
+1970,27489.81287,753.5380117,464.005848,1065.912281,14246.15789,456.748538,337.3333333,1292.263158,6023.894737,362.0409357,772.0584795,1627.865497,10144.33918,912.4327485,4368.842105,1587.204678,3676.321637,956.9064327,261.4678363,2681.356725,6682.339181,382.5789474,1321.842105,500.7836257,7713.994152,290.4444444,98.32748538,3474.298246,5905.05848,1379.391813,485.3508772,2803.812865,4646.421053,452.8070175,193.9181287,2593.754386,3258.865497,715.9298246,306.0350877,1273.48538,1577.421053,817.3976608,128.2690058,1471.122807,1632.28655,849.0701754,144.2923977,2931.807018,1082.538012,467.5087719,171,16.89858774,13.14709594,0.628264666,0.93956044,0.763392857,-0.249088731
+1971,45509.25,864.4396552,492.1293103,1122.318966,10641.2069,420.0086207,263.9224138,1204.077586,4502.905172,339.5,366.9913793,1599.793103,7542.155172,848.4655172,2499.801724,1564.224138,2780.491379,888.1637931,248.612069,2636.181034,5232.198276,264.2068966,98.22413793,438.9310345,6148.775862,289.1724138,91.10344828,2547.37069,4636.974138,1246.034483,479.1810345,2765.318966,3583.422414,435.5775862,175.0517241,1685.681034,2458.887931,768.2241379,303.0431034,1256.5,1158.405172,517.8362069,128.8103448,796.2413793,1236.758621,805.7672414,98.31896552,2859.767241,1094.060345,465.8706897,116,14.63886658,10.64790039,0.68624347,0.928,0.69047619,-0.387725158
+1972,29142.99153,845.1610169,516.940678,1074.898305,26452.13559,680.6101695,692.1355932,1492.330508,14665.72881,544.3474576,705.8644068,1756.228814,21292.99153,1317.516949,3091.322034,3880.084746,7760.533898,1388.70339,384.8898305,2527.29661,14810.59322,548.9661017,539.6016949,794.7033898,17388.00847,414.8898305,151.940678,3266.449153,13659.66949,1634.067797,1002.110169,2806.220339,12090.37288,702.6779661,291.8644068,2013.432203,9667.737288,1112.118644,448.8559322,1325.042373,7548.135593,879.7711864,171.1610169,4974.228814,6562.627119,1359.29661,159.6610169,3226.957627,456.8135593,466.5,118,15.21051105,10.10534956,0.747407212,0.983333333,0.670454545,-1.223560949
+1973,26330.3545,916.3968254,615.962963,1091.555556,23681.03704,697.0846561,593.4656085,1562.756614,12957.58201,583.973545,516.2751323,1763.058201,18999.85185,1330.359788,3136.396825,1798.518519,6668.746032,1385.142857,373.2962963,2538.402116,12664.81481,7566.05291,351.3439153,502.1587302,15305.07937,548.8201058,129.0740741,1551.137566,11928.28571,1548.026455,695.4550265,2846.301587,10325.73545,2892.904762,276.6984127,1440.042328,8373.978836,1021.915344,434.2910053,1331.862434,6529.174603,728.8095238,167.5978836,2810.100529,5743.846561,1337.021164,394.8677249,3319.862434,481.2645503,469.6031746,189,17.32852399,14.05350241,0.585040596,0.969230769,0.75,0.177363876
+1974,28807.62319,891.8985507,503.1449275,1079.304348,24469.46377,712.6956522,734.7246377,1582.985507,14009.44928,561.2898551,552.4202899,1774.710145,19742.85507,1356.014493,2585.507246,1756.884058,7081.478261,1420.550725,360.2463768,2489,13556.21739,4480.15942,290.884058,483.9565217,15684.3913,492.7681159,124.3623188,2669.536232,12516.15942,1525.942029,765.1449275,2806.449275,10995.86957,671.5942029,297.6376812,1809.884058,8578.855072,909.0434783,446,1336.478261,6825.014493,734.5797101,169.9855072,3237.681159,5877.623188,1390,163.7246377,3333.521739,569.5942029,465.3623188,69,12.10164089,7.749937097,0.768038373,0.958333333,0.627272727,-0.567441804
+1975,27111.01923,917.9038462,489.4230769,1078.086538,23456.46154,699.3942308,516.0961538,1509.461538,13280.52885,555.0576923,503.6442308,1725,18677.88462,1324.807692,4258.278846,2147.788462,6493.894231,1251.548077,341.5480769,2400.75,13411.15385,451.8076923,249.8076923,512.4134615,15362.76923,542.9807692,123.5865385,2146.576923,12230.48077,1453,751.8076923,2813.182692,10750.375,631.4326923,274.3653846,1801.076923,8545.692308,899.2403846,424.5576923,1309.846154,6672.634615,673.8173077,164.7307692,4229.942308,5950.394231,1337.5,285.7692308,3235.769231,586.3557692,466.4519231,104,13.19526573,10.22702611,0.63189662,0.936936937,0.619047619,1.276942559
+1976,30646.28832,826.9087591,584.9927007,1093.923358,26583.40146,674.8832117,650.1715328,1602.781022,15373.4781,530.8138686,812.7408759,1808.678832,21712.64234,1271.372263,4034.167883,3607.357664,7808.259124,1286.70438,350.0875912,2472.718978,15481.58394,536.2664234,269.3065693,600.0145985,18603.16058,526.6642336,131.7153285,2550.171533,14453.19708,1608.989051,725.7153285,2788.967153,12397.91606,750.3868613,274.2737226,1844.664234,10124.98175,1189.759124,414.1131387,1307.737226,7720.361314,712.0656934,161.8905109,2554.945255,6666.463504,1365.054745,1954.686131,3197.149635,705.3357664,471.1021898,274,22.98262186,16.45486219,0.698131296,0.835365854,0.691919192,-0.090867851
+1977,8814.285714,738.5833333,467.0714286,1018.607143,9268.928571,612.7380952,516.6547619,1407.464286,4077.369048,484.0238095,680.5833333,1768.238095,7397.952381,1147.809524,6422.083333,3370.27381,2601.095238,1180.202381,372.2261905,2774.904762,5018.654762,415.797619,1756.333333,628.2738095,5929.321429,562.1547619,111.1309524,2318.333333,4493.166667,1715.797619,645.4642857,2774.619048,3929.166667,969.0357143,222.5238095,1772.75,3311.785714,1100.27381,372.2380952,1499.321429,2835.797619,1060.309524,158.2261905,6250.059524,2234.964286,1202.25,632.4166667,3075.190476,744.8690476,465.1428571,84,11.97275174,9.810340716,0.573237923,0.933333333,0.636363636,-0.755606117
+1978,21385.66019,800.8640777,631.5728155,1073.31068,19109.7767,638.3980583,811.1165049,1660.786408,10286.23301,491.2621359,1227.718447,1817.466019,15416.36893,1230.349515,8264.631068,4370.242718,5410.92233,1168.61165,349.5048544,4147.223301,10386.81553,6017.563107,1898.825243,968.4174757,12406.84466,479.4466019,122.3883495,6868.737864,9633.339806,2155.893204,740.9126214,2797.427184,7861.805825,719.7475728,261.2330097,8902.504854,6494.116505,1042.262136,393.1359223,1366.184466,4569.728155,1123.213592,152.1067961,4831.650485,3871.165049,1208.407767,314.3009709,3369.330097,864.2718447,466.7669903,103,14.188272,9.757302687,0.725993108,0.919642857,0.613095238,0.443008458
+1979,21382.78095,706.7904762,511.9238095,1083.238095,17618.91429,563.9142857,454.8857143,1683.314286,8620.352381,432,538.7904762,1783.180952,13668.90476,1058.161905,5524.771429,2651.52381,4888.990476,1095.390476,310.8285714,3172.752381,8837.819048,5959.114286,627.6285714,494.952381,10795.8381,408.2761905,111.7238095,8266.07619,8723.380952,1453.209524,662.5619048,3269.67619,6945.704762,585.247619,238.8285714,13259.81905,5483.838095,762.447619,364.0857143,1322.361905,3273.485714,769.3333333,147.5714286,3830.733333,3067.209524,1051.580952,194.3904762,3149.409524,1008.8,467.5904762,105,13.7326773,10.21365702,0.66845964,0.954545455,0.535714286,-0.701286448
+1980,48582.22642,951.3962264,619.8113208,1129.528302,44318.71698,776.0754717,749.2830189,1697.754717,25579.69811,624.6415094,754.8867925,1776.735849,35194.18868,1418.962264,8635.660377,6147.792453,12585.28302,1479.226415,404.3962264,2670.45283,25326,490.9056604,139.2830189,581.9622642,30079.4717,452.754717,139,6347.660377,23987.49057,1704.698113,898.6415094,2881.754717,21079.84906,667.8679245,323.5849057,2670.679245,16132.92453,987.6037736,491.3396226,1315.660377,11963.37736,679,198.6037736,3382.226415,10593.41509,1464.301887,283.7924528,3354.415094,271.754717,467.5849057,53,12.57679079,5.514231332,0.89875801,0.946428571,0.736111111,0.162581082
+1981,27615.01942,858.4174757,587.368932,1106.592233,26079.14563,670.9320388,731.0582524,1676.592233,14477.8835,535,559.3009709,1799.980583,19680.95146,1265.417476,10687.2233,6291.417476,7352.495146,1310.708738,362.0194175,2405.291262,15538,440.3009709,160.2135922,458.368932,17177.30097,462,127.3203883,11982.25243,13032.49515,1462.359223,998.4174757,2857.873786,11523.37864,600.7475728,291.7087379,2416.271845,9121.737864,947.2912621,444.6990291,1304.339806,7336.097087,646.6699029,182.3300971,8123.728155,6119.368932,1358.640777,196.4951456,3441.873786,304.2912621,467.5728155,103,14.02516882,9.623395932,0.727458315,0.895652174,0.66025641,-0.621347846
+1982,37458.61379,1027.855172,528.2275862,1098.331034,32461.02759,675.3655172,478.0551724,1550.02069,18772.91034,563.0275862,538.5172414,1766.455172,26435.28276,1316.075862,5789.627586,3274.144828,9361.255172,1393.213793,383.5586207,2499.937931,18299.13793,468.4,255.8896552,516.8827586,21753.73103,438.0965517,132.8137931,3838.627586,16870.45517,1640.662069,872.2206897,2816.744828,14645.55862,737.1172414,293.3034483,1695.062069,11946.97931,956.2482759,448.1862069,1306.77931,9096.751724,727.5931034,174.1241379,2222.4,8241.489655,1373.57931,565.6896552,3308.462069,496.1034483,469.2137931,145,16.79476601,12.42739661,0.672654703,0.788043478,0.533088235,-1.069854871
+1983,62516.60135,986.7905405,569.4594595,1198.763514,56029.35811,791.9054054,525.8513514,1919.364865,30640.54054,605.2027027,519.2297297,1814.574324,40775.17568,1417.702703,8689.77027,5746.831081,15897.02703,1524.560811,414.7702703,4016.959459,29585.11486,467.4864865,169.1351351,440.7635135,36213.40541,449.3310811,139.3445946,6143.574324,27491.82432,1567.594595,722.5608108,2830.121622,22499.37162,623.6824324,326.7635135,2406.202703,13703.25676,864.5810811,463.7905405,1305.655405,11194.23649,652.4527027,179.9797297,2405.972973,9263.493243,1386.952703,125.3716216,3324.304054,184.9797297,471.2162162,148,16.53876132,12.44169963,0.658849038,0.886227545,0.578125,-1.040238996
+1984,44625.6,859.2,463.0181818,1118.381818,36585.05455,725.3636364,673.2181818,1638.472727,22424.89091,551.1454545,899.9636364,1808.890909,30976.2,1351.818182,3361.909091,3526.545455,10821,1365.818182,372.7454545,2471.545455,22067.61818,466.9454545,222.1272727,696.3090909,25310.78182,916.7636364,123.1818182,3173.563636,20494.96364,1521.363636,745.5454545,2802.854545,18036.10909,773.5636364,291.1454545,1880,14438.89091,1128.363636,429.7272727,1307.418182,10940.78182,696.0545455,168.5272727,2700.254545,9406.254545,1416.036364,562.6909091,3240.545455,623.7090909,468.3272727,55,11.00890685,6.580261213,0.801703755,0.901639344,0.654761905,-0.096820142
+1985,35345.05,830.1833333,454.6666667,1090.85,30112.76667,692.1666667,813.2,1606.233333,18587.16667,517,642.1333333,1747.933333,24422.85,1264.683333,3535.583333,2507.266667,8747.35,1271.233333,432.95,2462.766667,17772.4,470.45,146.0333333,554.4333333,20917.3,476.6833333,122.15,2273.883333,16726.05,1809,678.5666667,2802.283333,14686.75,670.7333333,281.0166667,1703.516667,11823.18333,1157.033333,421.4166667,1309.916667,8525.983333,654.8666667,160.5166667,2599.216667,7587.35,1349.066667,207.65,3208.95,753.75,467,60,9.704216226,8.455462974,0.490717942,0.923076923,0.6,-0.863622684
+1986,30855.43519,834.9444444,525.2314815,1068.175926,24636.59259,663.3611111,640.462963,1574.981481,13894.9537,491.462963,804.3518519,1715.055556,19262.81481,1192.138889,5721.564815,3626.425926,7039.416667,1212.083333,336.5740741,2441.453704,13739.52778,511.1203704,448.0185185,622.1944444,16634.31481,686.2777778,123.6296296,5219.611111,13169.98148,1627.907407,632.0555556,2808.898148,11222.37037,825.1574074,254.0648148,2337.101852,9262.462963,927.6203704,402.212963,1305.861111,6752.731481,715.3333333,164.1666667,5077.287037,5872.37037,1226.574074,252.5555556,3230.675926,796.6018519,468.1388889,108,12.68072318,10.92324263,0.507918148,0.955752212,0.755244755,1.049171182
+1987,35949.73913,875.9275362,530.6231884,1093.442029,30961.47101,701.826087,777.0652174,1609.818841,17610.57246,547.8768116,1733.84058,1773.826087,25054.84783,1284.028986,6127.050725,3178.492754,9056.326087,1279.971014,387.9347826,2986.202899,17557.16667,482.0507246,1191.615942,1030.471014,21112.98551,542.7681159,186.057971,2614.195652,16450.36957,1944.326087,598.6666667,2812.181159,13640.28261,643.2173913,276.3478261,4078.34058,11363.51449,1382.043478,421.4347826,1361.231884,7971.376812,977.0434783,165.9130435,3299.268116,6803.086957,1294.623188,1058.173913,3255.376812,829.2681159,471.0507246,138,15.80079236,12.22192696,0.633795213,0.8625,0.616071429,-0.028775292
+1988,48706.875,924.3295455,595.2954545,1154.795455,30375.0625,608.7102273,453.8295455,1587.971591,15690.11364,486.8068182,1140.267045,1788.085227,21021.80682,1150.9375,10381.96023,5250.232955,8393.443182,1227.130682,337.1363636,2453.625,16462.61932,380.2784091,120.3920455,578.6875,19345.59659,374.1306818,246.8806818,6939.676136,14890.01705,1630.403409,738.2897727,2858.994318,12807.73295,554.7215909,270.2840909,2919.085227,9274.039773,851.1022727,405.7102273,1292.886364,7488.4375,593.8920455,169.2727273,3598.636364,6095.676136,1203.369318,169.4261364,3280.340909,232.3522727,472.6875,176,20.33676479,12.42631946,0.791609487,0.822429907,0.514619883,-1.047786744
+1989,44332.36986,859.2328767,614.369863,1107.972603,38996.45205,665.2054795,604.0136986,1664.890411,20476.78082,539.109589,864.1780822,1785.630137,28038.9589,1242.739726,10373.49315,6513.493151,10353.05479,1334.794521,360.739726,3618.506849,20771.10959,427.1643836,136.3150685,675.1232877,25427.94521,407.6849315,131.3287671,11675.41096,19289.46575,1753.726027,956.4246575,2835.808219,16397.68493,592.6027397,275.6575342,3533.191781,11981.17808,915.1780822,437.9863014,1339.219178,9667.493151,619.1780822,173.4246575,4938.739726,8062.780822,1291.191781,178.0821918,3298.726027,244.3561644,470.8493151,73,11.70805548,8.383431118,0.698059683,0.948051948,0.623931624,-0.082677793
+1990,29325.87097,928.516129,560.9225806,1116.277419,24372.74839,716.4516129,603.4709677,1619.922581,14403.08387,552.3548387,755.6,1781.16129,19639.34839,1376.903226,4841.16129,3191.741935,7117.916129,1658.483871,379.8387097,2586.780645,13865.50968,521.9032258,434.6774194,713.3290323,16192.44516,485.3677419,142.0709677,4583.741935,12620.91613,1763.987097,767.6322581,2822.116129,11224.43226,666.1870968,295.1354839,2370.387097,8826.658065,1056.135484,463.0064516,1356.76129,6992.883871,745.8645161,183.2645161,5597.916129,6142.16129,1396.174194,168.9032258,3269.567742,535.2516129,471.5806452,155,17.56474548,12.08203693,0.725846024,0.895953757,0.60546875,-0.839945381
+1991,24812.74157,816.5842697,476.3370787,1061.202247,20953.95506,670.2921348,619.0449438,1499.393258,12232.95506,510.2247191,615.9213483,1750.393258,16957.69663,1281.460674,5394.325843,2647.269663,6195.202247,1266.797753,338.9101124,2443.719101,12242.44944,448.494382,379.3932584,667.1797753,14089.35955,399.8988764,118.8539326,3477.685393,11067.41573,1611.247191,781.494382,2786.573034,9681,717.505618,261.9101124,2071.977528,7752.146067,1028.674157,398.7752809,1303.955056,6267.258427,732.8089888,162.7752809,4783.292135,5378.696629,1342.898876,408.6629213,3255.775281,605.1011236,469.0224719,89,13.28741883,8.913617714,0.741609897,0.908163265,0.674242424,0.807747086
+1992,38416.88462,864.7307692,489.8230769,1098.292308,33006.86154,708.8461538,535.2307692,1567.576923,18912.08462,544,1557.392308,1736.753846,27571.30769,1324.530769,4049.238462,3412.169231,9582.269231,1294.853846,370.5615385,2555.569231,19179.55385,464.9076923,176.5076923,945.0923077,22633.75385,517.1153846,186.2538462,2226.630769,17682.67692,1848.730769,608.2923077,2801.276923,15624.66154,685.2230769,283.0846154,1815.084615,12749.73077,1297.284615,427.6461538,1301.315385,9286.676923,641.6230769,162.7307692,2704.184615,7923.423077,1366.653846,616.3076923,3236.630769,759.9538462,472.6692308,130,17.83326397,9.611175581,0.842339983,0.921985816,0.637254902,-0.411392513
+1993,40718.85227,904.3181818,501.2159091,1121.806818,32500.17045,737.3295455,738.5,1616.431818,19279.375,566.7159091,2143.306818,1883.545455,26945.22727,1336.602273,4005.375,5090.909091,9628.795455,1314.284091,368.75,2825.931818,19205.73864,487.4204545,370.1022727,1834.534091,22574.78409,479.0795455,250.7954545,2151.125,17702.06818,2239.204545,730.7386364,2827.556818,15631.63636,634.2840909,288.6136364,1908.443182,12647.90909,1599.431818,436.0340909,1312.272727,9062.534091,705.125,167.7272727,2688.045455,7824.534091,1381.636364,435.8636364,3208.261364,770.4659091,468.7272727,88,12.96422663,9.253606919,0.700369885,0.88,0.727272727,0.581821903
+1994,35353.12088,832.9010989,623.6813187,1123.21978,31049.52747,687.4835165,606.7142857,1673.197802,19296.56044,548.4945055,761.2197802,1812.417582,27794.01099,1337.32967,9275.263736,4288.384615,9707.252747,1296.263736,368.0989011,2482.142857,19187.12088,485.6263736,615.8571429,742.5604396,23025.17582,519.1538462,152.3076923,6114.747253,17752.98901,1802.186813,911.021978,2827.296703,14939.89011,751.7142857,284.4945055,2734.582418,12328.05495,997.978022,420.2637363,1319.89011,8863.450549,801.6923077,168.8241758,4541.395604,7376.406593,1352.483516,1143.989011,3328.428571,812.2527473,469.9120879,91,14.26849768,9.018323156,0.774932227,0.892156863,0.5,1.000412192
+1995,20153.27397,679.3561644,446.5547945,1036.873288,12441.44521,477.5171233,435.1609589,1293.688356,5791.506849,359.130137,833.3253425,1669.133562,9069.308219,890.9452055,4291.835616,1664.804795,3343.215753,944.3116438,261.5547945,3544.195205,5878.695205,727.0376712,1283.544521,673.7226027,7193.671233,326.239726,98.08561644,3299.993151,5610.246575,1445.246575,512.4041096,2799.582192,4451.369863,466.2157534,195.0684932,5378.616438,3403.65411,791.1815068,320.4417808,1303.400685,1895.626712,843.760274,128.9417808,2222.003425,1796.14726,867.8561644,185.2910959,2977.969178,1034.071918,472.1883562,292,23.49114657,15.94366837,0.734406687,0.966887417,0.746803069,-1.269134799
+1996,34110.2766,890.9148936,555.1276596,1091.170213,29623.40426,770.4042553,709.8297872,1616.978723,17717.7234,565.5957447,998.4042553,1887.787234,23618.55319,1309.297872,9966.085106,5679.12766,8581.680851,1337.978723,372.1914894,2411.787234,16224.82979,394.2765957,278.7446809,1015.382979,20989.29787,445.5319149,179.4468085,5389.659574,16297.40426,1856.212766,867.9787234,2801.425532,14052.82979,625.893617,295.893617,1975.957447,10976.17021,952.7446809,454.2978723,1303.106383,8523.808511,673.9148936,192.2553191,6356.638298,7728.06383,1379.787234,392.5531915,3386.361702,325.9148936,469.5531915,47,8.865691882,7.342969401,0.56036541,0.87037037,0.652777778,0.365709532
+1997,37355.63918,879.185567,568.6907216,1131.134021,33221.1134,722.8865979,843.7731959,1631.030928,18398.87629,564.2783505,947.4226804,1795.773196,26250.52577,1361.680412,3058.969072,3164.268041,9238.391753,1446.319588,382.6701031,2608.938144,18503.57732,1171.206186,426.3608247,709.8762887,22359.15464,457.3505155,260.0824742,3944.649485,17193.3299,1897.989691,814.0721649,2828.309278,15036.59794,822.1752577,309.0206186,1663.453608,12146.17526,1230.453608,466.1649485,1320.309278,9379.42268,751.6185567,179.7319588,5298.092784,8242.134021,1411.907216,233.2268041,3349.134021,467.9175258,470.2989691,97,13.34829115,9.82714766,0.676752975,0.923809524,0.746153846,-1.302137591
+1998,30190.16129,974.1505376,517.5376344,1083.774194,25949.24731,744.4193548,668.7311828,1552.634409,15199.21505,579.3225806,440.0430108,1751.053763,21192.5914,1402.387097,3680.860215,2400.032258,7095.903226,1333.645161,358.6129032,2408.075269,12756.29032,860,402.688172,472.2903226,15001.74194,421.344086,122.5591398,2468.430108,11920.80645,1461.623656,714.9892473,2821.010753,10566.41935,616.172043,285.6989247,1910.408602,8363.505376,866.1075269,438.8494624,1319.27957,6677.924731,731.6129032,173.516129,3482.591398,5889.129032,1369.602151,186.0537634,3264.580645,575.2365591,471.0752688,93,13.03601979,9.580493484,0.678148674,0.920792079,0.510989011,-0.665739174
+1999,24428.53623,770.0434783,582.0434783,1074.536232,20757.01449,607.826087,769.3333333,1693.275362,11028.24638,472.9565217,502.3913043,1812.956522,15955.73913,1155.57971,11135.63768,4135.565217,5663.086957,1160.84058,330.2608696,2609.449275,11011,2070.202899,147.6666667,488.2608696,13109.26087,446.4202899,125.4927536,13785.37681,10599.56522,1379.478261,911.9710145,2793.15942,8876.985507,642.9275362,259.115942,13764.52174,7218.014493,827.7971014,398.2608696,1299.536232,4873.15942,607.1449275,154.8405797,4147.753623,4359.202899,1162.695652,192.8985507,3326.971014,903.8405797,468.8985507,69,10.46406421,8.414369665,0.594466189,0.958333333,0.766666667,0.909383046
+2000,40183.60256,884.6089744,543.3461538,1106.532051,33771.86538,733.1858974,648.2628205,1576.403846,19881.35256,572.1730769,584.2435897,1770.378205,27330.60897,1382.141026,3546.711538,3316.641026,9535.833333,1557.673077,385.1282051,2445.192308,18833.48718,504.4230769,295.9615385,532.0769231,22288.27564,443.3910256,153.0128205,3428.852564,17592.78846,1627.596154,917.9615385,2823.576923,15605.03846,652.0128205,303.2628205,2231.192308,12222.36538,988.974359,469.1602564,1341.25641,9453.147436,730.7051282,179.9679487,5316.615385,8395.192308,1427.397436,143.5128205,3199.942308,546.6538462,473.7692308,156,19.23908068,10.71836815,0.830435782,0.906976744,0.509803922,-0.757582046
+2001,29819.20988,822.9135802,479.7283951,1071.617284,26597.98765,698.9382716,617.0864198,1551.358025,14809.58025,524.7160494,1298.37037,1797.790123,21781.62963,1325.320988,6246.728395,4329.222222,7638.777778,1275.987654,345.5185185,2589.098765,15157.14815,446.6419753,310.6049383,814.5555556,17805,446.3333333,122.1728395,4338.037037,13675.87654,1813.160494,919.7283951,2790.320988,11861.95062,703.617284,269.5555556,2443.851852,9584.654321,1390,401.5185185,1297.790123,7637.246914,717.3950617,162.5802469,5301.382716,6572.012346,1363.728395,485.0493827,3172.481481,615.1358025,470.7407407,81,12.61395889,8.928328459,0.706399509,0.852631579,0.613636364,-0.717959387
+2002,44222.52174,821.7608696,507.2608696,1083.630435,36389.56522,711.6086957,744,1587.434783,21896.3913,524.6086957,1157.347826,1784.23913,30636.71739,1285.5,4933.108696,3272.913043,10874.52174,1285.304348,452.6521739,2588.456522,21638,463.8478261,880.2391304,1325.304348,25886.1087,396.2173913,136.5434783,4056.347826,20774.06522,2160.978261,797.9347826,2786,17383.82609,617.6521739,278.3478261,2237.021739,14354.71739,1078.717391,425.5652174,1331.608696,9881.586957,852.6304348,163.7173913,3601.978261,8765.021739,1301.369565,591.2173913,3268.76087,820.7608696,469.2608696,46,10.34751863,6.963497313,0.739676134,0.807017544,0.511111111,-0.132961873
+2003,23104.50838,743.3519553,516.8435754,1073.413408,19940.56425,602.0837989,482.8715084,1675.324022,10376.37989,459.1117318,594.698324,1754.564246,15228.62011,1123.659218,5778.519553,3674.407821,5632.664804,1159.424581,328.0558659,2922.324022,10737.4581,3319.022346,1303.22905,494.9832402,12627.17318,432.1396648,118.9888268,6023.536313,10291.48603,1504.26257,743.0558659,2801.547486,8331.128492,590.8324022,257.7094972,11311.77654,6867.486034,805.2346369,382.972067,1323.469274,4624.251397,951.122905,153.8994413,4023.324022,4101.916201,1157.899441,191.5363128,3214.26257,948.0446927,472.2402235,179,17.61561105,13.28576334,0.656640244,0.957219251,0.662962963,-1.461076067
+2004,27841.10938,780.953125,500.625,1100.96875,24380.90625,626.5,772.359375,1726.984375,12460.48438,471.578125,530.359375,1756.9375,18668.01563,1170.5,4918.515625,2784.234375,6767.125,1170.59375,340.265625,2704.1875,12682.4375,6576.484375,156.75,486.1875,15001.15625,468.796875,119.390625,6843.5625,12275.0625,1473.609375,650.21875,2806.75,9823.6875,695.75,256.78125,10826.51563,8004.109375,789.03125,402.8125,1293.75,5296.65625,646.25,147.09375,2724,4713.53125,1168.90625,143.25,3295.578125,961,470.84375,64,12.2355773,7.409454978,0.795794752,0.820512821,0.533333333,0.332480148
+2005,27079.67568,969.6666667,573.2882883,1108.189189,24458.11712,759.0540541,845.8738739,1567.36036,13007,574.3603604,1667.774775,1795.108108,18252.81982,1390.855856,4565.513514,3732.927928,6621.108108,1383.594595,377.027027,2892.576577,12438.25225,1153.189189,704.2792793,1438.711712,14177.1982,485.8198198,195.6306306,3663.783784,10797.82883,2294,816.5225225,2825.540541,9622.234234,817.6756757,296.5405405,1662.297297,7676.36036,1460.135135,475.0540541,1448.648649,6099.387387,824.5585586,184.5135135,7498,5118.081081,1430.414414,525.6936937,3220.234234,423.7927928,472.6486486,111,14.65943394,10.06408078,0.727105368,0.932773109,0.711538462,-0.960849058
+2006,16558.91765,756.6352941,460.8588235,1040.670588,14887.43529,634.6588235,535.5529412,1444.976471,7816.258824,519.9529412,943.8352941,1810.482353,12336.31765,1202.917647,5607.623529,3632.411765,4312.458824,1343.505882,302.9176471,2503.858824,8478.694118,488.8235294,1002.541176,742.4705882,9830.447059,812.0941176,117.8588235,2237.505882,7598.505882,1727.717647,819.2,2794.058824,6658.047059,928.6941176,237.0705882,1744.211765,5509.011765,1154.811765,372.4823529,1287.388235,4512.552941,877.2,145.1764706,3278.482353,3724.435294,1228.105882,1023.752941,3136.317647,630.0352941,472.4470588,85,15.22993134,8.54240315,0.827886467,0.745614035,0.467032967,-0.449150235
+2007,25891.40217,790.9673913,515.3695652,1090.597826,23512.56522,664.5217391,1087.184783,1619.532609,12530.5,502.8586957,2199.184783,1812.326087,17959.23913,1209.108696,7938.608696,2867.967391,6563.217391,1185.967391,335.0978261,4520.978261,12916.68478,1570.445652,500.6956522,1893.01087,15930.17391,434.7826087,121.7065217,4167.456522,12252.03261,2301.695652,604.0652174,2815.5,10285.54348,712.9130435,265.1847826,6633.576087,8633.554348,1200.217391,402.3913043,1339.076087,5941.826087,741.3152174,156.4456522,3672.26087,5240.48913,1232.445652,478.8695652,3312.108696,857.2717391,473.1086957,92,12.14061994,11.01461727,0.420584694,0.867924528,0.505494505,-1.381418264
+2008,14293.30952,639.9166667,503.4404762,1010.583333,9233.392857,485.297619,516.3452381,1417.511905,4621.083333,389.6785714,900.702381,1710.392857,7664.488095,965.3333333,7902.654762,3536.892857,2775.833333,988.702381,268.2619048,5406.369048,5026.047619,599.0357143,180,673.5714286,6052.369048,344.3928571,104.4404762,12076.40476,5060.357143,1626.880952,648.1785714,2782.178571,4096.47619,502.3333333,209.047619,10780.71429,3240.642857,819.3928571,335.9642857,1316.630952,1947.654762,696.1190476,133.202381,3355.214286,1924.178571,957.0357143,228.7738095,3021.464286,1017.238095,472.1904762,84,12.03965777,9.020456548,0.662311429,0.965517241,0.636363636,-0.992395686
+2009,55731.88345,955.8275058,544.5897436,1167.340326,18868.36597,490.5827506,251.0839161,1367.972028,7701.668998,373.4522145,325.4498834,1617.219114,13211.02331,946.5897436,4470.39627,1967.629371,4846.801865,980.6223776,273.5058275,2377.310023,8874.25641,331.9417249,90.13752914,389.6550117,10528.54312,356.0932401,101.2144522,3318.34965,8034.249417,1164.543124,476.1002331,2801.748252,6228.365967,467.3613054,196.2773893,1415.321678,4174.993007,619.020979,320.5081585,1255.386946,1968.818182,497.8671329,127.6689977,870.6410256,2121.634033,877.1375291,100.4731935,2967.431235,1100.104895,480.3473193,429,26.77399406,21.06451446,0.617268217,0.926565875,0.696428571,-0.359667298
+2010,39204.2967,1008.395604,523.3516484,1152.21978,34547.87912,832.2857143,634.1428571,1799.263736,19605.69231,609.2637363,681.2747253,1812.274725,27841.25275,1464.296703,4488.615385,3268.912088,9754.087912,1499.923077,408.8021978,2487.824176,19572.73626,551.6043956,298.8021978,564.6923077,22819.04396,647.4505495,155.021978,3131.43956,17405.24176,2320.967033,804.978022,2830.296703,15494.89011,690.0879121,333.5274725,2018.076923,12394.96703,1138.043956,512.2417582,1322.131868,9546.417582,891.2747253,193.8351648,4553.604396,8412.989011,1542.054945,238.3516484,3300.846154,435.4065934,473.1428571,91,14.07559964,9.03499573,0.766796192,0.875,0.541666667,-1.232765327
+2011,18952.78333,988.4666667,542.2166667,1033.416667,16415.25,666.9,432.8833333,1378.866667,9124.15,554.45,609.2333333,1762.533333,13136.25,1280.666667,2872.533333,2102.083333,4721.966667,1324.416667,336.5333333,2755.933333,8630.716667,379.8166667,201.2666667,524.4333333,10314.88333,389.65,124.1833333,2013.033333,7794.766667,1608.4,695.05,2789.866667,6831.15,708.3833333,236.85,1387.216667,5455.016667,845.45,406.7,1356.733333,4712.416667,629.5666667,157.2,3333.283333,4180.933333,1240,145.65,3342.133333,517.75,471.2333333,60,11.88075924,7.167736658,0.797509582,0.895522388,0.625,1.41533001
+2012,20625,796.7103448,680.1931034,1083.551724,18499.22759,647.0137931,564.4758621,1554.4,10369.52414,502.6827586,516.7862069,1740.903448,15659.53793,1241.386207,4982.006897,3271.972414,5473.731034,1230.8,344.4137931,2416.131034,10719.28276,609.3103448,152.462069,474.7655172,12996.48276,438.6068966,116.3931034,3896.151724,9957.682759,1407.206897,611.1103448,2781.151724,8614.6,1294.282759,248.0689655,1921.675862,7180.944828,896.9103448,394.8137931,1295.158621,5540.137931,658.4206897,158.2482759,5113.096552,4808.089655,1326.241379,2627.462069,3238.862069,718.8896552,474.2413793,145,15.52960934,12.0192685,0.633236689,0.973154362,0.69047619,1.176466883
+2013,31545.5812,841.8376068,498.6581197,1085.008547,27343.63248,695.5982906,523.4102564,1581.649573,16409.07692,540.7264957,742.6495726,1796.478632,22693.15385,1350.358974,8018.435897,3929.965812,8041.017094,1298.735043,352.5470085,2422.470085,16235.00855,490.8034188,129.034188,863.3931624,19535.44444,427.3675214,166.1196581,4446.410256,14841.23077,1710.803419,775.965812,2792.931624,12983.42735,733.0769231,283.2393162,2246.358974,10332.99145,919.1880342,415.7264957,1301.444444,7993.846154,647.0598291,162.3931624,5010.418803,6829.923077,1382.059829,739.1025641,3205.470085,651.6581197,475.025641,117,18.80992953,9.28181398,0.869772528,0.8125,0.541666667,1.453213897
+2014,35947.50962,891.3653846,482.2307692,1109.634615,30390.26923,692.0384615,705.6923077,1602.230769,18004.52885,531.0576923,798.625,1772.028846,25106.58654,1312.778846,5309.451923,3372.769231,8863.355769,1309.144231,352.3942308,2498.192308,17975.69231,482.5288462,131.3942308,1135.259615,21371.76923,510.6346154,124.1442308,3102.884615,16352.65385,1702.413462,730.1826923,2809.471154,14323.97115,653.8269231,283.8942308,1828.894231,11356.05769,1307.615385,412.2211538,1301.538462,8678.134615,640.1634615,161.875,3539.538462,7479.586538,1354.740385,282.2211538,3225.480769,669.7115385,476.2884615,104,16.72461617,8.214051742,0.871083221,0.912280702,0.65,0.24748617
+2015,30693.65432,892.8518519,492.5925926,1073.876543,26884.97531,658.9753086,836.7530864,1518.049383,14838.96296,524.2469136,1489.938272,1835.82716,21865.45679,1245.901235,6789.987654,4050.444444,7719.654321,1285.049383,333.5185185,2615.54321,15583.34568,700.4074074,136.6296296,2188.814815,18926.45679,438.037037,125.7777778,2896.148148,13990.46914,2417.802469,749.4938272,2798.061728,12045.04938,633.6790123,256.654321,1736.481481,9844.259259,1705.493827,395.3950617,1300.012346,7807.037037,622.3333333,157.7160494,3318.802469,6589.851852,1302.111111,321.8024691,3189.777778,677.5185185,475.5802469,81,15.13377836,8.737374553,0.816502022,0.723214286,0.490909091,0.295932632
+2016,29184.76471,828.2352941,610.1617647,1089.5,25403,681.3088235,643.9411765,1587.102941,14567.64706,534.5,429.1470588,1763.779412,20568.89706,1256.382353,6328.338235,3401.588235,7496.102941,1273.470588,341.1029412,2413.808824,15008.73529,476.8676471,816.7352941,470.4264706,18031.82353,440.6323529,122.75,3710.058824,13801.92647,1503.294118,773.2352941,2792.941176,11906.54412,800.2352941,263.3823529,2609.191176,9711.426471,860.6029412,404.6617647,1303.220588,7436.338235,922.8970588,161.2941176,4920.073529,6500.029412,1325.808824,167.3235294,3297.161765,693.5,473.1176471,68,12.44187578,8.347703652,0.741515168,0.829268293,0.566666667,0.45141803
+2017,27318.0339,762.5423729,643.5762712,1099.838983,23140.27119,623.9152542,607.0847458,1709.762712,12367.30508,467.1525424,567.5762712,1787.70339,18278.68644,1144.745763,6384.008475,3284.440678,6560.101695,1190.991525,331.1440678,3104.364407,12819.52542,4529.864407,699.4661017,467.8983051,14821.61864,428.3813559,117.8728814,5238.508475,12251.66102,1469.237288,772.7711864,2798.567797,10154.05932,575.7881356,256.4661017,8496.466102,8276.262712,912.7372881,395.0338983,1318,5731.779661,750.0423729,152.9745763,3524.508475,5014.661017,1192.372881,190.0423729,3290.101695,916.5338983,473.2457627,118,16.13230273,9.416068135,0.811985309,0.967213115,0.694117647,-1.416242588
+2018,20184.32407,690.1203704,483.1944444,1053.101852,16997.41667,569.462963,645.9722222,1550.87037,8765.342593,434.9074074,1145.888889,1780.805556,12864.75,1071.259259,7541.574074,4122.842593,4856.046296,1093.157407,310.6944444,4372.75,8967.388889,1900.611111,230.2314815,895.1851852,10790.83333,395.3333333,110.3240741,5309.87963,8864.453704,1714.62037,650.9166667,2790.212963,7133.361111,612.0462963,234.6574074,11179.13889,5783.592593,993.8518519,371.3888889,1328.268519,3626.435185,623.6203704,154.4537037,4761.648148,3379.62037,1088.305556,275.2685185,3166.712963,981.712963,474.8055556,108,12.34879263,11.81143785,0.291780722,0.87804878,0.593406593,0.068363451
+2019,55092.61538,940.8791209,603.3076923,1181.43956,43752.27473,721.6703297,416.2747253,1813.296703,22443.32967,557.3516484,656.8571429,1803.593407,30650.10989,1306.571429,11100.36264,6485.67033,11959.71429,1418.67033,385.2307692,2482.78022,22828.32967,432.4505495,133.2527473,501.8131868,27214.3956,584.7142857,138.7912088,9075.054945,21344.92308,1521.087912,728.2307692,2828.362637,17883.26374,616.8351648,317.7362637,4764.868132,11781.58242,853.7692308,442.978022,1315.131868,9421.615385,640.5384615,183.8791209,3885.659341,7860.120879,1332.571429,154.9120879,3333.824176,203.2857143,474.6813187,91,12.92270234,9.037539099,0.714775816,0.968085106,0.7,-1.111881795
+2020,25805.79381,1221.061856,551.4329897,1049.154639,25584.70103,773.2061856,432.1237113,1389.381443,15480.85567,656.4845361,486.1752577,1747.649485,21081.39175,1405.958763,4363.268041,2182.226804,6978.56701,1367.391753,369.1237113,2370.515464,12708.86598,419.3917526,367.9381443,406.3505155,15768.93814,389.7216495,125.4845361,3464.979381,12005.47423,1465.154639,650.2061856,2799.680412,10508.68041,599.5876289,267.4020619,1225.268041,8043.360825,798.8969072,413.4639175,1297.371134,6364.690722,665.814433,164.9690722,1717.443299,5753.989691,1257.597938,120.7319588,3647.804124,372.5979381,476.3505155,97,13.2101271,10.17334781,0.637902264,0.866071429,0.532967033,-1.023358666
+2021,28345.96154,964.0512821,531.8076923,1094.782051,23732.51282,763.6153846,687.3076923,1567.858974,14282.24359,582.3589744,499.6923077,1726.179487,19507.67949,1399.320513,5293.461538,2031.282051,6604.525641,1455.74359,367.7820513,2442.012821,13580.51282,648.2179487,412.9487179,494.2948718,16180.78205,466.8076923,129.4871795,2851.641026,12931.16667,2248.538462,770.1410256,2819.461538,11381.24359,662.6410256,295.5384615,1489.935897,8869.435897,925.2692308,451.3205128,1331.75641,6825.051282,906.7820513,176.7179487,4572.833333,6167.551282,1501.628205,173.0641026,3312.794872,558.6923077,474.3205128,78,11.30226695,8.931236195,0.612827963,0.962962963,0.709090909,-0.954568593
+2022,24193.29167,771.53125,472.125,1075.947917,20487.45833,622.7604167,514.2604167,1526.21875,11286.78125,499.1666667,606.5833333,1747.385417,15735.20833,1191.71875,6396.052083,2908.65625,5727.604167,1284.020833,346.4895833,2622.770833,11287.10417,505.0625,670.96875,571.59375,13244.51042,395.34375,116.875,2416.927083,10374.08333,2031.625,718.1666667,2790.239583,9159.104167,647.625,250.3541667,1871.958333,7343.1875,1115.208333,382.2604167,1291.84375,5764.59375,782.8645833,151.3229167,3312.5,4911.322917,1247.333333,496.3125,3157.052083,637.4270833,475.9270833,96,12.39133586,9.939047068,0.597194451,0.96969697,0.671328671,-0.350705859
+2023,37445.07965,844.3982301,581.3982301,1100.814159,31952.79646,688.6283186,511.1681416,1601.619469,18786.89381,538.2123894,440.539823,1749.362832,26180.26549,1296.132743,5321.672566,3803.283186,9493.769912,1300.584071,354,2414.00885,18968.74336,483.6637168,453.0619469,533.3097345,22849.34513,410.460177,122.4424779,5255.371681,17533.35398,1513.575221,1069.327434,2811.168142,15377.46018,679.8495575,276.8495575,2277.079646,12412.23009,885.2035398,419.5221239,1300,9261.893805,742.0973451,166.8141593,3374.451327,8096.548673,1359.699115,197.4070796,3269.831858,686.8584071,476.8495575,113,17.99497701,8.185494692,0.890554457,0.926229508,0.579487179,0.577471981
+2024,28391.42143,794.6642857,463.7214286,1063.75,24818.99286,665.0214286,582.4,1527.014286,14336.89286,515.35,940.7357143,1782.592857,19928.12857,1236.078571,4077.785714,2553.142857,7027.214286,1239.421429,351.4,2726.885714,14039.20714,558.4214286,617.0857143,510.5285714,16700.38571,401.1214286,119.7857143,1752.1,13075.07857,1738.221429,578.7642857,2818.378571,11445.27143,733.5857143,264.3928571,1678.621429,9354.214286,1120.435714,402.4357143,1367.9,6994.15,783.3571429,155.5785714,3241.857143,6091.928571,1296.692857,302.3285714,3168.728571,739.0857143,478.2928571,140,16.59457072,11.01889926,0.747726991,0.95890411,0.648148148,-0.352504472
+2025,15492.17949,756.3974359,481.5,1033.782051,16065.19231,637.3974359,522.1923077,1473.628205,6542.525641,469.1923077,923.5769231,1743.5,10273.75641,1138.24359,6223.564103,4429.846154,3803.884615,1210.641026,330.2435897,2897.628205,7179.705128,418.1794872,813.6153846,558.474359,8742.923077,397.7564103,112.6794872,3392.102564,6217.794872,1792.679487,672.2692308,2788.910256,5471.089744,793.0128205,235.8461538,2084.615385,4719.064103,993.3461538,380.4615385,1446.820513,3865.269231,794.4871795,156.7820513,5410.102564,2991.5,1207.064103,309.4358974,3115.487179,748.6025641,476.3717949,78,14.78323935,7.096328105,0.877254674,0.951219512,0.65,-0.176171628
+2026,36052.24051,861.8734177,528.0759494,1094.177215,27223.40506,629.5696203,455.1012658,1559.708861,16423.1519,504.2405063,621.5063291,1737.177215,23122,1212.126582,6261.506329,4215.481013,8012.164557,1225.405063,346.0759494,2454.240506,15965.78481,1588.683544,244.2278481,681.7468354,18905.65823,406.4303797,128.8481013,5116.177215,15058,1528.455696,688.3164557,2798.835443,12932.93671,1283.683544,257.8227848,2080.987342,10537.86076,952.6075949,404.7721519,1287.227848,7466.227848,638.8481013,157.0632911,4595.734177,6520.21519,1247.21519,225.1265823,3234.075949,786.4683544,475.0126582,79,11.54683533,9.379150426,0.583281319,0.908045977,0.548611111,-0.45540697
+2027,45668.30457,938.4670051,539.2538071,1145.248731,41925.40102,764.1675127,674.1624365,1760.060914,23879.76142,598.3401015,640.6903553,1807.812183,32284.9797,1385.522843,7792.873096,4745.604061,11706.48223,1463.441624,404.5736041,2427.045685,23612.08122,498.7664975,148.964467,541.4416244,28436.75127,470.284264,154.3401015,4834.451777,21921.85787,1617,986.0913706,2844.350254,19355.47716,641.893401,329.6700508,2124.548223,15072.44162,943.3756345,485.213198,1300.634518,11782.79188,677.4619289,189.3807107,4591.340102,10050.48731,1479.80203,142.6751269,3381.974619,291.9187817,479.7614213,197,19.97938578,13.59496646,0.732794819,0.86784141,0.609907121,-0.407778486
+2028,33111.69333,895.1066667,561.9066667,1112.506667,27973.72,706.1866667,650.2133333,1582.186667,15972.28,563.4266667,771.24,1801.346667,22808.72,1374.92,3046.506667,2540.066667,7955.28,1618.306667,378.4666667,2582.906667,15985.70667,474.7866667,646.4533333,777.04,19277.90667,455.8666667,136.9733333,4004.333333,14610.38667,1728.573333,718.1733333,2825.32,12821.17333,817.0933333,313.7333333,1567.986667,10136.94667,949.12,484.12,1398.08,8479.32,827.68,186.2266667,4733.906667,7722.52,1418.68,176.2533333,3298.413333,510.1866667,476.5066667,75,12.08472633,8.806881814,0.684767737,0.872093023,0.576923077,-0.075342521
+2029,24861.92308,920.1428571,599.2600733,1072.875458,21388.56777,697.2197802,683.8461538,1547.117216,12092.75458,531.8864469,791.3699634,1792.307692,17077.68864,1307.747253,2153.527473,1504.787546,5954.399267,1293.641026,332.7216117,2393.923077,12178.49817,461.3186813,407.5677656,605.6410256,13942.69231,418.3150183,204.4542125,1278.630037,11009.82418,1563.190476,703.4432234,2845.908425,9659.168498,638.2124542,269.4615385,1720.666667,7640.92674,914.7985348,409.3663004,1313.725275,6066.871795,685.010989,159.2490842,3438.567766,5275.43956,1320.307692,814.6630037,3189.747253,597.1391941,479.6776557,273,19.90721773,18.92111457,0.310831465,0.900990099,0.590909091,0.846067919
+2030,20480.0963,679.9259259,426.2592593,1023.644444,17831.74815,571.2222222,985.8222222,1443.881481,9452.162963,451.1111111,1684.422222,1763.481481,13718.18519,1070.244444,8138.177778,4237.355556,5050.022222,1108.703704,307.6,7062.77037,9626.814815,620.9037037,156.6592593,1074.037037,11360.13333,402.6074074,110.4296296,3871.525926,9198.792593,2082.148148,599.9185185,2807.244444,7832.888889,602.3111111,237.1407407,2637.081481,6356.103704,1404.348148,372.2444444,1283.903704,4406.851852,580.5925926,147.3333333,3827.451852,3797.696296,1093.474074,282.0444444,3146.066667,893.9777778,478.362963,135,17.61564984,10.17708728,0.816228023,0.906040268,0.649038462,0.402002094
+2031,23027.28,682.57,455.43,1018.15,20161.3,564.83,769.12,1486.59,10414.57,436.24,1741.84,1765.69,15619.15,1087.11,8278.76,4095.33,5663.54,1116,313.96,5623.25,11075.34,1005.09,134.71,917.78,13049.3,399.9,116.88,5512.84,10467.12,1955.39,645.9,2790.14,8889.6,549.67,229.15,7143.28,7217.67,1066.02,371.92,1301.36,5093.71,581.21,148.86,3432.82,4413.02,1104.98,399.68,3184.38,903.73,478.09,100,14.92797595,10.43932633,0.714815676,0.819672131,0.510204082,0.727318278
+2032,41740.0838,895.6424581,520.1173184,1114.871508,10733.48045,406.5810056,202.972067,1180.167598,4009.083799,332.1620112,202.4413408,1581.905028,7596.463687,835.5027933,3235.067039,1504.173184,2736.798883,872.4022346,242.8603352,2287.184358,4955.944134,249.972067,327.5642458,366.5418994,5781.553073,257.0558659,94.48044693,2740.357542,4471.351955,1077.614525,447.1173184,2758.865922,3453.49162,433.7597765,178.9888268,1112.519553,2212.513966,534.3463687,298.5083799,1248.03352,1058.547486,532.8882682,119.6312849,941.0893855,1180.905028,801.2625698,155.0726257,2882.73743,1115.27933,480,179,20.52375739,11.55442061,0.826471991,0.937172775,0.745833333,-0.075782203
+2033,35421.63158,909.8355263,526.6546053,1092.707237,32290.15132,713.4736842,552.8848684,1606.6875,18106.42763,561.6480263,699.6118421,1785.542763,24543.44737,1304.769737,5361.388158,4236.023026,8903.789474,1375.651316,371.8026316,2396.720395,17862.00987,745.6677632,202.3157895,534.1875,21261.88816,437.6348684,132.1019737,4521.309211,16466.28289,1560.904605,773.7105263,2812.25,14364.89145,676.1644737,298.7927632,2019.394737,11176.39803,999.7335526,453.2861842,1315.888158,8747.319079,671.5493421,179.2434211,5394.052632,7608.766447,1408.694079,338.5690789,3347.345395,335.6480263,480.9539474,304,24.32878023,17.49404813,0.694939684,0.856338028,0.608,-1.038147794
+2034,25820.09091,1034.409091,577.0454545,1075.227273,21919.31818,751.9318182,744.3863636,1501.5,12500.81818,581.2272727,1103.886364,1770.659091,16864.84091,1346.25,4557.75,3206.863636,6157.113636,1319.431818,340.9772727,2422.295455,11421.52273,452.6590909,739.2727273,1084.227273,12722.77273,794.1136364,121.0681818,2251.909091,10166.27273,1431.5,685.0909091,2821.954545,8904.931818,582.7727273,272.2954545,1607.75,6996.681818,1193.772727,412.3409091,1339.477273,5478.818182,801.9772727,162.7954545,4262.568182,4626.068182,1301.477273,194.5681818,3254.727273,581.6818182,475.3409091,44,10.03777866,5.857398342,0.812087763,0.916666667,0.55,-1.010936489
+2035,37684.15888,851.046729,514.3925234,1088.962617,31166.57944,720.0841121,541.046729,1655.439252,18199.13084,530.5794393,1258.018692,1824.411215,25763.07477,1272.71028,4986.28972,3962.457944,9242.392523,1289.242991,364.5233645,2431.401869,18014.43925,519.1028037,582.4859813,910.1214953,21608.81308,452.8691589,340.953271,3424.607477,17081.46729,1838.46729,644.7009346,2811.149533,14325.63551,777.1682243,275.6074766,2236.700935,11693.94393,1150.934579,426.9719626,1310.719626,8397.327103,778.728972,165.8878505,4801.383178,7185.065421,1314.065421,487.2149533,3182.53271,808.1775701,476.953271,107,17.65560329,8.575233478,0.874128497,0.856,0.629411765,1.380475588
+2036,30029.76923,818.2747253,949.043956,1156.758242,24037.71429,657.3626374,1091.043956,1836.549451,13099.81868,492.6813187,1176.807692,1821.318681,18964.58242,1229.846154,5561.582418,3487.868132,6809.478022,1249.483516,348.3241758,5478.296703,13521.28022,601.967033,389.0054945,774.8736264,15730.46703,423.4725275,122.6208791,3668.472527,13211.32418,1789.340659,614.0714286,2825.89011,10870.14835,580.3791209,260.6098901,3581,8824.873626,1207.895604,411.0934066,1320.203297,6119.351648,675.0164835,161.7967033,2624.923077,5436.587912,1236.065934,172.3021978,3256.445055,925.8241758,480.0604396,182,19.14390011,12.80074663,0.743568931,0.892156863,0.532163743,-0.79842365
+2037,21455.65,675.4833333,454.4333333,1057.6,18546.01667,563.2916667,479.4666667,1566.775,9488.258333,430.3083333,504.2,1717.125,14540.4,1058.516667,5139.525,2680.516667,5224.916667,1092.508333,308.1,2848,9843.441667,6935.183333,150.1916667,473.9416667,11732.50833,417.7833333,115.525,6277.266667,9701.441667,1434.366667,691.4,2798.658333,7888.375,785.25,229.4333333,8716.508333,6472.975,759.05,363.0166667,1300.366667,4178.383333,610.0083333,140.5166667,3911.675,3786.458333,1084.15,146.7583333,3130.875,969.5916667,477.3083333,120,14.54220904,10.7611307,0.672614736,0.930232558,0.714285714,-1.125583554
+2038,22218.48864,1175.920455,683.8068182,1090.727273,20729.14773,751.1363636,554.2272727,1494.227273,10480.20455,623.1022727,807.2613636,1797.875,14212.94318,1290.761364,10539.06818,5345.125,5177.761364,1265,344.125,2482.397727,10462.84091,396.8977273,148.8636364,519.5113636,11341,447.6477273,134.5113636,9066.852273,8319.75,1553.647727,994.4659091,2797.647727,7362.227273,550.3636364,249.0795455,1988.386364,5645.215909,986.1136364,403.3409091,1301.511364,4964.386364,588.8863636,163.25,5098.045455,3546.068182,1162.068182,152.0681818,3601.818182,305.7159091,478.2840909,88,14.94180662,8.820211679,0.807180843,0.80733945,0.5,-1.565924322
+2039,24424.25714,945.2571429,483.7714286,1042.133333,22241.2381,688.9238095,465.8761905,1445.07619,11228.39048,555.8857143,428.8380952,1741.066667,15628.17143,1271.342857,2751.257143,1932.342857,5707.666667,1314.047619,357.4285714,2397.752381,9760.619048,404.2761905,621.2095238,447.2190476,11903.71429,380.4857143,119.7428571,2383.790476,9291.428571,1420.904762,707.8380952,2804.657143,8126.333333,668.3904762,262.247619,1596.714286,6343.67619,774.0666667,422.3238095,1355.961905,5058.971429,710.5238095,170.3714286,4548.580952,4435.828571,1302.342857,671.7714286,3172.209524,352.447619,477.8095238,105,13.7574895,11.09665062,0.591111585,0.846774194,0.621301775,-1.473294964
+2040,20800.3253,1246.975904,552.8072289,1053.289157,18792.15663,746.7590361,595.1084337,1428.891566,9984.445783,605.9879518,686.3012048,1781.795181,13547.84337,1299.650602,4693.26506,2211.795181,4864.445783,1392.73494,366.2891566,2406.409639,10377.81928,1235.891566,1603.13253,528.6746988,11633.31325,424.2409639,152.1686747,2908.722892,8894.638554,2476.108434,722.7951807,2797.73494,7880.746988,931.0843373,268.0843373,1370.180723,6174.445783,855.5421687,423.3373494,1345.012048,4982.843373,964.8915663,169.4698795,3281.168675,4340.674699,1259.373494,160.2650602,3518.180723,395.7108434,477.5783133,83,11.28130866,9.590143976,0.526635106,0.943181818,0.691666667,1.345446557
+2041,26691.31707,1307.963415,646.2804878,1250.97561,23973.69512,1022.402439,647.5365854,2088.731707,13078.36585,720.9878049,692.8536585,1790.792683,18582.95122,1689,6225.170732,3109.47561,6778.414634,1653.987805,459.7317073,2448.182927,13769.7439,632.6707317,310.4268293,752.5487805,15565.91463,511.1585366,181.5,3244.231707,11898.92683,4750.243902,808.0487805,2870.231707,10666.85366,772.9146341,400.1463415,1652.585366,8476.902439,1397.890244,565.7926829,1346.121951,6744.829268,1141.695122,225.1463415,2959.646341,5998.97561,1727.268293,382.902439,3398.390244,438.7804878,480.0731707,82,15.61040145,7.159861156,0.888612025,0.88172043,0.485207101,-0.765359394
+2042,37025.47674,1033.290698,579.5232558,1132.988372,31290.89535,768.4302326,662.0581395,1533.604651,18157.15116,609.6162791,719.872093,1790.116279,25518.77907,1432.197674,4229.697674,3506.77907,8864.255814,1478.604651,379.9883721,2428.651163,17857.63953,679.0581395,798.5465116,671.7093023,20721.27907,513.5232558,179.6976744,3370.383721,16228.02326,1835.476744,868.9767442,2805.395349,14169.66279,734.127907,309.9651163,1837.372093,11350.24419,975.6627907,461.1511628,1323.895349,8736.081395,827.6976744,180.8604651,4528.290698,7636.5,1382.44186,243.9302326,3329.581395,456.3372093,477.2906977,86,11.78918805,10.02238755,0.526566689,0.934782609,0.651515152,-0.079658005
+2043,22515.66038,921.0754717,510.4025157,1078.628931,15854.67296,617.3459119,459.6540881,1459.874214,8523.899371,505.163522,488.9874214,1753.748428,12503.39623,1215.591195,2078.27044,1789.830189,4467.949686,1303.358491,333.6540881,2466.358491,8999.402516,406.836478,326.4025157,483.6540881,10149.47799,409.6918239,118.6289308,2296.805031,8022.528302,1415.691824,688.8993711,2922.930818,7050.377358,1158.238994,256.5283019,1710.496855,5743.427673,810.6352201,425.9559748,1332.660377,4747.056604,669.1383648,171.8490566,3495.566038,3945.90566,1258.188679,1307.301887,3204.823899,500.6981132,480.4150943,159,15.59223114,13.93653663,0.448440163,0.883333333,0.6625,-0.201063991
+2044,32458.2518,799.2482014,464.0251799,1071.744604,27416.24101,721.1654676,752.0215827,1533.442446,15859.63309,526.7589928,2100.820144,1837.402878,22657.33453,1236.809353,4873.179856,3509.23741,7984.503597,1241.881295,341.7589928,3035.395683,15852.55036,559.3057554,558.3021583,1900.820144,18646.94964,451.5251799,520.1978417,2071.543165,14472.97122,2158.730216,624.2446043,2804.23741,12602.44245,633.3776978,259.1726619,1752.028777,10246.94245,1285.151079,399.4496403,1327.953237,7438.55036,754.0179856,156.5359712,3699.705036,6484.003597,1248.478417,287.4676259,3191.248201,776.1366906,482.057554,278,26.81643639,13.59041767,0.862067002,0.879746835,0.594017094,1.108656744
+2045,17886.36364,699.9225589,511.026936,1063.478114,14911.01684,566.7407407,503.962963,1563.212121,7451.700337,424.7441077,726.5993266,1735.804714,11381.79461,1053.754209,6800.703704,3187.892256,4181.511785,1086.030303,307.2626263,4329.653199,7780.851852,4368.707071,1084.427609,610.7104377,9255.333333,414.6498316,113.9023569,7671.771044,7615.309764,1578.993266,677.7609428,2831.016835,6143.468013,578.2996633,231.8855219,10794.91246,4892.545455,981.1818182,359.6599327,1328.441077,3009.919192,860.6060606,146.7474747,4492.188552,2795.925926,1045.013468,204.8787879,3207.053872,997.6734007,480.3265993,297,25.04324256,15.53344694,0.784392329,0.933962264,0.6875,-1.536520443
+2046,53528.56757,955.7927928,504.7882883,1165.671171,16310.52252,468.2162162,241.5855856,1336.792793,5446.085586,360.1126126,643.4279279,1612.477477,10044.77477,876.3783784,1688.779279,965.8873874,3553.689189,906,258.2702703,2328.887387,6146.68018,2063.531532,202.4189189,535.527027,7112.256757,278.5720721,561.3648649,922.1621622,5179.391892,1298.842342,409.6171171,2801.171171,3963.490991,460.018018,185.2297297,896.2162162,2223.207207,620.6981982,303.0585586,1254.603604,1023.801802,494.1261261,123.0855856,705.7702703,1182.68018,804.3378378,167.5135135,2898.054054,1138.315315,483.3828829,222,20.95258888,13.8071806,0.752167002,0.936708861,0.660714286,0.315018374
+2047,21188.95238,818.3333333,643.9047619,1108.309524,20392.47619,683.7619048,525.8333333,1635.261905,10392.28571,518.6666667,789.3095238,1840.761905,14216.35714,1207.690476,7130.785714,8153.02381,5661.666667,1283.380952,352.1904762,2415.357143,10909.5,432.6190476,748.8809524,646.7380952,12255.14286,448.6904762,128.4761905,7021.214286,9180.738095,1573.380952,1064.214286,2797.904762,8289.690476,644.047619,266.7619048,3059.214286,6582.261905,990.452381,412.4047619,1308.595238,5492.309524,769.5238095,179.4285714,9490.380952,4438.071429,1302.833333,458.0952381,3325.047619,325.8095238,477.3095238,42,9.468178191,5.794269272,0.790878667,0.954545455,0.75,-0.763310858
+2048,34135.40426,1070.723404,511.6808511,1088.595745,29140.31915,792.2340426,631.0638298,1495.319149,16826.2766,622.5957447,1005.914894,1751.957447,23662.57447,1401.276596,3367.702128,2635.531915,8134.914894,1399.382979,368.1276596,2421.12766,15967.74468,525.2765957,258.9574468,1044.553191,18669.57447,433.5957447,293.106383,3232.978723,15055.76596,2147.87234,695.4468085,2800.297872,13205.95745,651.7234043,301.8297872,1545.574468,10128.25532,1123.148936,450.6808511,1316.531915,7806.744681,715.7021277,179.2553191,3629.808511,6994.765957,1372.765957,465.2340426,3293.531915,447.1276596,478.2765957,47,9.982346994,6.335969498,0.772744331,0.886792453,0.671428571,-0.547150496
+2049,37617.0566,844.0943396,440.4716981,1072.660377,31457.88679,748,944.754717,1562.754717,18691,540.9056604,1901.264151,1764.188679,25428.01887,1361.698113,3664.603774,2687.471698,9108.811321,1319.09434,362.2264151,2838.867925,18468.13208,460,521.0754717,817.5660377,21543.86792,608.6792453,129.4339623,1423.377358,17189.84906,1982.943396,715.2075472,2826.603774,14909.24528,891.7358491,276.8301887,1610.471698,12040.71698,1648.396226,420.7924528,1362.641509,9162.735849,774.6792453,162.754717,2368.754717,7782.169811,1404.867925,485.5471698,3144.943396,616.9811321,477.6792453,53,12.95298606,5.404611743,0.908792515,0.883333333,0.509615385,-1.149422539
+2050,28752.88889,783.6969697,521.3838384,1089.313131,23842.56566,635.6161616,523.1212121,1583.292929,14025.78788,491.4848485,577.6060606,1719.545455,19828.64646,1190.474747,3156.727273,1844.919192,6985.79798,1203.777778,335.9393939,2432.131313,13892.38384,11208.30303,195.2424242,528.8787879,16563.9596,491.5353535,125.2727273,2491,13238.9596,1427.838384,543.0909091,2814.121212,11359.0202,3965.232323,251.4545455,1767.161616,9261.111111,920.2222222,405.6262626,1302.282828,6738.191919,639.2828283,157.8585859,3708.959596,5889.979798,1239.282828,335.7979798,3211.010101,795.0707071,479.3535354,99,13.19103838,10.45613982,0.609650998,0.876106195,0.642857143,1.551986371
+2051,31405.6,751.5636364,510.3909091,1053.436364,26968.06364,610.5272727,862.7090909,1634.954545,14351.14545,465.9090909,1555.445455,1767.963636,20916.42727,1148.963636,6302.054545,4226.9,7521.6,1169.927273,339.2,5178.672727,14656.92727,851.6545455,676.8272727,701.4,17240.28182,416.0909091,121.7454545,6816.154545,14349.15455,1971.563636,612.5818182,2812.027273,11766.77273,570.9545455,255.3,4222.772727,9446.163636,1167.090909,404.1363636,1307.118182,6246.327273,736.7727273,149.0818182,3024.727273,5661.872727,1170.672727,200,3240.772727,956.2272727,480.7636364,110,13.83004124,10.98886178,0.607179568,0.901639344,0.528846154,-1.462501212
+2052,47523.52439,901.2439024,569.7195122,1168.853659,43233.04878,748.9512195,529.7560976,1809.817073,23738.52439,584.7926829,651.6097561,1791.182927,31671.30488,1328.536585,10439.42683,5913.646341,12102.26829,1459.487805,403.3658537,2534.841463,23335.06098,453.7195122,146.2560976,516.8902439,28064.26829,455.195122,136.0609756,6593.353659,21762.17073,1560.060976,804.5487805,2811.512195,18298.86585,611.0731707,309.8536585,2311.231707,13018.19512,885.8902439,454.2804878,1304,10002.79268,657.5,180.3292683,4322.939024,8380.182927,1363.97561,139.0731707,3378.304878,221.4878049,480.5487805,82,10.83586238,10.02471216,0.379621061,0.931818182,0.67768595,0.253433153
+2053,40379.84277,865.1194969,585.490566,1110.119497,38388.41509,714.4402516,776.6037736,1653.955975,20451.28931,558.0377358,1124.823899,1831.572327,28157.03145,1290.566038,10260.05031,5919.842767,10367.1195,1376.553459,373.2012579,3038.471698,21450.57862,443.0566038,153.7610063,922.7987421,24826.02516,440.4654088,131.5157233,5269.974843,19262.58491,1810.27044,880.7610063,2852.779874,17151.42138,618.2327044,299.7295597,3009.459119,13012.54088,1012.408805,449.9119497,1320.610063,10319.77987,673.0880503,174.8113208,4425.257862,8358.924528,1375.251572,298.9496855,3323.044025,264.3836478,483.5786164,159,20.59725398,10.58971374,0.857710889,0.85483871,0.490740741,-0.757143978
+2054,44907.56863,968.3921569,560.0784314,1112.627451,39201.23529,751.3529412,661.7058824,1701.784314,23258.35294,607.8823529,1590.980392,1837.352941,31420.01961,1375.333333,7995.686275,4643.490196,10923.54902,1427.254902,387.0980392,2460.588235,21716.7451,468.1764706,252.7647059,546.2745098,26521.07843,529.8823529,142.4117647,5190.784314,20949.13725,1695.54902,864.8235294,2833.960784,18010.37255,650.5294118,319.627451,2036.705882,13990.54902,1528.980392,470.2156863,1311.45098,10799.47059,700.4901961,209.3921569,4640.705882,9621.568627,1440.568627,261.3921569,3361.117647,318.1568627,478.4117647,51,9.568318287,7.372950257,0.637369119,0.879310345,0.62962963,0.854756127
+2055,20697.83333,917.6166667,516.925,1053.708333,17929.075,690.45,435.4416667,1475.2,10839.43333,559.9416667,505.1666667,1724.333333,15181.55833,1334.133333,4124.733333,2901.366667,5927.241667,1425.425,390.3083333,2394.766667,10840.225,493.6666667,1023.491667,490.4083333,10496.275,401.3333333,125.8583333,3734.925,8092.075,1518.291667,727.2916667,2812.541667,7178.933333,678.3666667,263.2,1677.333333,5639.033333,819.4833333,434.2666667,1347.025,4409.375,805.9666667,176.95,5319.783333,4109.808333,1346.333333,419.75,3247.191667,362.0333333,482.0833333,120,14.39122561,11.347411,0.615041026,0.930232558,0.612244898,-0.813238674
+2056,35562.67045,845.8863636,495.1022727,1115.465909,30584.78409,697.4431818,471.9204545,1581.079545,17688.02273,538.375,414.9318182,1735.818182,25130.11364,1329.772727,4891.715909,3296.420455,8864.25,1309.602273,351.2727273,2382.772727,17917.69318,471.5454545,121.9659091,465.8522727,21420.56818,420.4772727,120.3977273,3426.534091,16070.07955,1417.920455,746.5909091,2822.840909,14061.60227,782.1704545,276.2954545,2294.840909,11236.5,825.8409091,411.9545455,1305.681818,8618.136364,650.8068182,162.2840909,4050.227273,7315.659091,1351.261364,611.9886364,3230.204545,661.6818182,480.9318182,88,11.37939963,10.63854716,0.35492364,0.897959184,0.564102564,-1.459428563
+2057,24901.48171,813.3902439,924.7317073,1164.591463,20538.18293,634.0731707,796.5670732,1762.609756,10901.94512,473.847561,907.5487805,1804.646341,16161.59756,1224.012195,5544.262195,2669.902439,5841.487805,1259.371951,339.9695122,5710.481707,11435.81707,486.6402439,307.2073171,815.0914634,13528.62195,419.445122,121.2134146,3507.72561,11308.64634,1570.341463,545.6036585,2823.835366,9157.621951,569.9268293,266.0426829,8998.256098,7506.396341,1094.945122,406.0365854,1346.128049,5217.134146,674.2195122,155.902439,3564.134146,4668.567073,1215.04878,201.4817073,3234.707317,938.2439024,483.6463415,164,17.49957363,12.13268983,0.720636146,0.942528736,0.616541353,-0.057703852
+2058,23203.06303,768.7563025,568.3991597,1105.865546,13563.90756,469.6470588,399.9789916,1346.705882,5937.588235,369.6302521,846.2268908,1655.584034,9683.970588,939.0210084,5189.983193,2050.268908,3551.743697,967.4411765,285.2563025,3374.264706,6548.777311,321.3907563,803.092437,526.105042,7904.256303,300.2016807,99.87394958,3731.277311,6020.05042,1352.180672,498.3655462,2784.205882,4761.369748,473.697479,200.2016807,4069.869748,3454.714286,794.9033613,314.9957983,1286.819328,1796.483193,751.9705882,128.4495798,1631.151261,1834.731092,879.302521,146.8529412,3000.12605,1073.071429,482.5546218,238,18.81662404,16.18351416,0.510184974,0.975409836,0.734567901,0.822268003
+2059,54110.04082,945.8877551,590.877551,1180.153061,47097.89796,768.6530612,555.0306122,1949.357143,24904.20408,585.0102041,536.5,1808.163265,33665.31633,1387.612245,10723.97959,8668.346939,13455.36735,1466.510204,397.9693878,2451.602041,25180.30612,461.3163265,152.9285714,461.6836735,29931.91837,473.8979592,144.622449,8720,22366.32653,1538.091837,860.8979592,2828.459184,18611.69388,635.4081633,320.0306122,5602.632653,11534.21429,857.7142857,453.6428571,1316.561224,9525.806122,649.2346939,180.5,3006.714286,7748.489796,1367.153061,156.1326531,3334.418367,185.8367347,481.6836735,98,16.07864996,8.172910488,0.861175196,0.933333333,0.538461538,-0.776113094
+2060,47905.46825,921.6468254,540.9365079,1140.420635,43476.94444,748.6349206,909.0912698,1694.468254,23903.51984,599.1785714,1406.448413,1893.238095,32689.0119,1370.892857,7441.353175,6150.111111,12086.87698,1464.146825,392.6428571,2715.349206,24529.50397,480.1825397,145.3611111,1102.214286,29135.65476,1164.809524,138.9603175,3708.464286,22379.53175,1783.09127,782.952381,2832.539683,19979.28571,641.7579365,322.3809524,2047.015873,15367.4246,1384.630952,474.8134921,1308.809524,11934.54365,676.3492063,186.1984127,4441.357143,9953.011905,1444.031746,223.4444444,3351.468254,278.0515873,486.1269841,252,19.77468615,17.36885377,0.478040541,0.868965517,0.571428571,-0.14382948
+2061,35671.19883,1122.923977,739.3216374,1178.05848,30445.66667,828.2280702,925.8479532,1750.116959,17032.82456,640.6725146,973.0760234,1834.157895,24338.61404,1472.035088,3079.982456,2773.093567,8044.614035,1460.005848,380.1520468,2523.54386,15741.10526,595.5789474,334.2865497,1003.71345,18265.88304,490.4678363,352.0409357,3084.859649,14346.05848,1933.637427,735.497076,2817.590643,12456.4152,782.1520468,299.1345029,1667.637427,9824.052632,1010.122807,466.251462,1327.918129,7646.22807,696.6374269,184.8830409,2499.754386,6603.929825,1404.906433,252.9473684,3415.269006,469.4502924,480.8011696,171,18.97616029,11.53101317,0.794198912,0.988439306,0.863636364,1.484137068
+2062,35349.832,992.512,577.704,1081.144,29585.52,701.632,745.08,1545.248,17077.624,576.88,1400.488,1865.688,24052.792,1359.016,5518.6,3387.824,8390.184,1378.224,370.856,2660.68,14031.176,421.04,204.696,744.152,16839.624,418.992,124.184,2513.792,12904.112,1937.32,788.632,2828.096,11350.392,691.6,269.992,1474.168,9085.68,1066.984,430.096,1328.52,7300.992,649.216,171.832,2866.912,6324.744,1267.112,151.616,3307.92,518.44,481.608,125,16.35273102,10.6098051,0.760950986,0.868055556,0.558035714,-0.804005147
+2063,27122.52299,972.7068966,577.8045977,1092.758621,22302.67241,745.1724138,599.4195402,1515.04023,13319.81034,587.8505747,832.4712644,1744.034483,18103.6092,1388.91954,3854.741379,2307.425287,6360.706897,1396.844828,366.6551724,2496.844828,12509.03448,482.454023,574.3850575,623.5287356,14568.5977,940.591954,125.4655172,1513.350575,11499.25287,1851.321839,715.2183908,2794.925287,10202.6954,685.0747126,288.591954,1541.632184,8008.724138,1025.66092,443.5114943,1336.396552,6242.954023,993.1436782,171.5229885,3419.258621,5570.011494,1659.413793,308.0689655,3181.948276,563.9885057,483.4137931,174,18.46512902,12.19094498,0.751077147,0.956043956,0.602076125,-0.803514064
+2064,22601.44068,914.0508475,575.4322034,1108.771186,19316.05932,732.940678,463.2033898,1587.347458,10676.48305,528.9830508,535.8898305,1741.618644,16004.74576,1404.669492,5275.601695,2720.610169,5703.559322,1300.949153,408.9067797,3145.355932,11325.16949,1108.372881,2220.474576,620.059322,13425.33051,430.279661,135.4152542,4115.40678,10819.36441,1880.923729,624.9152542,2792.271186,9265.525424,725.2711864,286.6440678,4606.915254,7525.686441,879.0508475,436.559322,1359.745763,5317.491525,1233.915254,175.2627119,3582.127119,4792.966102,1373.847458,231.6864407,3149.762712,873.5932203,483.559322,118,16.43834197,9.407487508,0.820051789,0.936507937,0.694117647,0.408816756
+2065,22763.00909,701.5,499.2590909,1066.709091,19543.80455,578.1727273,543.2909091,1514,10763.09545,449.1954545,508.9272727,1759.045455,15399.44545,1112.795455,5103.713636,2576.427273,5561.25,1116.954545,310.9045455,2833.795455,10749.35455,7563.377273,378.6681818,467.75,12709.84545,435.1,114.1590909,5561.790909,10330.40909,1442.945455,758.7318182,2780.504545,8740.690909,741.6590909,244.2863636,7657.118182,6967.886364,784.1363636,375.0681818,1308.759091,4889.759091,675.1863636,147.3772727,3047.936364,4224.286364,1134.454545,199.15,3154.104545,884.8409091,486.8363636,220,22.24619104,12.92428845,0.813927575,0.920502092,0.683229814,0.038474531
+2066,33481.70833,878.8680556,609.6944444,1138.194444,20099.625,608.1527778,847.4583333,1633.166667,10124.0625,491.7291667,1488.451389,1772.659722,14239.34722,1145.423611,12700.125,8085.756944,5886.451389,1204.138889,332.375,4506.409722,11800.65972,394.4791667,131.0972222,1054.0625,13446.66667,424.3194444,127.2708333,10614.71528,9709.451389,2554.8125,804.9930556,2796.659722,8402.263889,571.0833333,272.8819444,10162.21528,5457.333333,1059.611111,402.9652778,1316.0625,4717.631944,594.1458333,164.9930556,4216.145833,3682.229167,1199.090278,395.8055556,3253.902778,175.5486111,485.7708333,144,17.16835802,11.67297242,0.733293727,0.857142857,0.615384615,0.103871724
+2067,59882.76522,959.326087,578.4086957,1161.017391,59431.45652,861.8521739,874.5826087,1991.504348,31927.69565,624.6652174,1310.386957,1827.669565,44262.4087,1463.152174,8618.969565,7117.021739,16959.93043,1545.786957,424.0130435,2550.256522,32569.20435,495.9652174,167.2913043,1071.873913,38854.06957,612.6173913,381.0434783,6775.547826,29736.58696,1802.282609,666.0608696,2850.9,24931.86087,663.1869565,340.9521739,4288.869565,16383.81304,1021.873913,486.5782609,1328.382609,13097.24783,677.0782609,187.7913043,3742.521739,10742.09565,1448.256522,256.9521739,3367.765217,195.626087,486.1130435,230,23.9491477,13.31871586,0.83109877,0.864661654,0.511111111,-1.11774585
+2068,33674.46067,951.2752809,616.0449438,1110.764045,30460.70787,757.2078652,671.7078652,1581.606742,16698.36517,578.3595506,1041.101124,1801.769663,23105.17978,1385.679775,5012.320225,4725.533708,8312.58427,1403.904494,377.5224719,2498.050562,16357.64607,474.3707865,1560.241573,948.5280899,18262.51685,459.6235955,148.6966292,5348.382022,13862.81461,1998.623596,884.7134831,2818.865169,12278.42697,764.8820225,299.6966292,1880.337079,9889.561798,1181.573034,460.4101124,1380.483146,7847.095506,1075.938202,183.8764045,5956.769663,6715.449438,1412.966292,444.8707865,3228.786517,423.3370787,485.2977528,178,21.97536074,10.47436054,0.879097972,0.931937173,0.551083591,-0.901884982
+2069,33229.24465,916.1620795,489.3914373,1080.954128,29082.35168,693.3730887,560.8990826,1520.189602,15906.00612,548.9785933,636.7522936,1766.16208,22834.25688,1312.941896,3526.905199,2338.281346,8335.217125,1395.449541,435.1223242,2590.033639,16605.86239,475.3333333,221.1681957,493.8960245,19736.29664,429.795107,128.1529052,1953.094801,14988.59021,1870.324159,754.6269113,2820.513761,13169.32416,688.7125382,284.9296636,1514.550459,10525.69725,1108.730887,442.3088685,1316.636086,8284.278287,672.883792,172.6146789,2564.776758,7224.269113,1361.097859,237.4036697,3271.357798,483.6391437,490.6850153,327,30.94273245,15.55345704,0.86448827,0.795620438,0.486607143,-0.54106636
+2070,29712.62264,911.6603774,483.1886792,1068.622642,24036.43396,719.9622642,663.0566038,1533.811321,14664.81132,543.5471698,1396.09434,1789.962264,19551.18868,1310.754717,2941.45283,2205.773585,7169.226415,1341.679245,347.6603774,2421.283019,13883.58491,469.6037736,329.6603774,1053.188679,15943.37736,1437.886792,134,1266,12642.33962,1496.679245,667.9811321,2808.90566,10948.84906,607.7924528,290.5471698,1515.943396,8669.245283,1194.90566,418.5849057,1317.603774,6873.528302,685.5660377,171.8867925,7336.90566,5927.226415,1353.075472,351.1320755,3112.849057,586.0188679,481.2641509,53,9.622854616,7.464082247,0.631148578,0.946428571,0.588888889,0.595403047
+2071,28194.94771,813.4379085,467.620915,1069.346405,23996.11765,687.3529412,621.7385621,1505.490196,13832.89542,520.2810458,1077.477124,1788.163399,20114.37255,1283.130719,4998.764706,3412.019608,7096.424837,1286.882353,333.2091503,2426.091503,14187.68627,435.9934641,353.6928105,875.7385621,16590.69935,445.3986928,229.4379085,3184.607843,12971.46405,1826.071895,808.503268,2805.745098,11327.50327,723.0392157,260.9869281,1857.640523,9211.424837,1188.660131,400.7777778,1298.202614,7258.418301,750.2418301,156.8627451,2975.96732,6223.026144,1335.836601,672.6732026,3162.026144,622.9869281,484.0457516,153,17.77341289,11.50579394,0.762184507,0.884393064,0.607142857,-1.360087895
+2072,33669.08571,824.6228571,513.6685714,1094.48,27867.16,679.6,545.2914286,1573.371429,16281.77143,528.2628571,613.8,1764.657143,22738.15429,1312.891429,6782.142857,3958.131429,8140.588571,1303.942857,349.0971429,2442.497143,16524.51429,459.5942857,190.2857143,723.5485714,19534.77714,469.7085714,124.9485714,5153.828571,14993.47429,1469.091429,777.1885714,2800.005714,13365.17143,668.4285714,276.9885714,2334.92,10636.88,1030.725714,411.6914286,1303.76,8272.525714,661.1885714,161.6114286,4414.811429,7006.165714,1354.451429,405.4571429,3237.297143,643.7485714,485.4685714,175,18.21297855,13.09798801,0.694847787,0.862068966,0.514705882,-1.033302983
+2073,38587.22105,824.5473684,497.7263158,1098.247368,34765.25263,692.0052632,617.2631579,1593.442105,18966.76316,516.4578947,540.6578947,1762.7,27197.46316,1265.068421,5963.131579,2959.131579,9664.105263,1291.915789,350.4631579,2475.884211,19110.43684,467.7736842,785.3263158,544.1,23268.23158,416.1,131.2631579,3673.847368,17871.36316,1550.568421,654.8894737,2799.968421,15227.38947,877.9473684,279.9105263,3951.531579,12418.46316,881.1789474,419.7315789,1320.289474,8816.089474,863.6052632,161.2105263,2743.789474,7586.905263,1293.715789,865.4263158,3210.257895,835.2,483.9,190,17.62358841,14.16662776,0.594839249,0.935960591,0.698529412,-1.014514753
+2074,38321.72165,845.185567,447.5051546,1105.278351,33308.5567,685.4742268,725.3092784,1686.453608,18478.04124,517.8556701,948.371134,1785.556701,26823.39175,1256.092784,3458.360825,1669.113402,9434.484536,1247.639175,400.7731959,4094.659794,18931.09278,15145.20619,938.4742268,1202.072165,22786.58763,500.2783505,124.5257732,1529.453608,17917.59794,1961.041237,504.8865979,2801.319588,15275.05155,673.4536082,278.8865979,3028.597938,12404.73196,980.628866,422.7319588,1391.896907,8589.752577,922.7731959,161.5051546,2281.804124,7481.505155,1313.793814,190.1443299,3251.85567,862.6597938,481.5670103,97,12.45593523,10.33052767,0.558705861,0.97,0.734848485,0.888227625
+2075,44024.33333,865.8958333,463.71875,1105.541667,36521.88542,708.1979167,637.3229167,1575.041667,25142.88542,583.1875,1129.40625,1792.854167,33761.80208,1421.541667,3711.760417,2933.645833,11768.51042,1361.041667,376.9583333,2466.96875,23747.10417,501.21875,128.8854167,803.9479167,27850.36458,976.96875,127.0104167,2263.427083,22061.21875,1588.25,577.7916667,2812.0625,19424.39583,775.03125,307.3125,1720.239583,15717.53125,1263.416667,436.7708333,1301.166667,11194.94792,643.6875,167.875,3035.302083,9674.072917,1405.5,357.0833333,3351.145833,755.0520833,485.1041667,96,13.68446855,9.220537212,0.738917615,0.914285714,0.581818182,0.408111801
+2076,31659.3301,964.184466,545.407767,1079.601942,27043.42718,699.9708738,900.2718447,1555.097087,15545.17476,558.0873786,1963.475728,1838.737864,21463.04854,1331.456311,4754.38835,3147.038835,7621.368932,1401.524272,366.1553398,3425.213592,15526.02913,660.8834951,301.8349515,924.3980583,18379.95146,540.961165,130.7184466,2231.31068,14198.73786,2151.058252,730.961165,2826.07767,12645.43689,684.8058252,285.4174757,1632.262136,10015.41748,1354.854369,455.3300971,1443.543689,7529.601942,700,175.6699029,4911.174757,6613.84466,1347.902913,189.8252427,3285.572816,526.8932039,485.3592233,103,14.68507905,9.169617607,0.781090916,0.919642857,0.66025641,-0.585363508
+2077,17232.4527,765.9932432,454.7364865,1048.878378,15246.73649,626.6013514,550.9662162,1407.533784,8634.790541,491.1554054,470.7702703,1746.439189,12157.06081,1233.337838,4177.189189,1784.060811,4378.324324,1663.168919,320.3918919,2402.993243,8904.864865,455.8783784,1196.972973,539.1283784,10192.41892,532.5608108,120.277027,1084.655405,8025.682432,1530.02027,925.0675676,2811.75,7209.081081,676.8040541,264.6689189,1540.432432,5648.567568,885.9391892,405.5878378,1326.945946,4633.472973,884.8986486,160,3253.533784,3951.148649,1296.777027,638.4527027,3106.702703,578.4864865,486.3783784,148,16.47272536,11.58652519,0.71081765,0.967320261,0.616666667,0.768900251
+2078,40958.525,848.4875,460.725,1093.6875,35772.6,707.7125,650.5,1613.5625,20644.575,534.1875,1182.725,1755.1625,27921.3,1296.2875,3991.8375,2499.0625,10207.1,1299.5375,373.75,2478.9375,20363.075,471.1625,310.975,1049.5625,24371.95,408.35,389.15,1799.7625,19154.9,1731.1875,562.4875,2795.475,16161.6875,695.075,285.3625,1833.9625,13262.15,966.375,432.9625,1298.7125,9292.5625,675.0625,162.475,1776.0875,7952.65,1312.8375,719.95,3152.225,822.85,484.1125,80,11.52378443,9.340229785,0.585714319,0.930232558,0.666666667,0.001536515
+2079,33688.88312,794.2337662,512.6233766,1086.623377,27788.23377,628.7142857,655.4805195,1597.805195,14852.96104,488.7792208,1596.662338,1768.350649,21018.57143,1166.38961,7457.766234,4021.909091,7422.038961,1201.714286,336.961039,4991.961039,15151.84416,503.8181818,181.6623377,646.8571429,17466.42857,394.3766234,121.5194805,5558.220779,14386.14286,1766.454545,680.9350649,2787.558442,12249,556.6883117,269.5194805,15621.79221,9651.090909,1151.532468,392.1818182,1324.649351,6685.142857,633.2077922,159.2207792,3378.12987,5853.87013,1164.571429,253.5584416,3177.337662,911.1038961,484.5974026,77,12.5171226,8.276691886,0.750183594,0.93902439,0.538461538,-0.505472387
+2080,30851.48372,921.8744186,674.2651163,1821.572093,23701.77209,662.9813953,592.6465116,3535.92093,10738.02326,493.4093023,660.2325581,1897.148837,14542.75814,1144.613953,7306.037209,3272.483721,5605.795349,1234.265116,440.6511628,2972.990698,10292.4,1205.130233,1403.706977,514.0232558,12008.09767,460.772093,121.8232558,8541.976744,8543.962791,1733.362791,640.4930233,2804.093023,6999.865116,624.4697674,261.6790698,7233.106977,3786.916279,772.2418605,371.5813953,1303.139535,2953.772093,797.772093,149.1953488,3241.75814,2569.548837,1058.306977,167.7255814,3200.15814,148.7116279,488.2744186,215,24.37984117,11.48343656,0.882121572,0.942982456,0.565789474,-0.817706672
+2081,40658.12745,871.9019608,584.3039216,1133.95098,39828.19608,722.1568627,512.4509804,1749.745098,21091.92157,564.745098,525.2647059,1816.382353,28980.29412,1324.196078,10285.78431,5927.166667,10710.16667,1398.784314,381.8529412,2416.460784,22135.38235,449.6666667,138.0392157,453.6568627,26147.11765,460.0882353,136.5196078,6846.558824,19574.60784,1489.833333,786.4411765,2814.392157,16546.70588,613.4117647,302.8823529,4314.460784,12345.22549,841.4509804,452.4019608,1311.196078,9866.990196,671.5196078,179.7941176,6334.901961,7760.166667,1376.382353,208.0882353,3346.598039,233.0196078,484.2941176,102,14.33291079,9.317966111,0.759840258,0.935779817,0.68,-1.339691546
+2082,45203.19375,893.53125,589.36875,1143.84375,44005.9625,746.36875,790.45,1741.0375,23600.5875,582.3625,1043.36875,1811.65625,32742.8,1333.76875,9187.775,6012.24375,12100.81875,1437.71875,387.8625,3376.6125,24851.59375,579.88125,149.70625,775.4375,29047.075,451.23125,138.925,5424.9375,22448.275,1852.68125,869.2375,2835.33125,19448.56875,638.96875,313.16875,3250.64375,14506.05625,979.15,469.975,1318.54375,11454.31875,658.8875,184.175,3653.08125,9289.725,1401.6875,245.2,3328.11875,246.30625,488.1,160,17.27273274,13.2171131,0.643791398,0.816326531,0.588235294,0.645112851
+2083,41001.79412,997.6911765,619.2647059,1112.602941,36632.75,759.6470588,1066.647059,1649.867647,20647.32353,633.4705882,1783.191176,1879.647059,27973.54412,1380.308824,10902.02941,6141.058824,9878.352941,1417.823529,385.4705882,2549.279412,19381.41176,478.7205882,233.3088235,821.4264706,23056.57353,696.9558824,136.3088235,6882.235294,17665.29412,2177.485294,827.5882353,2814.088235,15277.70588,626.6470588,307.7647059,2042.897059,11858.29412,1296.102941,451.5,1310.838235,9393.235294,671.8235294,181.7205882,4599.911765,7854.485294,1382.411765,234.7352941,3459.397059,313.6323529,485.0441176,68,11.63838301,7.866618138,0.736974821,0.906666667,0.62962963,-1.256609122
+2084,37098.80769,856.5384615,487.4358974,1091.487179,31873.91026,677.4615385,705.7179487,1553.961538,18225.02564,546.5128205,1165.217949,1780.358974,24954.17949,1326.897436,2886.141026,2143.397436,9001.820513,1594.307692,369.2051282,2467.128205,18309.39744,2732.730769,317.0769231,661.6923077,21398.58974,445.7435897,140.2564103,1794.512821,16592.10256,1655.679487,682.5,2852.320513,14594.51282,677.3333333,294.8846154,1652.538462,11644.20513,1282.269231,467.2051282,1354.717949,9188.269231,710.7564103,177.5128205,4164.269231,8070.179487,1409.525641,176.5769231,3251.128205,537.2179487,484.474359,78,13.31788783,8.026669339,0.797969091,0.886363636,0.6,-1.13677139
+2085,32456.43671,822.3797468,514.2658228,1093.620253,27283.56962,669.9936709,579.0632911,1549.35443,16164.32278,528.4493671,505.2594937,1755.196203,22661.82911,1295.113924,4790.373418,2908.531646,8148.563291,1264.202532,344.0443038,2526.189873,16223.24684,447.3227848,672.2531646,474.278481,19303.27848,389.3924051,119.9620253,2294.202532,15158.5,1573.981013,811.8670886,2779.765823,13326.05063,794.721519,267.278481,1819.506329,10804.84177,832.1772152,411.7088608,1323.227848,8042.379747,793.3797468,162.0063291,2655.468354,6980.202532,1332.386076,1093.28481,3142.044304,698.6708861,488.0632911,158,17.65320472,12.53188844,0.704309427,0.844919786,0.619607843,0.004776291
+2086,38009.92063,815.6904762,459.7380952,1101.904762,32268.55556,684.1190476,688.3015873,1546,18678.7619,530.7777778,1687.730159,1814.142857,26395.78571,1268.563492,4175.150794,3561.849206,9311.936508,1276.436508,358.484127,2436.301587,18452.89683,672.3730159,166.515873,1026.730159,21864.96032,491.2063492,227.8809524,2572.166667,16974.40476,2106.984127,591.3730159,2816.301587,14959.74603,675.8095238,278.4206349,1881.420635,12153.25397,1367.142857,418.5873016,1294.047619,8684.198413,646.1984127,162.1111111,3413.436508,7604.119048,1305.468254,235.4285714,3192.428571,765.5238095,488.6111111,126,15.46609728,12.32198559,0.60436254,0.857142857,0.525,0.908346314
+2087,21295.24832,739.8053691,553.3892617,1111.66443,11692.8255,483.3624161,519.9530201,1437.42953,5883.536913,380.2214765,524.4496644,1678.04698,8743.241611,944.9463087,6803.033557,2292.469799,3200.845638,994.8053691,270.6711409,3030.966443,6029.228188,5858.496644,155.6711409,469.4496644,7026.912752,366.8187919,103.3691275,6959.550336,5797.174497,1471,579.6040268,2786.080537,4661.436242,544.5369128,210.6979866,6726.483221,3581.610738,783.5503356,326.557047,1266.805369,2143.469799,629.1409396,133.261745,2337.181208,2031.181208,934.7181208,147.7449664,3051.845638,1011.57047,487.7919463,149,16.07171078,11.976006,0.666885033,0.943037975,0.665178571,-0.52943343
+2088,26346.05505,771.2293578,475.559633,1085.165138,8824.201835,393.5963303,209.4220183,1149,4428.889908,332.4036697,331.1009174,1624.330275,6728.550459,830.1651376,2758.66055,1419.284404,2386.752294,893.1192661,245.4862385,2576.055046,4456.486239,1316.798165,162.7981651,380.2844037,5272.146789,273.2568807,92.31192661,3058.504587,4263.990826,1148.431193,510.6880734,2770.972477,3370.651376,435.2385321,176.6513761,2460.055046,2583.568807,653.9633028,294.8073394,1242.66055,1482.972477,523.8990826,120.0917431,1017.100917,1405.449541,809.3211009,94.79816514,2869.266055,1023.59633,485.8165138,109,12.61241387,11.04376021,0.482989371,0.96460177,0.762237762,0.115447668
+2089,28925.8,1019.155556,576.0888889,1078.896296,24769.53333,744.9777778,653.6222222,1519.488889,14141.67407,594.6888889,1011.437037,1829.340741,19898.34815,1324.392593,5858.407407,3214.407407,7056.577778,1346.548148,358.5333333,2410.222222,14318.25185,686.7925926,378.7037037,1005.562963,16329.25926,485.0074074,145.3555556,4395.074074,12902.57778,1999.274074,750.3777778,2792.503704,11300.38519,609.1037037,281.5703704,1809.940741,8771.103704,1028.681481,436.2222222,1315.4,6846.111111,709.7185185,173.762963,4473.903704,5911.985185,1310.755556,179.4666667,3393.77037,449.0592593,487.6592593,135,18.37037956,10.46725601,0.821790432,0.870967742,0.535714286,-1.05981548
+2090,21502.81308,789.2056075,590.271028,1137.065421,18404.6729,657.0560748,705.8598131,1564.766355,10475.71963,495.2990654,645.3831776,1803.588785,14780.1215,1245.803738,1635.738318,2210.962617,5305.196262,1251.037383,327.2616822,2479.214953,10472.8972,442.5046729,544.6542056,587.0560748,12275.23364,656.9906542,112.5607477,1453.925234,9468.429907,1498.196262,758.8971963,2800.495327,8357.457944,858.8878505,261.9252336,1989.11215,6682.700935,973.7757009,393.0654206,1324.672897,5342.280374,770.7850467,153.7102804,2887.448598,4551.074766,1310.392523,652.0093458,3134.682243,610.3084112,487.9065421,107,14.49820011,9.676564007,0.744670668,0.930434783,0.636904762,0.318921052
+2091,30230.60309,805.7010309,489.257732,1069.587629,25252.8299,658.5824742,633.2216495,1535.262887,14749.41237,519.5,939.6134021,1807.474227,21107.1134,1264.505155,5398.510309,3856.061856,7421.329897,1615.520619,358.6443299,2585.515464,14930.37113,450.6597938,686.1701031,816.7474227,17663.02062,1002.06701,145.3814433,2887.953608,13494.47938,1739.381443,751.9536082,2816.43299,11754.65464,932.443299,263.1237113,1826.546392,9441.716495,1136.912371,387.4690722,1325.036082,7250.5,807.3814433,158.4896907,3669.530928,6230.190722,1298.886598,189.8814433,3217.747423,684.1494845,488.6649485,194,20.31660015,12.52171778,0.787488465,0.91943128,0.646666667,1.11550941
+2092,30785.67045,751.25,454.1136364,1054.761364,26853.82955,685.75,716.3181818,1527.693182,15665.875,501.7727273,1935.795455,1845.875,22229.86364,1192.272727,4976.693182,3533.193182,7887.147727,1226.704545,330.1818182,2538.818182,15826.68182,453.0454545,187.8181818,1680.943182,19119.43182,393.3522727,806.2613636,2641.340909,14958.06818,1748.272727,622.1590909,2802.670455,12670.15909,628.3409091,265.3977273,1919.034091,10409.42045,916.0340909,395.6931818,1300.602273,7582.931818,633.125,151.1818182,3668.454545,6531.761364,1223.193182,506.2613636,3205.636364,807.4204545,485.1136364,88,13.79101312,8.59440179,0.78207161,0.888888889,0.628571429,1.539836754
+2093,27810.13548,823.2,540.6064516,1090,24501.75484,647.1612903,577.3612903,1539.477419,13163.67742,496.8774194,623.5290323,1752.264516,18991.14194,1214.916129,4521.677419,3531.006452,6823.032258,1212.554839,340.6774194,3000.696774,13381.12903,2098.916129,955.7677419,872.5419355,16477.62581,510.916129,121.2,2701.270968,12478.53548,1640.767742,615.9483871,2794.954839,10547.3871,637.2193548,265.8258065,6794.006452,8681.348387,1097.793548,396.4967742,1339.141935,6246.090323,907.1419355,158.4064516,4178.012903,5345.787097,1253.567742,310.1354839,3214.554839,856.1290323,489.8258065,155,18.75817706,11.05987547,0.807693276,0.93373494,0.627530364,0.354837712
+2094,26684.74775,926.0900901,1041.288288,1231.477477,21801.85586,690.4684685,1077.081081,2035.945946,11594.21622,509.4054054,605.2972973,1939.684685,16784.21622,1270.810811,6435.117117,2942.234234,6019.45045,1321.207207,347.3243243,2694.27027,11797.27027,596.6486486,187.2612613,460.8288288,13529.18919,473.981982,125.5495495,5778.684685,11538.07207,1585.351351,544.7477477,2843.738739,9415.495495,609.8828829,274.3423423,11263.12613,7295.108108,991.3963964,409.6126126,1327.009009,4998.324324,666.1171171,170.3243243,3763.855856,4514.342342,1247.234234,196.7927928,3281.153153,947.4864865,489.6216216,111,14.03838536,11.51964251,0.571529201,0.810218978,0.528571429,-0.385381278
+2095,42913.34498,918.5458515,565.7860262,1120.637555,38898.63319,734.3100437,604.6026201,1694.646288,22262.68559,588.8908297,838.9388646,1829.266376,29904.44105,1350.737991,7807.716157,4662.89083,11044.27074,1435.078603,393.8864629,2455.393013,22008.36245,462.209607,171.1004367,553.6855895,26258.49345,465.3930131,189.558952,5031.71179,20014.33188,1679,896.8165939,2837.917031,17488.9869,643.790393,322.2576419,2138.231441,13646.84716,1014.388646,472.3275109,1307.681223,10914.64629,670.1484716,184.5240175,4425.755459,9113.283843,1426.790393,146.9519651,3346.537118,300.0436681,492.8733624,229,26.89732568,11.33925242,0.906793324,0.870722433,0.654285714,-0.273976846
+2096,22035.74775,948.8558559,512.7657658,1051.864865,20528.4955,668.3243243,761.9009009,1428.648649,10817.69369,536.0720721,1580.027027,1786.009009,15038.11712,1269.630631,3447.045045,2978.144144,5577.468468,1319.702703,379.9369369,2717,12306.33333,537.6036036,813.8108108,1256.126126,13290.5045,437.8198198,366.7477477,3157.945946,10184.20721,2098.855856,700.2702703,2803.396396,9024.90991,683.3873874,275.0540541,1601.297297,7133.27027,1164.036036,446.8828829,1397.504505,5763.009009,810.4594595,176.3783784,5878.900901,4989.153153,1325.657658,192.5945946,3309.486486,394.8018018,486.4864865,111,17.26904846,8.628199127,0.866236766,0.8671875,0.652941176,-1.307367303
+2097,21658.08247,779.7268041,760.6804124,1126.811856,16821.67526,562.3917526,474.8556701,1573.28866,8473.909794,429.1778351,643.4639175,1758.154639,12476.15722,1052.634021,5628.525773,2491.948454,4593.201031,1099.688144,303.314433,3145.979381,8695.195876,5664.89433,149.8969072,530.3994845,10030.49485,433.3350515,113.1056701,5901.690722,8431.690722,1504.417526,667.5180412,2822.670103,6898.796392,649.507732,241.3170103,8720.118557,5397.981959,800.0773196,361.6314433,1292.319588,3504.430412,611.8634021,147.0103093,3452.31701,3123.386598,1062.966495,163.1649485,3160.778351,968.8608247,495.628866,388,27.80872037,19.14880602,0.725150914,0.881818182,0.621794872,-0.59111328
+2098,20694.99145,890.9401709,538.2564103,1064.555556,18305.4359,671.8717949,556.9401709,1467.393162,10307.76923,536.3333333,460.4786325,1736.564103,14323.42735,1229.709402,7280.923077,2485.854701,5203.74359,1293.136752,343.3076923,2386.350427,10293.88034,473.1282051,746.8205128,450.8205128,11418.53846,398.4102564,121.6923077,4597.384615,8904.358974,1447.74359,779.2820513,2794.555556,7841.076923,665.957265,273.008547,1970.794872,6139.264957,794.6666667,422.982906,1380.376068,4814.273504,735.8034188,168.974359,5351.264957,4402.692308,1288.17094,370.4273504,3276.564103,348.4188034,489.008547,117,12.79898592,11.81961235,0.383645658,0.966942149,0.642857143,-0.502516898
+2099,27647.26842,759.1894737,452.3052632,1047.121053,23267.41053,616.6210526,558.8105263,1507.936842,13270.53684,490.5315789,764.8631579,1808.278947,18902.55789,1211.505263,5234.563158,3627.089474,6901.605263,1242.831579,314.0421053,2470.247368,13758.77895,416.6157895,192.0631579,705.5526316,16431.4,1210.168421,115.8631579,3563.047368,12419.51053,1364.357895,695.6368421,2788.821053,11031.74211,649.6315789,250.8210526,1988.589474,8831.257895,1238.742105,383.9789474,1305.494737,6843.810526,641.2842105,159.3315789,4312.973684,5928.389474,1247.610526,432.2631579,3168.915789,651.3947368,493.7789474,190,22.46375643,11.49001887,0.859288379,0.87962963,0.558823529,-0.625697816
+2100,25981.89189,757.6486486,488.9324324,1046.932432,23550.66216,615.2702703,548.4864865,1474.662162,12483.95946,473.3648649,453.0810811,1723.027027,18731.12162,1174.783784,4960.472973,3485.918919,6476.040541,1180.864865,345,2435.405405,12611.68919,464.7567568,2124.108108,501.5,15461.45946,381.1756757,117.4189189,2948.608108,11707.37838,1639.202703,600.4324324,2789.135135,10067.09459,718.6486486,257.4594595,3959.959459,8153.202703,846.2567568,399.027027,1323.135135,5888.891892,1296.905405,154.7837838,3939.22973,5134.337838,1213.918919,1234.108108,3153.783784,845.9189189,488.5405405,74,11.17369614,9.188168319,0.569049312,0.925,0.611570248,0.653197571
+2101,36674.85053,891.8113879,674.5765125,1294.914591,23190.57651,578.0960854,584,1817.580071,11251.45907,470.0569395,1025.640569,1807.498221,15954.94306,1085.562278,9806.982206,3831.740214,6157.085409,1155.871886,358.1992883,3592.398577,11459.66904,858.4875445,624.9003559,814.886121,13885.46619,386.7117438,214.9786477,13106.21352,9926.19573,1729.103203,681.9572954,2805.309609,8276.245552,528.7580071,245.9466192,6482.797153,4830.423488,844.4626335,364.9145907,1278.711744,3890.86121,670.1423488,150.6512456,3476.117438,3373.263345,1086.30605,278.4697509,3164.893238,157.7046263,496.0569395,281,25.5253045,14.67247388,0.818279378,0.955782313,0.53219697,-0.621236132
+2102,43220.81915,877.2234043,493.7659574,1089.755319,37914.90426,723.9361702,618.9042553,1581.946809,21690.15957,558.6595745,472.8723404,1766.840426,29796.26596,1357.180851,3758.510638,3486.212766,10724.85106,1432.37234,382,2413.648936,22114.11702,639.4893617,285.6702128,472.4255319,24863.37234,434.2234043,133.5957447,3371,19107.32979,1655.659574,788.8723404,2814.053191,17010.24468,653.2234043,310.1489362,1894.393617,13655.40426,951.606383,472.8829787,1336.425532,10574.55319,734.9361702,185.8510638,3652.255319,9241.5,1440.723404,355.7021277,3281.414894,436.6276596,490.4361702,94,15.88542265,8.698725966,0.836745663,0.758064516,0.516483516,-0.8012252
+2103,18770.54032,812.5080645,462.6693548,1042.233871,16212.37097,640.0483871,493.9112903,1393.548387,9173.298387,498.8306452,381.0725806,1719.459677,12603.94355,1261.959677,2105.403226,1025.612903,4579.612903,1372.435484,353.483871,2401,9298.612903,434.0806452,452.2016129,432.0967742,10715.70968,392.6209677,122.6935484,964.6209677,8390.927419,1411.306452,657.0645161,2804.709677,7387.314516,723.9354839,256.4032258,1504,5992.362903,791.266129,418.8306452,1314.137097,4747.927419,709.3306452,163.733871,2886.717742,4162.919355,1332.096774,725.8467742,3073.483871,547.5645161,490.7177419,124,14.65366643,10.89212681,0.668953939,0.953846154,0.688888889,0.313982543
+2104,43526.86087,852.1014493,467.7652174,1098.669565,37252.41159,705.7507246,578.7884058,1605.104348,21382.66087,541.2289855,1077.826087,1774.617391,29951.05217,1311.872464,3687.263768,3229.168116,10643.84348,1312.553623,363.6492754,2720.973913,21314.33333,482.226087,185.7681159,676.2,25507.97971,491.9101449,153.0289855,2619.118841,19786.52754,1829.530435,740.4376812,2804.133333,17253.1913,656.0173913,287.4608696,1761.365217,14301.88986,1209.947826,429.0289855,1312.904348,10530.5971,661.7855072,164.0666667,2578.776812,8966.411594,1375.646377,225.2086957,3237.855072,741.657971,495.6405797,345,27.36192241,16.5019414,0.797666527,0.90078329,0.552,-0.720385863
+2105,27171.68817,770.311828,446.8924731,1067.123656,24076.50538,641.311828,549.8333333,1523.080645,13796.47312,496,1270.623656,1799.537634,19521.22581,1200.978495,4269.655914,3195.145161,7026.209677,1205.612903,333.688172,2602.672043,13932.76882,548.7150538,314.3709677,936.0322581,16669.93011,774.0430108,199.6182796,2050.38172,12947.62903,1759.112903,553.1075269,2841.962366,11121.11828,879.8924731,256.6236559,2055.182796,9154.908602,1745.16129,406.4247312,1296.489247,6789.252688,664.844086,160.9731183,3382.16129,5814.494624,1249.607527,468.6505376,3219.38172,794.7956989,492.6612903,186,19.15504729,12.9332488,0.737646134,0.881516588,0.664285714,0.263744503
+2106,32189.25234,774.5700935,514.1028037,1074.140187,12524.50467,485.635514,546.3831776,1314.551402,6568.11215,392.0560748,959.6915888,1685.542056,10044.02804,962.953271,7719.271028,3989.88785,3695.345794,1022.457944,286.1682243,4601.682243,7247.859813,1131.794393,129.0747664,624.1214953,8145.299065,329.2616822,104.8785047,5612.130841,7037.990654,1801.009346,629.9158879,2766.934579,5985.897196,497.1775701,211.2990654,4662.065421,4791.242991,1097.28972,341.8878505,1294.317757,3449.981308,545.2897196,143.5981308,2740.35514,3061.317757,1020.691589,186.4672897,3048.485981,917.4392523,491.8037383,107,14.09318175,9.941716475,0.708782189,0.938596491,0.594444444,-0.105345155
+2107,27269.43878,878.6020408,468.0204082,1057.193878,22605.36735,660.5714286,386.4795918,1500.081633,13353.34694,528.8367347,403.2857143,1716.816327,18888.04082,1240.122449,5098.714286,2524.714286,6588.979592,1257.846939,330.6530612,2359.295918,13494.14286,552.8265306,282.4591837,458.6428571,15882.45918,370.3163265,108.4897959,2556,12084.71429,1467.581633,675.122449,2783.510204,10667.09184,633.4591837,243.5612245,1657.132653,8546.459184,815.877551,378.8673469,1294.214286,6476.959184,642.8571429,149.8265306,3009.387755,5590.806122,1233.94898,210.8673469,3194.040816,671.5816327,491.1020408,98,14.17636304,9.177521409,0.762165746,0.91588785,0.685314685,0.349745357
+2108,12965.14865,705.777027,391.6756757,1005.324324,11288.93243,567.7162162,356.1554054,1309.472973,6417.168919,440.7297297,371.8108108,1718.851351,9071.695946,1079.675676,1417.121622,1115.243243,3346.081081,1102.135135,297.3378378,2409.804054,6447.189189,361.4256757,166.3783784,441.7162162,7687.425676,333.4256757,102.6148649,974.2094595,6099.391892,1233.587838,554.3243243,2801.939189,5435.175676,627.6418919,226.6756757,1428.891892,4541.743243,704.3243243,359.6013514,1283.560811,3423.493243,592.0608108,146.0608108,1924.763514,3014.425676,1161.695946,2709.472973,3069.168919,710.0540541,491.9391892,148,15.95891427,11.92846258,0.664320036,0.961038961,0.755102041,-0.648617077
+2109,21393.33166,743.4489112,526.8693467,1092.956449,17326.88777,586.1306533,588.9882747,1636.246231,8613.778894,445.6968174,815.9899497,1769.514238,13012.86265,1112.167504,5351.165829,2305.770519,4758.102178,1128.169179,315.9279732,3442.733668,8919.149079,7390.621441,175.1256281,589.5376884,10529.69682,479.2881072,116.7051926,5433.380235,8675.929648,1616.125628,615.6499162,2852.237856,7073.569514,712.5125628,247.9480737,9668.603015,5526.59464,837.0067002,372.4321608,1311.515913,3509.931323,666.8659966,149.3031826,4490.393635,3161.147404,1090.566164,201.8576214,3205.79397,990.6666667,499.3015075,597,29.90991096,26.40264406,0.469863711,0.927018634,0.740694789,0.422699283
+2110,53229.13043,929.5869565,566.7934783,1164.195652,53102.90217,782.4347826,575.5326087,1878.576087,27641.66304,600.0978261,534.9782609,1828.48913,37721.58696,1398.891304,7828.597826,6263.923913,14603.15217,1481.097826,408.6413043,2372.347826,28916.36957,474.2826087,149.9565217,438.2717391,34836.36957,476.8369565,140.1630435,5213.695652,26169.26087,1570.684783,716.9565217,2842.271739,22504.33696,639.0652174,332.7826087,3349.195652,16393.5,902.2717391,477.2065217,1308.913043,12645.22826,666.2282609,183.923913,3571.902174,10289.86957,1445.76087,174.673913,3337.173913,221,490.2608696,92,13.60068079,8.945367054,0.753267173,0.948453608,0.73015873,-1.474090681
+2111,42741.98507,1013,661.6567164,1139.313433,37089.65672,746.4179104,720.3432836,1659.208955,20740.20896,585.6268657,683.2686567,1789.373134,29751.26866,1418.074627,6584.268657,3348.791045,10351.80597,1459.835821,392.119403,2486.059701,21905.83582,522.8358209,307.5074627,554.5522388,24539.10448,471.1940299,137.5074627,3884.014925,18704.07463,1745.716418,806.119403,2832.731343,16404.08955,650.9850746,321.7164179,1622.895522,13003.44776,1000.119403,472.4029851,1333.507463,10201.47761,720.238806,184.5970149,2797.880597,8773.477612,1411.492537,174.4029851,3342.343284,473.7014925,491.1492537,67,10.32095161,8.963957843,0.495653282,0.858974359,0.609090909,-0.482065921
+2112,13949.4,735.1294118,517.6588235,1053.329412,11687.61176,606.5529412,555.4823529,1414.341176,6747.788235,465.1058824,456.3529412,1731.811765,9403.882353,1175.670588,3798.152941,2423.247059,3508.776471,1258.552941,314.4117647,2407.458824,6899.6,420.8117647,1662.905882,470.2117647,7869.082353,473.0823529,107.8470588,1407.352941,6087.694118,1456.529412,919.8705882,2800.117647,5301.4,753.3882353,245.6588235,1813.882353,4266.188235,991.4117647,386.0117647,1305.035294,3454.670588,1008.094118,145.9647059,2436.717647,2934.552941,1238.929412,777.0705882,3087.058824,601.6352941,492.6823529,85,11.07157075,10.49291619,0.319058277,0.904255319,0.544871795,0.108756995
+2113,29356.14,768.65,447.32,1064.71,23576.01,634.45,512.99,1517.43,13845.25,585.23,748.38,1771.38,19446.32,1206.93,4357.42,3428.06,6997.66,1246.46,354.41,2729.04,14170.94,471.17,586.59,712.09,16886.45,720.05,111.22,2010.03,12697.77,1485.94,685.25,2778.04,11103.27,784.73,251.82,1674.31,8975.32,1063.87,393.52,1344.47,6818.02,742.21,156.89,3535.32,5902.59,1260.85,265.42,3128.61,662.82,493.18,100,14.68734617,9.044615107,0.787894666,0.884955752,0.666666667,-0.094667423
+2114,30052.60909,780.0909091,431.6636364,1071.045455,27463.5,645.7545455,573.7545455,1544.090909,15130.03636,513.2545455,1780.136364,1777.554545,20761.58182,1202.845455,5706.518182,2890.554545,7575.172727,1225.954545,333.5,4006.218182,15081.49091,478.3181818,597.5545455,1567.709091,18264.99091,398.6636364,125.6818182,2347.954545,13934.65455,2055.509091,579.4363636,2802.290909,11778.77273,611.9818182,259.9363636,1813.881818,9569.272727,1268.2,406.3818182,1303.181818,7150.736364,746.6,155.2,2507.036364,6011.4,1234.663636,483.6181818,3199.181818,818.5636364,493.4090909,110,13.59442375,10.61791282,0.624469582,0.924369748,0.611111111,0.445412923
+2115,24976.56667,740.7666667,553.7666667,1071.841667,20520.98333,603.7916667,970.45,1571.775,11119.05,457.85,1763.583333,1777.033333,15900.19167,1117.433333,7569.175,4169.291667,5650.683333,1134.433333,321.6416667,5821.616667,11340.38333,452.6666667,703.7583333,964.55,13073.36667,394.6083333,118.9833333,5650.775,10728.75,2394.566667,620.0083333,2790.175,9117.216667,565.7,251,12349.03333,7125.625,1506.983333,378.3583333,1324.825,5110.083333,781.0833333,164.1416667,5548.008333,4487.358333,1124.933333,512.525,3155.041667,902.875,491.6083333,120,13.68939702,11.26776959,0.567893612,0.983606557,0.659340659,0.952325682
+2116,25398.12658,820.0759494,694.0759494,1108.341772,21490.16456,636.6835443,527.3037975,1788.164557,11350.94937,471.7848101,665.1012658,1786.101266,17104.91139,1218.949367,11420.49367,5227.64557,6043.797468,1188.683544,331.2151899,3614.164557,11789.58228,1408.924051,295.1265823,541.1012658,13753,445.5443038,124.2405063,13025.56962,11409.65823,1605.063291,818.1898734,2805.240506,9294.202532,596.3797468,271.7341772,21842.24051,7396.101266,934.2025316,393.9493671,1332.607595,4922.189873,681.7341772,160.3291139,6145.936709,4451.924051,1179.860759,220.3924051,3223.734177,957.9620253,490.3797468,79,13.21120897,8.021767358,0.794553584,0.929411765,0.652892562,-0.831671804
+2117,30760.21622,874.972973,541.4459459,1083.027027,28656,711.7837838,544.6351351,1554.283784,15418.01351,557.527027,572.7432432,1746.918919,21393.04054,1320.905405,4824.662162,3546.121622,7898.175676,1403.608108,374.3783784,2443.486486,16726.43243,447.5810811,1056.418919,538.6756757,18616.52703,435.8378378,133,3302.364865,14118.89189,1719.837838,925.1351351,2810.621622,12650.01351,793.5135135,294.3918919,1796.459459,10202.93243,954.9864865,440.7567568,1366.027027,8201.486486,907.6891892,181.0135135,4561.121622,6908.662162,1403.175676,924.1351351,3262.472973,426.6891892,493.7432432,74,13.76009386,7.784594996,0.824585704,0.860465116,0.569230769,-0.606727379
+2118,31273.35052,886.4845361,519.0721649,1094,25137.38144,663.8762887,470.0103093,1513.14433,13845.93814,532.2268041,593.814433,1750.28866,19958.47423,1287.072165,6090.247423,2376.56701,7084.103093,1330.505155,357.0721649,2452.247423,14755.3299,436.7319588,824.6391753,525.0412371,16532.20619,398.0103093,126.5773196,4333.329897,12809.3299,1531.051546,782.3814433,2811.804124,11201.01031,632.0309278,267.8041237,1560.185567,8722.639175,889.3505155,421.3195876,1318.360825,6912.072165,792.1958763,163.5979381,2740.85567,5843.649485,1294.865979,306.0515464,3425.463918,465.1340206,492.9587629,97,15.33700911,8.625526278,0.826865648,0.843478261,0.532967033,0.594883832
+2119,34753.64706,857.1372549,505.5882353,1081.078431,28523.92157,678.5490196,474.1764706,1561.470588,16757.96078,560.7843137,552.1764706,1787.666667,24317.64706,1373.588235,4099.235294,2833.764706,8736.882353,1397.254902,372.6862745,2596.411765,17005.27451,467.2941176,812.2352941,465.4705882,20096.4902,477.1764706,127.3137255,2331.098039,15689.62745,1628.509804,749.8431373,2795.607843,13389.98039,830.4901961,295.0980392,1728.862745,10520.56863,953.5686275,445.1764706,1315.431373,7903.941176,839.2156863,175.0980392,5437.54902,6668.764706,1376.156863,1640.372549,3245.72549,495.5686275,491.6862745,51,9.513426652,7.281555422,0.643557514,0.894736842,0.708333333,-0.438134085
+2120,31495.83568,900.5868545,594.9859155,1100.56338,27532.52582,709.7511737,708.4929577,1645.737089,15214.7277,515.370892,625.5492958,1775.690141,22779.29108,1286.901408,5304.784038,3753.652582,7996.802817,1265.126761,372.1455399,2878.248826,16042.10329,692.5539906,2510.830986,840.8356808,19352.88732,459.3755869,140.4741784,4028.201878,15248.07042,1737.553991,611.7652582,2791.342723,13061.48357,659.1596244,284.8873239,5575.42723,10638.13146,1018.441315,425.2253521,1373.164319,7581.788732,1398.262911,171.4929577,5043.882629,6624.380282,1322.685446,304.4507042,3323.737089,869.0798122,496.2957746,213,18.90368748,16.13277187,0.521224986,0.794776119,0.560526316,-1.53592783
+2121,27458.57025,825.9008264,526.9256198,1090.322314,24645.70248,666.2396694,528.6528926,1561.31405,13919.39669,535.1570248,619.5123967,1792.636364,18641.92562,1234.31405,6341.165289,3874.322314,6790.867769,1310.768595,353.0826446,2397.652893,13946.7438,2542.206612,235.9834711,455.1735537,16581.00826,450.7024793,123.1157025,4782.652893,12494.58678,1470.710744,826.9752066,2797.049587,10980.32231,680.5123967,284.1652893,2391.347107,8544.214876,886.768595,433.214876,1299.446281,6744.570248,668.2727273,169.231405,6077.933884,5940.190083,1311.214876,543.8512397,3301.479339,325.1818182,492.8760331,121,15.99732608,10.36068558,0.761937053,0.902985075,0.630208333,-1.200230261
+2122,37727.48171,986.7560976,524.3536585,1090.97561,31731.26829,697.2987805,501.1158537,1492.506098,17253.31707,551.0243902,450.8902439,1731.371951,23802.20732,1290.128049,3733.640244,1971.073171,8647.981707,1393.109756,370.6585366,2383.091463,16315.59146,454.2804878,392.2682927,427.2134146,19233.76829,397.1707317,129.8597561,2385.609756,14549.25,1468.170732,693.5792683,2819.213415,12814.98171,656.8536585,289.5182927,1323.762195,9870.689024,821.7012195,441.7865854,1334.932927,7658.79878,686.9512195,176.9939024,2930.932927,6957.676829,1351.847561,166.1341463,3211.121951,358.9268293,494.7073171,164,20.18953166,10.77031598,0.845825031,0.886486486,0.546666667,-1.095893792
+2123,21801.18812,885.0594059,536.2673267,1090.811881,18805.86139,692.4752475,497.1980198,1538.306931,10622.47525,544.4851485,498.3366337,1772.80198,14807.22772,1304.742574,4384.039604,2478.554455,5314.920792,1321.336634,357.6138614,2407.29703,9881.217822,434.009901,1862.356436,488.2673267,11653.0396,431.009901,123.3663366,2158.445545,9335.950495,1524.881188,780.7623762,2823.009901,8108.881188,855.6336634,260.7920792,1575.29703,6443.287129,851.3564356,422.6633663,1368.60396,5063.663366,1023.693069,161.970297,4565.861386,4161.811881,1259.287129,228.8415842,3233.633663,503.970297,493.6534653,101,13.4931684,9.655393968,0.698534394,0.926605505,0.706293706,-0.191987517
+2124,19308.76068,790.9145299,521.3675214,1052.350427,16579.84615,643.8119658,478.3333333,1419.632479,9888.923077,517.7606838,547.5811966,1759.803419,13587.05983,1259.367521,7130.094017,2932.675214,4765.632479,1442.367521,340.4615385,2444.726496,10098.81197,433.2735043,1439.367521,550.7179487,11431.18803,472.0598291,122.4358974,1834.931624,9079.897436,1592.871795,841.5042735,2804.965812,8014.769231,644.4871795,267.8119658,1680.102564,6472.923077,982.7094017,417.3247863,1324.794872,5035.239316,950.2307692,168.6068376,3499.726496,4491.145299,1313.803419,622.0512821,3119.905983,570.034188,494.3247863,117,12.58452878,12.04798427,0.288881865,0.983193277,0.642857143,-0.424926593
+2125,44128.80769,864.2884615,562.4423077,1109.557692,42952.01923,735.4423077,821.2884615,1735.346154,23434.13462,573.4038462,666.6538462,1823.288462,31904.88462,1322.038462,7895.903846,3629.192308,11812.65385,1420.634615,386.8076923,2844,23792.55769,485.9230769,153.7692308,516.25,29012.73077,452.9615385,138.3653846,5191.173077,22412.69231,1550.576923,676.3076923,2839.826923,19088.19231,629.6346154,314.5769231,3855.480769,14190.82692,876,469.3846154,1331.711538,10920.38462,675.7884615,183.7115385,4500.807692,9301.307692,1414.288462,201.1730769,3346.5,237.1346154,492.3846154,52,10.03830693,6.813350359,0.734383269,0.928571429,0.722222222,0.79035227
+2126,20239.64035,1164.394737,607.377193,1043.719298,16821.33333,763.1403509,839.3070175,1427.096491,9551.877193,625.4473684,1438.385965,1786.789474,13403.54386,1338.035088,6080.719298,2755.394737,4651.614035,1269.517544,361.2017544,2563.412281,9761.964912,423.9561404,887.0877193,938.9473684,11133.70175,469.4912281,256.7017544,2826.482456,8533.77193,2126.315789,669.9473684,2790.596491,7519.192982,655.1929825,242.6052632,1343.973684,6015.245614,1149.95614,396.9649123,1345.605263,4563.429825,906.0263158,154.3333333,2886.149123,3942.850877,1159.342105,213.254386,3435.307018,514.7017544,494.9649123,114,12.51109914,11.71869184,0.350230209,0.966101695,0.791666667,-0.445484051
+2127,29988.72872,900.2739362,509.2234043,1071.707447,25520.83511,698.8351064,575.0904255,1506.039894,14765.24202,554.3723404,592.2845745,1764.106383,20070.48138,1326.303191,2716.898936,2442.731383,7143.462766,1477.962766,371.2898936,2476.444149,14285.70479,467.6675532,669.0026596,534.6117021,16681.67287,453.8803191,125.4281915,1991.239362,12795.44149,1622.68617,775.6675532,2873.654255,11430.87234,794.5292553,278.3297872,1645.973404,9116.361702,974.2606383,451.7260638,1353.510638,7078.667553,845.2898936,172.7792553,4803.670213,6181.81117,1346.010638,272.0026596,3208.082447,531.5425532,500.5026596,376,27.07031571,17.84384948,0.751996888,0.971576227,0.68115942,-0.753920481
+2128,43254.65517,854.2413793,480.0517241,1107.37931,37064.68966,725.4137931,577.3793103,1665.913793,22083.74138,526.5517241,676.862069,1760.827586,30091.46552,1303.206897,3588.586207,3253.344828,10755.53448,1302.086207,358.7241379,2428.448276,21689.22414,489.5517241,259.6034483,681.5172414,25523.82759,409.7068966,152.1551724,2614.758621,20585.53448,1567.655172,745.4137931,2828.310345,17422.41379,642.0689655,289.7413793,1895.931034,14142.7069,913.3793103,428.8275862,1311.844828,9976.189655,676.4137931,161.1896552,2351.241379,8609.103448,1324.810345,261.2931034,3228.896552,805.0689655,492.8103448,58,10.85593233,7.885859701,0.687261419,0.852941176,0.527272727,-1.238389995
+2129,46731.5478,927.7416021,592.881137,1158.248062,22353.44961,532.248062,367.7700258,1464.599483,9946.403101,400.7235142,619.8165375,1641.121447,16102.17829,1029.643411,5324.248062,2385.18863,6006.382429,1054.211886,289.9534884,2891.591731,11010.5478,1117.312661,319.0542636,515.8423773,13370.08527,354.9250646,107.875969,3801.72093,10096.6124,1562.289406,469.0852713,2783.191214,7920.994832,508.3462532,228.5064599,3167.118863,5563.599483,727.7571059,340.9560724,1272.271318,2828.731266,636.2997416,136.2687339,1612.589147,2923.093023,954.6589147,163.8036176,3035.126615,1084.286822,498.5736434,387,31.25183693,16.82428598,0.842724223,0.846827133,0.56744868,-1.23552641
+2130,45754.07469,899.626556,575.6348548,1132.589212,40697.77178,733.7178423,623.7551867,1693.340249,22858.48133,580.4896266,621.1908714,1794.070539,31266.58091,1351.40249,9042.775934,5887.016598,11332.78423,1425.792531,383.1701245,2472.647303,23253.64315,460.1825726,152.2406639,478.2323651,27432.93776,455.8340249,135.6887967,5565.091286,21385.25311,1598.643154,955.439834,2825.6639,18799.65145,672.7634855,316.746888,2853.651452,14194.6805,927.9045643,466.2946058,1311.182573,11126.28631,659.5103734,182.3609959,4467.099585,9372.045643,1421.605809,236.9170124,3344.278008,283.8506224,500.6887967,241,25.60999722,12.31727403,0.876744899,0.919847328,0.573809524,-0.869610997
+2131,47079.42045,1064.545455,545.5340909,1120.409091,41635.44318,758.4431818,803.7727273,1657.931818,24384.79545,619.8409091,1735.477273,1822.829545,33057.97727,1401.681818,6623.068182,4020.238636,11908.60227,1459.704545,403.2613636,2526.681818,23238.27273,480.6363636,149.8863636,856.3409091,28219.36364,456.6136364,136.1704545,3579.897727,21900.20455,1985.693182,827.875,2825.045455,18972.35227,635.7954545,313.7613636,1816.806818,14583.76136,1039.204545,461.2386364,1313.977273,11287.13636,657.2272727,178.5113636,2405.011364,9873.318182,1443.352273,197.2272727,3358.090909,311.6704545,493.6818182,88,13.61885609,8.596312791,0.775614686,0.967032967,0.846153846,-1.426668652
+2132,22838.54128,1060.66055,561.7706422,1082.321101,19800.31193,688.2018349,638.3853211,1495.073394,10995.40367,557.3486239,654.7706422,1770.100917,15689.55046,1274.238532,5097.036697,2848.724771,5677.229358,1297.431193,366.6146789,2580.385321,11972.88073,443.1651376,677.8623853,703.0275229,13858.17431,462.6055046,127.3119266,4517.587156,10782.77064,1792.880734,694.2752294,2801.688073,9546.954128,688.5045872,287.2752294,1829.220183,7517.385321,1000.422018,435.5963303,1340.807339,5993.036697,805.6880734,176.9908257,5686.715596,5310.568807,1311,153.7155963,3327.12844,396.733945,495.3394495,109,15.3869405,9.18563952,0.802258837,0.908333333,0.707792208,-1.085799473
+2133,20512.26452,740.9935484,417.7870968,1038.464516,17924.39355,607.1419355,520.5419355,1409.180645,9986.716129,553.0580645,483.4064516,1737.329032,14375.59355,1183.251613,3266.8,2592.045161,5098.980645,1210.309677,314.3290323,2545.896774,10123.67742,408.4258065,564.4967742,508.9032258,11773.04516,508.6645161,110.483871,1706.806452,9252.806452,1413.077419,749.4709677,2785.722581,8138.870968,701.3290323,242.7096774,1730.754839,6531.451613,855,377.9354839,1319.548387,5197.916129,974.9483871,151.1483871,2398.458065,4502.754839,1244.658065,777.7741935,3107.864516,619.4064516,496.6645161,155,18.46619102,11.81582906,0.768489149,0.890804598,0.509868421,-0.859178928
+2134,23855.65476,936.5357143,480.047619,1056.964286,19492,582.3095238,465.6428571,1434.797619,11802.97619,479.0952381,771.75,1742.988095,15932.30952,1174.559524,4781.904762,3134.440476,5786.27381,1204.607143,311.6547619,2466.75,11596.22619,406.9047619,496.5119048,892.9047619,13444.27381,421.5595238,109.75,3696.297619,10550.60714,1441.72619,737.9166667,2772.154762,9220.142857,621.5833333,239.2261905,1832.02381,7314.738095,1128.154762,378.1666667,1305.428571,5691.011905,770.8928571,150.3095238,3077.071429,4951.416667,1225.22619,638.5,3121.595238,630.4880952,495.5119048,84,13.61519384,8.220361458,0.797163251,0.923076923,0.583333333,-0.702554834
+2135,38344.51695,815.8220339,469.2711864,1081.533898,32783.28814,680.3728814,731.1016949,1593.466102,18735.95763,517.3305085,1341.042373,1782.288136,26085.92373,1269.745763,4719.322034,3209.152542,9455.364407,1267.364407,352.3220339,2856.661017,18836.98305,472.4237288,488.3813559,1188.898305,22444.29661,428.1440678,124.6016949,2800.966102,17617.33898,2082.152542,559.8135593,2812.076271,15196.66949,917.3644068,273.220339,1822.050847,12196.65254,1222.381356,416.5762712,1302.627119,8562.050847,722.7627119,160.059322,3481.983051,7447.508475,1277.313559,286.9915254,3259.254237,829.5508475,496.7881356,118,12.97837881,12.42559262,0.28874133,0.921875,0.698224852,-1.270916948
+2136,48257.63033,910.6303318,623.0947867,1173.554502,22783.60664,537.0473934,476.2701422,1438.540284,11705.14692,427.6777251,719.6919431,1720.777251,15974.34597,1020.388626,7215.753555,3518.061611,6371.421801,1102.199052,306.9620853,2394.71564,12166.11848,389.6161137,108.0616114,493.8530806,14471.41232,323.943128,441.5924171,7725.938389,10701.76303,1328.952607,544.943128,2796.383886,8928.981043,498.7156398,229.7156398,2429.92891,5640.336493,686.507109,364.8625592,1269.900474,4438.862559,545.1232227,147.07109,2087.582938,3787.691943,1036.71564,165.0616114,3068.971564,168.9668246,502.1658768,211,22.37441028,13.02163524,0.813197471,0.844,0.528822055,-0.497053454
+2137,53217.82645,917.2644628,592.1570248,1161.950413,53437.66116,761.8347107,712.0661157,1776.983471,28741.55372,605.7520661,630.7438017,1805.14876,39515.00826,1399.495868,8806.768595,6639.264463,14311.95041,1490.297521,401.0495868,2874.454545,29304.07438,478.8429752,154.4793388,642.107438,35606.53719,468.8595041,144.322314,5799.46281,27610.7686,1689.008264,753.661157,2831.545455,23256.38843,638.2396694,327.4793388,3165.198347,17395.35537,957.2727273,483.0413223,1314.446281,12955.04132,673.9090909,185.0578512,3831.917355,10894.92562,1455.553719,178.8016529,3395.677686,229.0661157,498.322314,121,16.09244538,10.23017358,0.771925664,0.902985075,0.581730769,-0.366692333
+2138,49157.4,897.6,548.5285714,1117.1,46044.15714,755.5285714,710.5571429,1700.2,25366.27143,591.0714286,899.6571429,1825.171429,35121.4,1339.171429,8117.528571,5176.842857,12795.47143,1444.171429,389.1714286,2702.342857,26448.8,462.4142857,146.2714286,570.6,30972.28571,437.8285714,135.5857143,4574.914286,24515.72857,1723.3,816.8142857,2859.885714,21372.51429,661.4857143,330.3,3201.128571,15977.64286,971.1285714,479.6857143,1307.442857,12338.07143,675.8857143,181.7285714,3586.742857,10397.77143,1428.657143,336.6714286,3315.057143,256.6571429,494.8428571,70,11.91344559,7.769512499,0.758078475,0.921052632,0.648148148,-1.280825539
+2139,41016.90378,884.8109966,597.0309278,1112.731959,37342.31615,720.5704467,589.8419244,1667.305842,20735.95533,568.0652921,694.1683849,1797.041237,28361.48797,1296.164948,8691.106529,6330.498282,10371.27835,1393.780069,375.7319588,2622.04811,22205.55326,449.5532646,151.0412371,502.3539519,25191.90378,439.7697595,135.3298969,5314.457045,19565.50172,1634.140893,1000.151203,2816.821306,17271.53265,642.6941581,313.0343643,2991.027491,13036.23368,908.3642612,460.3264605,1310.800687,10260.5567,666.814433,184.580756,5307.213058,8410.109966,1392.810997,300.6013746,3304.969072,266.8728522,504.9828179,291,32.15378643,12.65296147,0.919318672,0.826704545,0.461904762,-0.370414011
+2140,36606.51887,858.9528302,524.6320755,1085.40566,32137.18868,712.5283019,915.6698113,1550.235849,18527.85849,563.8396226,1613.575472,1777.745283,26047.4717,1328.811321,6922,3702.660377,9231.037736,1376.754717,362.3018868,2509.283019,18654.41509,470.2169811,524.3396226,1123.481132,21779.56604,472.9811321,132.7924528,4680.433962,17180.14151,2061.716981,802.5754717,2829.301887,15128.4717,644.5471698,299.9433962,1656.424528,11982.29245,1053.867925,454.8867925,1318.537736,9075.471698,750.3679245,177.3867925,3942.867925,8063.320755,1387.207547,242.3207547,3308.990566,458.4339623,499.509434,106,15.77153459,9.215386372,0.811534151,0.905982906,0.56684492,-0.082782979
+2141,23289.74336,821.3672566,519.2212389,1048.513274,20120.31858,665.2035398,531.9424779,1449.39823,11368.32743,510.0752212,467.3716814,1727.734513,15598.76549,1273.163717,3222.659292,2595.566372,5624.584071,1330.5,347.2212389,2435.300885,11557.61504,447.3761062,703.0619469,501.9070796,13332.53982,415.6946903,123.1681416,2276.884956,10383.5177,1482.99115,758.0176991,2807.482301,9232.845133,725.1725664,269.9159292,1853.787611,7356.460177,909.3584071,421.7300885,1313.358407,5696.283186,791.5,165.9867257,3757.19469,4998.176991,1334.783186,407.920354,3132.29646,557.2964602,501.6946903,226,21.78735579,13.65073949,0.77938596,0.933884298,0.604278075,-0.355362941
+2142,16791.37255,756.4215686,657.4117647,1100.068627,8209.931373,389.4509804,296.5784314,1064.166667,4238.176471,328.7156863,442.0588235,1590.960784,6346.156863,801.5294118,3205.852941,1184.627451,2346.196078,874.5196078,239.4313725,2662.137255,4343.676471,526.6764706,128.6078431,427.7745098,5116.039216,253.0686275,89.11764706,1769.980392,4170.392157,1128.254902,476.9607843,2752.205882,3319.598039,437.5,178.8137255,2255.078431,2590.460784,570.2647059,297.6568627,1246.509804,1552.980392,504.8235294,126.7156863,1039.598039,1479.656863,810.3431373,91.98039216,2852.088235,1018.401961,497.2941176,102,12.03543177,10.89174549,0.42546817,0.971428571,0.653846154,-0.729476933
+2143,44115.80233,945.1569767,525.4651163,1160.627907,12066.9593,413.1162791,186.372093,1183.796512,4972.383721,332.0872093,203.3023256,1585.063953,8339.860465,832.2209302,2140.976744,1134.337209,3040.331395,871.75,242.25,2292.959302,5409.232558,256.4825581,76.77906977,359.0174419,6258.127907,251.2906977,91.38372093,1830.848837,4835.488372,1064.011628,428.6918605,2771.488372,3707.906977,431.4011628,174.9244186,1010.976744,2292.186047,534.75,295.2790698,1251.424419,1070.924419,461.372093,120.1453488,659.0581395,1178.534884,795.1162791,73.0872093,2854.302326,1112.854651,498.3895349,172,15.61484129,14.06022695,0.434980335,0.971751412,0.716666667,0.408344114
+2144,59246.72632,1003.315789,588.7263158,1173.557895,51220.64211,774.6842105,661.8947368,1886.589474,27088.98947,596.6105263,522.2736842,1758.684211,36397.27368,1387.389474,9885.536842,6147.842105,13911.93684,1469.515789,400.3894737,2388.073684,27451.76842,472.6315789,158.0947368,447.4421053,32590.38947,447.3789474,143.2947368,9343.526316,24350.42105,1547.726316,624.0210526,2832.726316,20439.87368,635.0947368,322.4421053,7214.021053,13057.65263,844.2526316,468.5894737,1324.336842,10214.35789,645.1789474,179.9578947,2827.631579,8421.273684,1353.736842,198.4105263,3243.326316,180.8631579,498.5473684,95,15.29091451,8.130501376,0.84691954,0.922330097,0.521978022,-0.586189244
+2145,45337.95062,863.7407407,560.3580247,1128.574074,44244.93827,731.7530864,581.7962963,1798.759259,23077.45062,597.9753086,648.6481481,1812.117284,32486.56173,1327.376543,8404.580247,5733.487654,12555.52469,1431.438272,399.4876543,2433.339506,24057.62346,449.6358025,697.7716049,480.1666667,28627.94444,635.5493827,138.0493827,5846.32716,21477.35802,1517.882716,638.845679,2840.864198,18185.33333,665.3703704,312.2716049,5565.537037,12295.96914,960.154321,446.4012346,1330.925926,9721.246914,772.882716,181.537037,4005.944444,7956.524691,1379.012346,199.8395062,3347.993827,193.5864198,498.9259259,162,20.64342455,11.49394941,0.830656637,0.798029557,0.50625,-1.076729745
+2146,28993.8227,830.2021277,528.3156028,1073.109929,25824.4539,677.0602837,531.3368794,1535.141844,14443.20567,532.4822695,475.3546099,1762.829787,19775.41489,1257.932624,7794.099291,3994.528369,7118.911348,1327.241135,377.6524823,2396.053191,15008.24113,605.6453901,688.3652482,441.7943262,17732.8227,422.2304965,132.8829787,5938.397163,13476.18794,1453.468085,821.9858156,2813.680851,11943.04965,636.9113475,282.5780142,2231.56383,9046.326241,848.5035461,435.1631206,1311.79078,7167.890071,785.5212766,176.8617021,5873.5,6410.163121,1357.996454,409.6382979,3360.560284,329.1560284,504.8687943,282,29.57054426,13.35957482,0.892126052,0.846846847,0.497354497,-0.617451205
+2147,40179.34247,895.7260274,528.8630137,1076.027397,35363.13699,751.1369863,1075.191781,1604.561644,19887,574.630137,1982.643836,1807.671233,27499.39726,1343.712329,4310.150685,3741.821918,10125.68493,1452.30137,387.4109589,3080.767123,20046.46575,466.5205479,1420.178082,1735.890411,23138.57534,463.0958904,281.3972603,3803.849315,17815.52055,2374.643836,763.3287671,2820.863014,15991.60274,638.8767123,301.5205479,1495.863014,12714.91781,1411.246575,483.630137,1383.726027,9855.547945,1054.561644,190.3835616,4841.383562,8691.273973,1439.671233,229.3835616,3256.027397,414.9863014,496.8630137,73,11.50001281,8.635377617,0.660414143,0.890243902,0.51048951,1.334642618
+2148,33715.95946,850.2027027,513.0675676,1121.027027,29713.7027,712.1081081,609.3378378,1594.472973,17520.18919,564.6891892,503.7972973,1760.256757,24029.35135,1308.635135,4745.864865,3555.5,8782.283784,1399.581081,375.8513514,2414.391892,17793.95946,488.5810811,365.527027,545.7837838,20466.24324,471.3648649,128.6756757,3659.418919,15994.48649,1564.216216,837.8243243,2801.216216,14054.71622,622.6756757,300.4864865,2005.986486,11076.63514,903.1621622,459.5945946,1325.905405,8450.108108,716.472973,175.6621622,4834.202703,7545.513514,1380.918919,153.7702703,3376.756757,449.7702703,496.4864865,74,11.34006357,9.215964562,0.582695267,0.880952381,0.611570248,1.479822145
+2149,18111.61644,721.6506849,444.4246575,1029.191781,15826.00685,599.0616438,419.7739726,1367.034247,9122.253425,463.2260274,506.3424658,1728.979452,12688.54795,1185.90411,2916.986301,1849.705479,4496.863014,1236.438356,319.4383562,2436.315068,9074.59589,420.5684932,735.6506849,561.4315068,10501.78082,364.5890411,112.5616438,1267.30137,8247.657534,1425.267123,763.3424658,2795.356164,7316.013699,663.0821918,243.6849315,1599.431507,5752.876712,970.130137,381.5753425,1305.013699,4528.787671,763.5753425,149.5342466,4324.780822,4051.684932,1216.260274,413.5479452,3149.39726,593.6917808,499.5068493,146,16.45300692,11.63590418,0.70699302,0.935897436,0.608333333,0.573662611
+2150,29699.84416,847.7207792,647.0454545,1112.935065,25859.22727,696.0844156,568.7922078,1614.350649,15018.73377,524.0844156,528.6168831,1748.272727,20399.12987,1295.75974,2884.493506,2201.376623,7360.058442,1282.409091,354.1363636,2448.571429,14650.37013,472,354.9155844,499.3051948,17742.98701,428.1428571,126.2142857,2271.409091,13615.26623,1479.441558,580.7012987,2788.207792,11926.85714,741.4285714,283.6168831,1840.525974,9779.383117,875.6688312,418.9545455,1321.597403,7396.331169,704.0974026,166.7402597,2441.5,6278.396104,1366.974026,462.1883117,3177.012987,724.3376623,499.7857143,154,15.7860243,12.54119014,0.60733096,0.956521739,0.696832579,-0.119661541
+2151,29104.77311,877.9159664,545.8991597,1100.310924,22810.0084,683.7478992,638.789916,1568.882353,12640.11765,508.3193277,878.2605042,1767.857143,18147.29412,1227.428571,5281.647059,3610.915966,6299.428571,1209.504202,341.6638655,2447.966387,12538.66387,487.0168067,449.5966387,1027.630252,15221.96639,403.7815126,144.7647059,2803.134454,11703.11765,1834.462185,540.7142857,2807.647059,10015.02521,892.8403361,261.1512605,3365.470588,7990.764706,1199.277311,401,1301.184874,5766.94958,739.1848739,157.7226891,3919.235294,5068.067227,1239.252101,634.6134454,3278.268908,844.0420168,497.6806723,119,14.76713493,10.55611765,0.699289508,0.944444444,0.708333333,1.106407036
+2152,50877.90741,899.6388889,560.6851852,1145.398148,49977.60185,761.7222222,1222.787037,1797.092593,25846.57407,616.8240741,1317.851852,1857.324074,36064.17593,1346.657407,7686.62037,7529.157407,13771.49074,1462.472222,406.8888889,2396.314815,26946.44444,466.9259259,656.0185185,612.8055556,31772.46296,1226.314815,140.5092593,4635.037037,24268.26852,1585.398148,658.3611111,2834.898148,20695.78704,645.037037,322.8888889,4260.805556,14436.56481,1374.064815,469.7314815,1326.240741,11153.96296,769.6388889,189.5833333,3610.740741,9149.453704,1414.259259,185.962963,3414.62037,204.4907407,500.1203704,108,17.84812508,8.075347352,0.891790819,0.892561983,0.519230769,-0.569251001
+2153,24296.56579,898.5921053,496.6578947,1039.868421,20135.22368,625.2763158,371.7894737,1466.447368,11449.51316,475.2105263,527.7894737,1745.697368,15528.14474,1164.960526,4684.25,3304.763158,5768.881579,1232.605263,312.9210526,2430.578947,11344.07895,411.3289474,622.5394737,610.4342105,13014.38158,380.7236842,110.3421053,2799.473684,10099.39474,1361.684211,722.4473684,2792.828947,8967.144737,615.3552632,239.0526316,1884.815789,7128.697368,878.4078947,377.9473684,1298.276316,5560.776316,737.3684211,155.4078947,2796.276316,4753.907895,1196.184211,325.4078947,3137.25,637.7894737,498.7763158,76,11.96313289,8.385769166,0.713193068,0.962025316,0.690909091,-0.649894184
+2154,29611,751.372093,450.755814,1059.232558,25527.16279,627.5581395,532.244186,1504.348837,14662.54651,504.4302326,645.3255814,1744.395349,21086.74419,1201.651163,5513.069767,3682.813953,7463.255814,1210.034884,328.7906977,2493.662791,14855.40698,483.4767442,314.5348837,731.5116279,17825.75581,512.6627907,119.127907,3265.116279,13970.32558,1602.953488,647.7790698,2788.72093,12095.24419,582.6395349,264.4418605,1994.360465,9958.755814,1024.709302,391.5697674,1297.918605,7074.709302,666.9767442,157.627907,4306.593023,6319.953488,1230.372093,196.4767442,3163.418605,772.627907,497.9186047,86,12.66614705,9.111251622,0.694659357,0.868686869,0.651515152,-0.489199644
+2155,33377.42424,810.2474747,534.2575758,1103.575758,29557.13636,646.2626263,721.6969697,1604.40404,16053.32323,494.6767677,1048.510101,1736.843434,23018.56566,1212.530303,5658.808081,3454.757576,8038.757576,1224.338384,334.7727273,3786.464646,16194.58586,6239.025253,788.9848485,955.3232323,19519.5202,462.4343434,125.2878788,4122.469697,15598.91919,1849.308081,645.4343434,2803.621212,13040.23232,608.6363636,267.3282828,5907.09596,10368.36869,990.8939394,398.2020202,1321,7421.919192,818.5909091,156.1616162,3194.848485,6347.555556,1242.010101,291.1767677,3255.565657,890.5959596,502.489899,198,20.83656475,12.27429435,0.808078541,0.947368421,0.582352941,-0.581122611
+2156,26532.61224,769.7142857,487.7346939,1064.05102,23860.02041,653.6938776,520.9591837,1513.642857,12512.14286,492.1122449,907.2755102,1745.704082,18716.92857,1312.469388,4692.438776,4756.938776,6758.295918,1249.387755,333.7959184,2453.571429,13046.45918,1446.214286,215.1326531,717.5408163,15780.95918,430.3979592,122.5816327,2674.663265,11970.11224,1623.05102,800.8469388,2798.081633,10310.21429,1005.489796,256.877551,2192.755102,8617.459184,983.6632653,398.0204082,1277.969388,6534.510204,631.2040816,157.3367347,5143.816327,5441,1242.295918,368.3265306,3157.938776,760.9591837,499.6428571,98,13.99113427,9.925080388,0.704822665,0.875,0.628205128,-0.833604522
+2157,31108.48649,797.8378378,461.4459459,1074.594595,27312.40541,686.7432432,697.1486486,1574.216216,15600.2973,510.027027,1244.959459,1782.283784,22122.82432,1237.445946,6295.243243,3984.851351,7826.662162,1217.648649,342.2432432,2425.432432,15833.60811,450.9324324,184.5675676,1255.432432,18802.63514,437.2972973,483.7162162,3347.567568,14811.37838,2087.621622,550.9189189,2784.662162,12551.08108,652.1216216,263.1486486,1948.648649,10256.75676,1349.013514,406.1891892,1313.986486,7506.972973,633.8243243,156.3378378,2667.378378,6444.635135,1263.391892,589.0540541,3198.486486,808.1081081,499.3108108,74,12.16586753,8.478244948,0.717180145,0.891566265,0.560606061,-1.010613478
+2158,45644.24,871.32,519.33,1121.98,43948.71,726.59,830.13,1712.4,24082.97,577.89,1466.96,1814.39,32653.76,1306.13,7449.93,4868.63,11913.34,1418.82,385.2,4050.66,24569.57,847.42,164.2,909.96,29527.55,445.82,135.48,2991.07,22877.14,1807.17,640.77,2854.29,19767.29,638.84,308.79,2884.39,14695.64,997.49,453.93,1341.57,11260.07,662.59,179.98,2998.72,9453.73,1396.45,370.4,3323.38,242.81,500.09,100,17.30680947,7.792762409,0.892891712,0.854700855,0.534759358,-1.313497885
+2159,41729.58427,857.741573,474.5842697,1092.786517,34696.33708,697.6292135,612.258427,1586.134831,20470.14607,543.1011236,1418.382022,1810.94382,28441.62921,1316.303371,4649.292135,4487.202247,10208.64045,1314.629213,355.8089888,2561.426966,20271.69663,473.6966292,146.8426966,1163.404494,24260,445.4157303,435.9662921,2928.516854,19151.96629,2084.932584,678.3483146,2831.292135,16561.5618,639.4382022,283.8988764,1921.831461,13693.77528,1315.123596,429.6516854,1287.696629,9785.651685,661.9662921,166,3343.786517,8542.213483,1362.426966,202.6629213,3276.168539,752.0786517,503.1685393,89,17.10083632,6.866058783,0.915857152,0.881188119,0.618055556,-0.144307866
+2160,46249.91538,997.1076923,618.5307692,1188.069231,12704.50769,458.5538462,467.0153846,1346.523077,4654.769231,362.2615385,773.7538462,1613.369231,8119.615385,896.6230769,2424.869231,1031.192308,3008.5,932.5384615,259.6,2364.623077,5324.984615,355.7076923,192.4615385,479.4923077,6212.869231,294.5076923,222.8461538,1120.5,4698.553846,1223.330769,404.8384615,2795.992308,3633.938462,451.2692308,187.5923077,948.8846154,2168.107692,675,309.0461538,1244.738462,1038.792308,499.9615385,126.4384615,869.9,1219.746154,845.6769231,260.3923077,2890.269231,1132.446154,502.4769231,130,14.21275984,11.87257053,0.549724698,0.942028986,0.619047619,0.291041891
+2161,43566.63095,912.8809524,652.75,1135.821429,44773.29762,752.1309524,616.4642857,1767.392857,22757.86905,579.952381,542.3809524,1817.761905,31881.11905,1344.97619,10599.33333,6637.904762,12190.09524,1438.797619,393.5,2446.214286,24171.71429,466.2380952,170.0714286,464.9166667,28811.9881,470.5714286,141.0238095,7045.738095,21846.83333,1550.309524,873.1666667,2829.642857,18792.02381,647.1785714,319,6603.5,13766.94048,894.952381,459.1071429,1316.392857,10628.42857,665.9404762,185.5238095,3201.464286,8680.392857,1420.559524,220.9285714,3325.071429,219.7380952,500.8333333,84,14.25648124,8.606273032,0.797230955,0.875,0.646153846,0.249600512
+2162,26553.12389,874.2123894,521.5486726,1072.300885,25621.57522,715.1327434,458.2477876,1516.690265,13917.0354,590.5044248,502.7522124,1740.345133,18887.76991,1319.115044,4141.522124,2220.477876,6790.460177,1375.469027,361.0619469,2386.185841,12198.53097,420.5575221,880.6725664,456.1061947,14252.0708,451.8318584,122.1327434,2961.20354,10978.53982,1593.079646,839.0176991,2822.893805,9760.99115,772.1061947,260.3362832,1460.938053,7601.964602,792.3185841,414.0884956,1320.575221,5860.40708,793.8672566,168.5309735,4109.787611,5280.911504,1257.035398,131.1415929,3251.902655,364.300885,503.2300885,113,14.80976892,10.21381846,0.724126052,0.896825397,0.579487179,-0.732205207
+2163,34066.72414,811.5977011,539.8850575,1080.448276,30059.17241,662.7126437,572.183908,1512.586207,17524.35632,537.9770115,466.4022989,1796.45977,24177.10345,1263.517241,6204.206897,4166.08046,8707.83908,1354.574713,354.7356322,2407.310345,18278.08046,666.1954023,436.4367816,461.5517241,20963.74713,410.1264368,127.1264368,5758.724138,16479.88506,1546.827586,965.8965517,2806.816092,14509.04598,619.3103448,289.3793103,2272.747126,11543.7931,901.7701149,446.6436782,1333.149425,8870.816092,705.4367816,177.4827586,5992.448276,7860.655172,1358.781609,175.3908046,3236.908046,441.4942529,501.5977011,87,11.11942539,10.41983389,0.349104381,0.956043956,0.659090909,0.204582632
+2164,21159.40714,719.3714286,473.9071429,1036.857143,18876.47143,677.2785714,572.7857143,1429.814286,10729.67143,473.9071429,1019.142857,1831.314286,15033.15714,1161.007143,5184.421429,3195.428571,5277.692857,1241.164286,312.5428571,2527.721429,10770.03571,402.8642857,468.9214286,955.1714286,12500.5,545.8,116.2,1933.614286,9869.828571,1683.864286,722.3214286,2799.842857,8917.628571,613.0785714,249.1285714,1691.25,6970.464286,1205.614286,386.5642857,1309.442857,5515.478571,683.8642857,153.5428571,4181.942857,4817.821429,1217.757143,540.9642857,3101.864286,581.1785714,501.2857143,140,15.78299154,11.81503861,0.663029687,0.909090909,0.673076923,1.324160128
+2165,34204.76923,1129.346154,579.7884615,1106.615385,30251.94231,821.0384615,1223.942308,1658.25,17167.25,632.2884615,1777.730769,1823.769231,23273,1417.326923,3953.576923,3353.807692,8127.865385,1404.134615,368.5576923,3543.923077,16654.23077,498.9038462,440.5192308,2017.442308,19640.01923,449.6923077,174.1153846,3243.096154,15215.57692,2429.903846,714.3076923,2859.423077,13636.01923,657.9423077,308.5,1435.173077,10578.48077,1248,460.9230769,1380.442308,8407.903846,730.6538462,175.0576923,3814.423077,7201.692308,1367.769231,208.6346154,3342.326923,410.2115385,502.7115385,52,12.30408556,6.308162204,0.858574739,0.825396825,0.481481481,0.4164407
+2166,39855.48936,889.7234043,509.5531915,1107.531915,34510.7234,712.0212766,621.8085106,1608.765957,19787.74468,545.5319149,550.2765957,1760.93617,26836.02128,1338.106383,4041.191489,3680.553191,9652.255319,1417.468085,372.1702128,2435.191489,21792,514.5106383,333.9787234,549.9361702,23504.23404,492.3191489,136.8723404,2923.446809,18347.87234,1784.06383,867.8085106,2826.191489,16050.08511,680.6382979,320.7234043,1943.553191,12837.06383,1031.042553,473.0851064,1321.319149,9916.510638,700.787234,182.4893617,3670.404255,8548.468085,1425.276596,495.6170213,3231.978723,433,500.3191489,47,8.624319335,7.186862583,0.552783069,0.979166667,0.734375,-0.359774755
+2167,22457.86905,720.1071429,471.6785714,1036.119048,19635.54762,610.9285714,418.952381,1430.654762,11697.45238,480.5357143,480.5952381,1769.964286,16200.09524,1158.154762,3779.166667,2619.5,5888.202381,1282.892857,322.3095238,2528.011905,11695.34524,429.6071429,1144.011905,436.5119048,13596.03571,394.5595238,115.4880952,2598.011905,10754.83333,1465.952381,771.3690476,2825.761905,9269.345238,729.797619,246.75,1505.869048,7539.416667,826.4285714,415.7261905,1326.119048,5912.857143,896.1547619,160.952381,4500.285714,5312.77381,1241.083333,334.7142857,3093.27381,494.3690476,500.8928571,84,11.81405948,9.100939052,0.637623481,0.988235294,0.717948718,-1.467074969
+2168,22585.30328,782.2131148,440.852459,1042.991803,19382.41803,638.4016393,438.6885246,1413,11203.81148,508.8688525,354.0901639,1660.442623,15750.20492,1273.47541,3522.336066,2708.97541,5612.737705,1413.02459,335.7868852,2365.967213,11869.89344,471.4016393,326.9672131,450.647541,13844.64754,360.8442623,117.942623,3577.852459,10461.39344,1421.934426,822.8278689,2808.032787,9434.909836,610.0819672,264.7377049,1801.131148,7707.532787,818.7131148,388.7868852,1288.909836,5959.795082,659.704918,158.1311475,1809.696721,5153.139344,1350.065574,1693.934426,3066.147541,680.7295082,503.5983607,122,15.21553247,10.60844808,0.716865238,0.917293233,0.677777778,-0.18882534
+2169,25727.95652,827.8695652,619.5652174,1090.282609,22866.82609,656.5652174,893.7173913,1621.391304,12123.43478,491.9130435,1839.434783,1783.021739,17718.73913,1219.956522,6934.108696,5071.282609,6359.847826,1226.652174,340.7391304,3422.608696,12180.67391,2291.630435,962.4565217,1997.086957,15043.28261,455.6304348,269.0652174,3945.782609,11440.67391,2116.304348,708.7608696,2809.282609,9603.717391,661.5217391,264.0869565,5826.26087,7726.173913,1038.5,418.0652174,1336.26087,5699.76087,907.2608696,160.326087,5781.086957,4705.543478,1248.891304,553.3913043,3216.26087,880.5434783,500.9130435,46,8.770331525,6.976330457,0.606023675,0.901960784,0.638888889,-0.540285667
+2170,21873.73596,749.7303371,562.3539326,1063.994382,17684.00562,601.5561798,1011.449438,1557.606742,9215.292135,457.8314607,1904.595506,1744.202247,13285.44382,1088.758427,9426.516854,3678.707865,4885.168539,1125.623596,312.8089888,3647.275281,9726.58427,905.8539326,984.4269663,1091.280899,11298.86517,391.4101124,117.8202247,8027.865169,9457.808989,1997.662921,714.8426966,2895.859551,7889.241573,563.3089888,252.4101124,11620.98315,6234.668539,2342.438202,375.752809,1319.898876,4497.589888,864.4606742,167.5955056,4768.61236,3890.797753,1111.258427,389.6348315,3196.719101,923.9157303,504.488764,178,18.30126527,13.60782006,0.668685549,0.881188119,0.585526316,-0.261895507
+2171,48541.44565,907.8586957,665.3152174,1142.717391,49335.6413,744.1086957,680,1797.706522,24701.55435,591.4130435,594.0217391,1783.804348,34797.47826,1333.717391,9784.184783,8677.326087,13089.75,1418.880435,390.1847826,2423.695652,26149.42391,466.9673913,205.5978261,450.9021739,31067.61957,573.5652174,139.3695652,7798.347826,23492.77174,1515.054348,1030.119565,2826.434783,20378.3913,637.2608696,317.6847826,6010.521739,14560.27174,1052.934783,460.8369565,1325.76087,11175.46739,668.1630435,188.2173913,3243.804348,9093.293478,1413.869565,203.1630435,3361.021739,211.5326087,504.2608696,92,12.98197317,9.339811439,0.694549756,0.968421053,0.696969697,-0.6723046
+2172,36783.21493,1064.507463,569.1462687,1109.889552,31893.06269,708.3164179,587.3014925,1581.501493,18302.94627,573.7074627,745.2746269,1758.361194,24794.27463,1303.901493,6427.597015,3603.58209,8884.152239,1361.38806,359.1104478,2408,18110.53731,433.4477612,166.5432836,461.8597015,21674.77313,479.3343284,174.0089552,4508.349254,16519.94328,1601.895522,691.2328358,2819.773134,14324.05373,686.4686567,289.5820896,2087.501493,10951.55224,911.8597015,439.4268657,1314.170149,8547.892537,644.8955224,174.838806,3294.850746,7463.337313,1348.164179,427.5134328,3393.991045,309.3850746,507.9880597,335,24.28203069,18.0984655,0.666680092,0.927977839,0.72826087,-0.815613111
+2173,20443.11957,923.3369565,549.2608696,1067.097826,18531.01087,692.6630435,452.7282609,1476.347826,10051.05435,553.1304348,493.1413043,1762.043478,13571.26087,1254.641304,3769.73913,1760.445652,5016.26087,1339.25,343.6304348,2408.532609,10716.44565,452.9130435,1440.043478,473.6195652,11957.32609,384.4782609,126.8586957,2397.934783,9189.978261,1787.836957,656.7934783,2856.032609,8043.717391,922.6847826,260.9130435,1357.26087,6250.826087,801.2608696,432.826087,1420.641304,4867.586957,893.8043478,171.8152174,4686.195652,4379.847826,1283.315217,170.7826087,3328,352.0978261,505.076087,92,15.99726357,7.83626371,0.871806586,0.851851852,0.471794872,0.844391996
+2174,24674.99265,873.5367647,536.3529412,1052.176471,21572.16912,637.3308824,532.9558824,1425.911765,12416.61029,518.4044118,836.2941176,1730.264706,16898.96324,1228.830882,4629.507353,4121.183824,5957.352941,1210.382353,321.0073529,2719.176471,12083.26471,412.4705882,345.1764706,690.6691176,14116.09559,382.3970588,122.4632353,3163.455882,11033.75,1650.904412,798.3308824,2795.286765,9809.625,583.9338235,251.6764706,1821.007353,7688.073529,1009.066176,385.7867647,1312.301471,5995.308824,736.9485294,148.3970588,2372.654412,5314.426471,1238,286.2058824,3259.455882,608.625,506.1911765,136,15.22228928,12.20077451,0.59798512,0.900662252,0.503703704,-0.23621965
+2175,12802.84507,691.7957746,381.2253521,1002.225352,11084.35915,555.6408451,383.2605634,1300.211268,6235.788732,447.1126761,370.584507,1716.992958,9219.197183,1124.408451,1249.309859,1033.78169,3317.316901,1137.197183,299.7535211,2385.373239,6685.78169,380.471831,148.7253521,444.1408451,7854,349.1619718,105.1126761,954.3732394,5965.183099,1264.267606,576.7676056,2791.5,5383.795775,742.6760563,227.7957746,1476.964789,4549.838028,717.7042254,362.1619718,1280.401408,3454.28169,582.7535211,146.1197183,2207.147887,3064.239437,1165.225352,1387.5,3043.457746,690.6690141,506.8802817,142,16.68046215,11.09776183,0.746562749,0.940397351,0.696078431,0.041734636
+2176,40527.12232,899.8134557,504.9296636,1098.865443,35264.56269,722.6299694,596.1620795,1619.550459,20050.07645,545.6880734,779.8379205,1775.376147,28837.8318,1342.189602,4006.211009,3532.819572,10239.40367,1317.183486,371.1804281,2412.296636,20477.4159,671.293578,135.3333333,741.1406728,24758.43731,437.4556575,148.3363914,2863.874618,18869.54434,1653.88685,698.8990826,2821.149847,16249.45872,752.146789,290.5259939,1977.53211,13589.04281,1081.159021,432.4984709,1296.489297,9699.495413,654.7889908,165.1406728,3016.165138,8448.116208,1382.804281,336.1192661,3205.522936,773.8103976,513.941896,327,29.55370886,16.41895604,0.831474244,0.840616967,0.512539185,-0.626524793
+2177,25360.55208,793.7395833,621.3020833,1113.916667,19192.10417,622.8645833,891.7604167,1652.15625,10896.76042,475.4479167,1794.114583,1770.083333,14716.39583,1151.59375,7367.052083,3081.364583,5454.791667,1157.354167,314.7083333,4809.885417,10857.16667,585.0833333,631.6041667,1223.927083,12499.70833,458.7604167,116.8333333,4033.53125,10558.125,1965.416667,605.5208333,2813.0625,8941.53125,606.9895833,262.25,11464.27083,7001.40625,1914.6875,389.09375,1336.427083,4832.25,779.75,160.4583333,4266.770833,4306.052083,1184.4375,502.5520833,3256.59375,907.7708333,503.21875,96,12.45123651,9.89246211,0.607268911,0.932038835,0.671328671,-1.473435514
+2178,42535.41379,892.2241379,571.0172414,1138.982759,39542.77586,743.2586207,558.9310345,1704.482759,21906.58621,568.6551724,890.1206897,1850.12069,30229.74138,1306.844828,6641.362069,5647.793103,10966.06897,1425.551724,376.7758621,2725.672414,22748.53448,443.637931,140.5344828,582.8793103,26139.62069,443.8448276,133.0517241,4061.275862,20649.17241,1710.534483,834.9137931,2821.758621,17894.89655,648.0862069,307.9137931,3340.896552,13233.87931,942.2241379,464.6206897,1314.844828,10216.77586,696.1724138,182.7068966,4641.517241,8582.62069,1393.034483,382.8275862,3289.810345,257.5172414,502,58,10.89893124,7.00504179,0.766094957,0.950819672,0.753246753,-1.442780347
+2179,26390.82143,926.8928571,562.9464286,1096.089286,22972.08929,717.7321429,665.5,1593.553571,13130.89286,549.7142857,602.8571429,1783.857143,17997.83929,1304,6525.875,4368.339286,6412.803571,1337.321429,353.1428571,2470.089286,13471.71429,785.6964286,790.9285714,2004.517857,15226.07143,481.9107143,134.1964286,6091.839286,11964.53571,1596.75,915.875,2799.196429,10537.67857,644.4642857,293.3392857,2050.160714,8275.25,1061.392857,452.6785714,1342.357143,6466.625,909.375,179.5,4669.446429,5774.053571,1354.25,166.125,3395.160714,403.9107143,504.5178571,56,11.12466174,6.662954487,0.800797293,0.949152542,0.727272727,-0.265832698
+2180,33505.21951,880.4634146,487.5365854,1107.621951,29148.92683,715.804878,704.7317073,1556.292683,16818.09756,548.3414634,680.5609756,1772.743902,22784.53659,1347.317073,4494.365854,2323.207317,8380.853659,1429.97561,373.2317073,2465.853659,17753.39024,467.8414634,618.6097561,523.2682927,19969.30488,534.9634146,134.6463415,2802.841463,15658.47561,1623.878049,801.3658537,2945.170732,13819.34146,830.4268293,302.9634146,1664.487805,10966.84146,960.9146341,463.1341463,1364.012195,8481.890244,780.6707317,182.0487805,4437.658537,7559.743902,1434.512195,670.5853659,3238.5,425.6585366,504.0609756,82,13.96033309,7.731068572,0.83265753,0.901098901,0.569444444,0.889944872
+2181,25172.48031,811.007874,512.5275591,1060.858268,21594.05512,660.7007874,558.7874016,1523.338583,12470.51969,527.2047244,635.5590551,1773.787402,17032.0315,1246.11811,4469.937008,3182.850394,6211.677165,1342.047244,374.1968504,2452.307087,11988.83465,432.8425197,1744.472441,538.2283465,14155.08661,415.6771654,124.5590551,2614.708661,10899.2126,1789.062992,776.9527559,2813.354331,9681.291339,940.6614173,265.2834646,1633.275591,7667.795276,954.3622047,433.6377953,1356.968504,6120.322835,1217.811024,168.6141732,5469.15748,5368.409449,1323.779528,277.8661417,3262.622047,510.9055118,505.2362205,127,16.1993173,10.87560354,0.741129728,0.858108108,0.610576923,-1.511074757
+2182,40700.75862,858,506.7068966,1101.948276,34241.44828,688.9482759,664.9482759,1580.896552,20259.63793,512.7931034,635.7758621,1751.396552,27897.43103,1294.189655,5772.965517,2550.155172,10179.2069,1285.586207,360.1724138,2512.206897,20420.56897,477.1896552,266.637931,621.5172414,23966.60345,466.2241379,132.8275862,3434.706897,19153.7069,1640.689655,595.1724138,2789.603448,16498.62069,922.6551724,284.3793103,2136.017241,13414.2931,952.5689655,439.5689655,1298.586207,9392.327586,667.7586207,172.0517241,3013.965517,8157.034483,1318,919.3103448,3239.551724,815.6034483,503.3448276,58,9.513531917,8.286155201,0.491307445,0.878787879,0.644444444,-1.519326462
+2183,35251.8125,907.2556818,667.6193182,1171.744318,12453.99432,433.1022727,322.0340909,1248.039773,5987.801136,363.5568182,648.0681818,1661.380682,8366.085227,862.6193182,4264.102273,2067.068182,3288.352273,911.2897727,261.6818182,3318.443182,6204.982955,569.8011364,174.3522727,523.0909091,7117.045455,283.2272727,96.89204545,6082.238636,5075.755682,1541.056818,429.75,2792.039773,4237.517045,447.4659091,193.9431818,2293.539773,2362.630682,665.9943182,314.8863636,1260.909091,1877.420455,515.7556818,128.0454545,1426.653409,1651.545455,871.1306818,133.0227273,2935.619318,142.9943182,507.1761364,176,16.40433845,14.08548115,0.51257299,0.956521739,0.611111111,-1.213498121
+2184,17780.98693,855.7973856,517.1045752,1048.718954,16254.67974,722.9738562,669.6535948,1462.104575,8804,523.5359477,513.4052288,1743.836601,12272.45752,1235.111111,4740.202614,3432.163399,4534.555556,1299.235294,364.2745098,2447.849673,9149.019608,449.0392157,3115.202614,541.8627451,10373.38562,462.1045752,125.4117647,2017.869281,8148.339869,2026.183007,1150.594771,2822.803922,7213.751634,733.620915,259.0653595,1522.333333,5633.745098,958.9934641,436.1372549,1384.69281,4454.379085,1362.235294,172.3137255,4838.751634,4085.045752,1320.928105,163.0130719,3295.679739,383.7189542,507.9738562,153,16.60499139,12.06597583,0.687010466,0.921686747,0.75,0.08386432
+2185,21303.91262,926,561.9417476,1080.76699,18921.26214,718.5145631,635.2330097,1511.941748,10674.34951,551.407767,623.776699,1779.805825,14858.75728,1284.747573,6107.864078,4286.883495,5458.097087,1313.902913,356.2718447,2395.776699,13607.30097,946.3009709,1533.796117,985.184466,12856.04854,759.6213592,128.368932,3634.15534,9978.621359,1706.145631,782.0485437,2797.582524,8850.135922,641.7864078,279.9223301,1958.873786,6976.378641,987.5533981,432.7475728,1361.621359,5515.048544,1100.92233,174.5533981,6331.825243,4944.873786,1339.23301,195.6796117,3258.252427,395.3786408,506.1456311,103,14.30446564,10.01607918,0.713940418,0.887931034,0.72027972,-0.554971202
+2186,16825.30556,739.9652778,468.8819444,1044.826389,14846.27778,624.3958333,577.2083333,1420.6875,8526.756944,482.0347222,859.1388889,1716.423611,11920.45139,1195.555556,3371.965278,2247.805556,4317.055556,1180.25,319.8263889,2455.618056,8606.291667,416.2777778,379.0625,745.3958333,10286.33333,429.25,137.0694444,3039.375,7902.854167,1534.027778,703.8819444,2788.173611,7010.256944,606.2430556,250.1388889,2012.555556,5850.215278,837.9861111,382.7708333,1306.666667,4497.138889,690.4861111,158.1597222,4584.763889,3904.798611,1261.4375,543.8333333,3078.354167,709.5486111,505.1041667,144,14.63117682,12.8515248,0.477989106,0.947368421,0.75,1.523539597
+2187,31935.32571,855.4857143,483.3771429,1074.977143,27336.97143,692.0171429,754.7142857,1564.474286,15975.52571,532.2457143,1770.04,1901.371429,22930.15429,1318.44,6179.377143,3875.285714,7994.885714,1266.165714,390.3257143,2643.125714,16150.46286,505.8857143,254.9885714,1944.92,19367.77714,465.48,133.5542857,2123.491429,15031.87429,2308.28,547.4742857,2807.462857,12853.20571,962.9771429,278.0057143,1748.805714,10717.55429,2001.994286,423.4457143,1304.062857,7680.285714,668.4285714,164.1085714,3404.102857,6711.868571,1322.948571,329.2228571,3224.2,790.1257143,507.0742857,175,18.77067909,12.2135939,0.759357144,0.921052632,0.614035088,-1.247359359
+2188,31991.26136,886.1363636,490.7727273,1060.829545,27829.17045,696.1136364,756.75,1498.909091,15882.80682,548.3977273,924.7840909,1725.477273,22535.56818,1309.204545,6299.386364,2452.647727,7871.011364,1341.5,358.3181818,2437.840909,15028.23864,419.0113636,184.4204545,657.125,17483.89773,399.125,123.4886364,4582.965909,13683.44318,1682.909091,727.4318182,2805.409091,12002.97727,593.7045455,274.3068182,1742.227273,9522.238636,926.8863636,426.2045455,1320.329545,7367.920455,665.0454545,172.9886364,4178.011364,6475.568182,1312.829545,523.2727273,3299.068182,466.875,505.6931818,88,12.17800095,10.13249067,0.554727121,0.846153846,0.523809524,-1.557348483
+2189,20140.4625,775.19375,429.55625,1038.99375,17687.9,629.125,550.35625,1372.35625,9872.5625,493.7875,456.26875,1732.325,14431.0375,1245.3875,1980.75625,1325,5149.51875,1281.1375,336.31875,2425.01875,10781.76875,407.53125,277.10625,441.29375,12042.33125,382.2125,121.41875,2008.25625,9431.2375,1409.175,681.11875,2904.0125,8445.66875,895.49375,252.95,1480.25625,6711.75625,797.35,411.39375,1298.79375,5260.7125,649.78125,161.95,2319.63125,4601.8875,1356.04375,6180.5125,3160.50625,480.05625,507.45625,160,20.3367924,10.209487,0.864855712,0.958083832,0.561403509,-1.044224449
+2190,31814.25758,879.3787879,475.8333333,1068.606061,26396.57576,675.3787879,663.7727273,1536.037879,15442.70455,523.6969697,838.4772727,1729.25,21723.78788,1255.780303,5567.939394,2528.113636,7751.643939,1208.537879,336.6363636,2781.901515,15497.57576,470.4318182,543.1136364,834.3560606,18426.68182,456.3257576,123.4393939,2884.189394,14308.9697,1761.598485,528.9848485,2801.212121,12430.77273,937.9393939,261.5151515,1817.409091,9855.727273,917,393.25,1307.893939,7015.75,736.7121212,157.0378788,3796.265152,6031.075758,1217.333333,465.3560606,3305.439394,830.0984848,507.6818182,132,15.80922224,11.42257796,0.691343494,0.936170213,0.586666667,-0.990535548
+2191,47716.45833,892.125,586.1041667,1150.145833,46824.77083,730.2291667,777.6666667,1741.708333,25201.52083,592.25,635.8333333,1752.666667,34180.35417,1327.375,8788.8125,6505.4375,12670.54167,1450.458333,394.0208333,2671.625,25966.625,449.6458333,150.3958333,511.6458333,32106.77083,447.1041667,141.7916667,6218.333333,24448.4375,1702.25,705.6458333,2812.041667,20914.45833,636.2083333,319.5625,3775.583333,15647.02083,926.5,475.0208333,1300.729167,11841.35417,673.9583333,178.0208333,3419.3125,9881.395833,1434.645833,194.7916667,3370.104167,234.7291667,506.2916667,48,10.04685516,6.180019898,0.788433629,0.979591837,0.6,0.616350419
+2192,23600.08333,799.5833333,593.4444444,1079.611111,24702.83333,655.1388889,1113.583333,1586.861111,12144.27778,524.3888889,2184.166667,1841.25,17228.55556,1208.111111,11550.83333,8776.472222,6498.722222,1268.833333,356.1388889,5480.472222,14351.91667,482.6388889,137.8611111,1881.027778,15789.16667,451.1666667,125.3333333,4887,11746.5,2239.444444,779.3611111,2809.083333,10458.91667,604.3888889,271.9722222,3287.833333,7978.277778,1212.722222,418.2777778,1339.555556,6643.277778,652.3055556,182.3055556,6751.111111,4936.805556,1284.111111,412.5833333,3323.166667,249.3888889,504.8333333,36,8.266476106,5.955488387,0.693518737,0.9,0.571428571,1.443205131
+2193,33766.78947,964.3684211,638.6210526,1135.442105,31128.23158,764.0315789,586.9789474,1652.042105,16892.47368,588.1368421,544.1368421,1760.073684,23578.46316,1408.452632,3676.294737,3038.294737,8482.926316,1458.136842,418.7894737,2422.8,17394.43158,525,582.1052632,504.2421053,21104.06316,448.3263158,146.8315789,3569.736842,16124.52632,1928.105263,801.3578947,2820.494737,14343.49474,670.6631579,319.2736842,1694.652632,11240.46316,1039.231579,481.0842105,1326.726316,8635.957895,778.4315789,189.7578947,4222.568421,7864.431579,1477.084211,152.1473684,3242.957895,372.3894737,508.2947368,95,12.82349897,10.03540444,0.622550953,0.896226415,0.608974359,-0.863463382
+2194,19515,1045.015625,533.5,1049.078125,19229.42188,719.34375,555.90625,1391.375,9492.78125,580.703125,667.40625,1731.5,13004.5,1273.859375,4676.5625,2040.15625,4870.390625,1854.953125,323.328125,2489.421875,10578.75,392.28125,302.3125,563.984375,11404,385.9375,123.75,2286.59375,8486.71875,1615.828125,691.078125,2839.796875,7777.203125,619.328125,248.9375,1433.890625,6324.453125,844.671875,413.109375,1327.6875,5314.984375,661.390625,158.859375,2591.890625,4082.765625,1207.515625,136.796875,3357.453125,417.625,507.234375,64,10.35106184,8.858702644,0.517264651,0.853333333,0.52892562,0.212349574
+2195,19848.65094,730.3962264,470.0754717,1033.386792,17683.98113,607.7735849,356.2169811,1434.95283,9813.622642,479.0377358,465.9716981,1777.415094,13950.15094,1165,4751.386792,2357.537736,5098.386792,1289.056604,320.5566038,2413.04717,10789.41509,4936.235849,1069.839623,463.9245283,12147.25472,423.6886792,118.0566038,1950.669811,9458.726415,1723.264151,1171.566038,2812.518868,8389.433962,780.0660377,245.8113208,1469.820755,6804.45283,903.8867925,404.8207547,1299.726415,5322.603774,819.3584906,160.1037736,3903.849057,4652.433962,1262.292453,326.5377358,3378.849057,448.245283,508.2830189,106,14.19542162,10.13217076,0.700387017,0.929824561,0.630952381,-0.986304319
+2196,31275.2,836.835,495.745,1110.65,27064.625,683.395,543.865,1575.01,16120.05,538.87,660.21,1751.505,22007.29,1309.88,4938.18,3887.61,7368.115,1311.585,342.075,2490.66,15775.27,464.215,424.92,543.245,17564.29,835.82,124.65,3054.395,14291.345,1529.78,847.08,2813.365,12680.6,629.08,291.385,1823.725,9973.005,1086.29,441.23,1315.47,7590.46,727.415,169.36,3142.35,6666.92,1364.3,332.11,3197.94,571.53,509.76,200,20.7538675,13.26728999,0.768983756,0.877192982,0.634920635,-1.526589914
+2197,30865.9927,810.2262774,443.2919708,1046.328467,26417.84672,661.9854015,663.7226277,1520.021898,15555.80292,514.5839416,1562.970803,1750.722628,21601.10949,1268.678832,3871.781022,2867.211679,7856.540146,1284.605839,332.0145985,2768.934307,16014.9562,447.4671533,287.3284672,1216.50365,18692.34307,420.2481752,117.270073,2592.167883,14446.67153,1941.109489,635.0072993,2804.043796,12712.35036,957.4525547,271.1313869,1945.708029,10332.46715,1106.284672,405.8175182,1301.430657,7955.452555,699.379562,152.729927,3599.934307,6899.423358,1354.569343,460.7883212,3139.905109,629.4817518,509.2116788,137,16.13554216,11.13563273,0.723684766,0.907284768,0.713541667,0.162164301
+2198,47861.07317,896.402439,529.1707317,1121.353659,40947.81707,730.695122,672.7439024,1660.768293,23705.85366,559.7195122,1112.817073,1765.780488,33702.47561,1381.792683,4633.036585,4163.158537,12273.71951,1348.634146,370.195122,2507.329268,23675.70732,536.0853659,119.6097561,937.3414634,28755.78049,447.4756098,246.5365854,3052.695122,22244.80488,1918.268293,778.4390244,2808.963415,19214.08537,677.3902439,305.1463415,2162.646341,16041.79268,1261.890244,446.6463415,1314.121951,11293.08537,644.3780488,168.5487805,4463.414634,9986.914634,1430.792683,221.8780488,3250.243902,765.3902439,507.402439,82,12.71753792,9.290287419,0.682902101,0.863157895,0.450549451,-0.691449005
+2199,34169.33149,810.8066298,543.9447514,1103.966851,26126.56906,638.6519337,839.480663,1748.348066,14120.12155,462.9834254,907.4640884,1824.049724,19418.78453,1165.353591,6505.906077,3021.381215,7034.425414,1185.585635,322.8066298,2938.78453,13678.67956,2263.441989,181.1823204,661.0165746,15647.97238,478.2596685,121.7734807,5377.977901,13338.38122,1647.453039,610.121547,2793.629834,11141.16575,593.7790055,257.4309392,6474.077348,8330.850829,1076.447514,385.441989,1297.911602,5789.977901,647.3038674,149.3370166,2587.98895,5090.121547,1144.099448,273.4475138,3203.187845,934.3977901,510.1767956,181,19.11902835,12.46098556,0.758426732,0.914141414,0.558641975,-0.721958487
+2200,47893.12602,902.1341463,530.0731707,1156.756098,14501.53659,466.4837398,284.6219512,1322.597561,6332.849593,365.6097561,506.0934959,1647.939024,10713.68699,909.5284553,5527.609756,2688.422764,3979.886179,955.6666667,262.2804878,2615.739837,7219.544715,379.9837398,229.8861789,569.4715447,8617.772358,288.9268293,100.2804878,3801.077236,6672.621951,1618.410569,452.0813008,2804.418699,5343.971545,470.402439,192.3089431,1379.971545,3667.341463,672.5203252,308.5731707,1254.45122,1834.284553,541.6504065,128.398374,1494.560976,1965.036585,869.097561,141.7317073,2899.601626,1095.52439,509.703252,246,21.04551926,15.11127322,0.696014163,0.938931298,0.732142857,-1.520172133
+2201,43073.77725,962.2796209,551.8151659,1111.327014,38355.08057,728.8483412,783.2843602,1616.85782,21372.3981,586.2417062,1012.587678,1760.246445,28524.53081,1316.800948,6490.118483,4950.341232,10358.36019,1394.587678,372.3601896,2561.597156,21383.79621,443.028436,188.1090047,654.028436,25583.21801,875.3696682,142.7677725,4518.691943,19613.19905,1614.308057,679.8720379,2812.834123,17041.96682,615.2085308,303.6919431,1623.635071,12957.95735,1076.421801,446.0236967,1301.478673,10246.62559,654.1943128,173.8625592,3588.099526,8598.137441,1366.838863,171.8056872,3380.563981,290.6919431,512.6161137,211,18.7095201,14.89208705,0.605345184,0.879166667,0.620588235,-0.593013443
+2202,28099.625,884.2767857,477.6428571,1061.651786,23373.66964,676.3303571,488.3214286,1511.214286,13438.01786,528.9196429,410.3303571,1704.071429,18590.63393,1268.169643,5898.571429,2822.741071,6730.758929,1246.553571,326.9553571,2400.008929,13665.53571,458.0267857,386.4910714,438.7321429,15977.15179,392.5446429,116.9732143,5680.848214,12172.82143,1416.991071,660.2410714,2794.5,10842.4375,598.6071429,254.2410714,1783.910714,8805.964286,916.1964286,393.8571429,1294.473214,6691.776786,718.5714286,163.3482143,4364.214286,5768.5625,1261.919643,255.9732143,3193.303571,646.3482143,507.625,112,12.89270389,11.21298321,0.493553555,0.973913043,0.783216783,1.380572386
+2203,22856.88806,771.761194,434.2910448,1029.119403,18126.11194,618.9328358,426.5597015,2054.798507,10603.59701,494.0149254,397.5074627,1739.477612,14808.89552,1222.164179,4580.514925,2212.5,5531.395522,1229.11194,330.0074627,2402.395522,11175.27612,438.6567164,383.9328358,474.5597015,13360.4403,389.0820896,115.9328358,2338.097015,10232.35821,1450.604478,696.1940299,2793.850746,9163.925373,595.5223881,248.5373134,1813.69403,7477.462687,932.2164179,389.2238806,1309.589552,5559.544776,697.1865672,156.8656716,3281.656716,4926.977612,1284.768657,420.2686567,3101.641791,659.4925373,509.6119403,134,13.76976577,12.47497516,0.42334493,0.930555556,0.683673469,-1.184179129
+2204,32420.22549,803.1078431,501.7843137,1064.529412,28689.07843,657.8235294,789.6470588,1496.107843,15626.93137,507.2843137,1137.186275,1774.117647,23674.79412,1256.058824,6280.019608,4211.058824,8344.186275,1245.098039,345.6176471,2579.77451,16456.93137,441.0196078,144.127451,1167.578431,20049.7451,839.127451,138.1960784,3233.970588,15004.0098,1596.892157,639.9411765,2807.460784,12964.91176,693.7254902,262.0196078,2103.235294,10867.91176,1222.803922,407.627451,1297.784314,8312.039216,650.6666667,163.7941176,3914.078431,7025.960784,1301.264706,360,3194.176471,744.7058824,510.3137255,102,14.55626961,10.57092182,0.687471972,0.86440678,0.523076923,0.750293694
+2205,19703.36735,852.9591837,696.4693878,1107.918367,19673.61224,670.8979592,640.7959184,1617.469388,8408.061224,492,831.2653061,1792.734694,14686.42857,1215.346939,5552.816327,4884.632653,4978.897959,1212.938776,340.7959184,2472.22449,10139.69388,484.877551,603.1020408,906.2244898,12751.93878,453.7959184,165.6326531,3932.306122,8951.489796,1646.020408,799.3673469,2793.795918,7655.510204,719.3877551,278,18253.38776,6350.612245,1045.877551,406.3673469,1383.979592,5324.44898,850.6734694,159.9591837,5496.204082,3913.040816,1245.795918,593.6122449,3311.081633,869.0204082,505.4897959,49,12.63353432,5.124746994,0.914030111,0.924528302,0.628205128,1.270141689
+2206,31477.95604,864.8571429,474.2307692,1065.538462,25957.8022,693.7142857,591.3516484,1517.912088,15838.79121,566.978022,571.3516484,1711.252747,20939.16484,1297.175824,3823.065934,2279.065934,7505.879121,1264.428571,324.6043956,2644.736264,15193.01099,450.8241758,351.1648352,518.3846154,17541.49451,397.3406593,119.7142857,2272.868132,14025.04396,1532.582418,667.0879121,2798.43956,12284.34066,697.010989,264.7142857,1671.21978,9677.175824,912.0659341,408,1311.703297,7497.505495,736.0769231,159.5494505,2321.813187,6548.285714,1328.659341,421.2527473,3257.505495,619.3076923,510.010989,91,12.14906339,10.08883702,0.557136438,0.968085106,0.7,-0.336968711
+2207,27014.67059,827.4117647,510.1764706,1094.447059,23700.8,691.6823529,507.8352941,1598.211765,13181.83529,504.6235294,738.6823529,1795.505882,18969.17647,1359.494118,5938.529412,2912.188235,6758.129412,1238.941176,345.6470588,2396.894118,13791.6,1353.564706,127.0705882,593.8235294,16164.38824,454.5058824,131.2705882,2770.670588,12521.75294,1471.376471,679.8235294,2806.223529,10778.35294,1241.376471,254.2823529,2255.211765,8769.670588,1259.176471,400.6941176,1300.976471,6663.576471,614.3411765,161,3847.188235,5491.623529,1285.482353,438.0823529,3196.941176,806.0941176,509.1058824,85,11.30569392,10.04701601,0.458549878,0.944444444,0.643939394,-0.083360012
+2208,20262.77632,838.5526316,534.0986842,1095.855263,16269.11184,669.8618421,520.2039474,1581.414474,9103.855263,489.2236842,629,1789.664474,12895.61184,1306.815789,3691.269737,2343.486842,4645.072368,1191.217105,331.8355263,2473.118421,9312.934211,7257.618421,360.4210526,690.0723684,11250.73684,480.8355263,130.6513158,2210.236842,8696.835526,1573.921053,517.9539474,2831.434211,7464.809211,2363.361842,250.8223684,2132.611842,6019.236842,954,394.1447368,1307.315789,4393.473684,703.3421053,160.625,3570.342105,3749.868421,1243.940789,369.1644737,3278.342105,845.7697368,511.9671053,152,18.48667745,11.37440574,0.788311904,0.844444444,0.603174603,-0.26051178
+2209,43755.28986,923.2028986,562.0144928,1116.565217,35731.24638,740.9565217,767.2898551,1718.449275,21865.34783,560.1014493,1907.695652,1814.57971,30074.46377,1361.84058,6364.043478,4707.217391,10827.11594,1337.492754,389.826087,2436.173913,21576.42029,525.1449275,572.4927536,1938.304348,25846.36232,526.6086957,138.5797101,3706.695652,20870.43478,2153.666667,593.6521739,2819.15942,17900.84058,687.6521739,301.3043478,2808.26087,14410.31884,1667.637681,451.7391304,1323.666667,9999.768116,862.9855072,177.4927536,3791.086957,8900.028986,1433.188406,324.7391304,3426.492754,861.5652174,508.7971014,69,11.35972621,8.473198908,0.666060006,0.958333333,0.522727273,0.540367704
+2210,25576.46825,790.6190476,554.6507937,1090.206349,11497.6746,523.7301587,665.8492063,1487.055556,5477.468254,393.5555556,1570.968254,1743.301587,8253.84127,1073.349206,10940.29365,3621.15873,3066.571429,1032.531746,289.7857143,4741.007937,5670.007937,2240.539683,626.5079365,1177.166667,6627.293651,437.3333333,104.3015873,5277.936508,5393.738095,2103.873016,570.0238095,2786.015873,4318.690476,559.8809524,203.7857143,6340.119048,3266.920635,2373.111111,324.5079365,1279.904762,1890.238095,727.3253968,135.031746,4672.230159,1858.039683,942.0873016,322.1904762,3017.039683,1030.150794,510.2857143,126,13.68824633,11.85266973,0.500214964,0.940298507,0.692307692,-1.305458545
+2211,46826.512,897.736,613.624,1139.2,38790.032,670.832,529.344,1741.648,20639.976,556.904,506.12,1776.872,28496.176,1235.16,8823.896,5051.136,10913.296,1315.552,370.896,2358.344,21235.672,412.808,511.088,439.28,25480.672,413.72,127.664,7070.056,19303.176,1463.376,627.496,2822.68,16227.616,615.728,299.896,5389.336,10922.432,800.848,434.856,1308.168,8321.872,694.048,172.44,3093.072,7064.16,1291.352,179.368,3282.864,186.792,509.28,125,17.28987315,9.481437777,0.83622861,0.919117647,0.668449198,-1.393369493
+2212,51506.92045,943.0795455,594.7272727,1153.977273,48405.28409,773.4318182,608.75,1776.613636,28188.51136,590.8636364,705.0681818,1801.977273,36622.35227,1371,7853.181818,5807.079545,13574.11364,1483.659091,399.7613636,2690.715909,27628.05682,486.0340909,149.9659091,550.8636364,33115.90909,458.5,144.4886364,5323.136364,26032.56818,1699.568182,773.7159091,2848.840909,22576.32955,652.0113636,338.125,2805.613636,16466.94318,955.8181818,483.6590909,1319.272727,12297.93182,696.8295455,188.3522727,3599.136364,10713.15909,1471.352273,196.3977273,3334.306818,244.0909091,510.5,88,12.36298377,9.386975548,0.650763204,0.897959184,0.615384615,1.099589788
+2213,27004.9125,809.1875,606.025,1093.575,23561.1625,655.5625,748.1625,1510.15,13364.675,514.1875,1413.4375,1776.4875,18716.9125,1236.425,5540.55,5208.225,6663.3625,1334.25,350.625,2625.925,14617.875,487.8125,878.9875,646.4875,16234.4875,1452.5125,123.8125,3246.2125,12721.95,1829.9125,825.075,2824.4375,11180.475,737.85,274.225,1700,9004.675,1413.375,432.675,1336.0625,7056.825,791.475,172.5125,6250.15,6167.05,1338.3875,668.1625,3261.975,434.2875,510.825,80,12.83579666,8.001863785,0.78190134,0.963855422,0.666666667,-0.590736564
+2214,29772.19792,863.4479167,680.3125,1117.666667,25109.25,717.8229167,707.75,1637.114583,14923.66667,543.5625,2495.489583,1843.5625,20983.22917,1326.8125,4214.041667,3410.78125,7513.145833,1311.302083,356.7916667,2459.53125,14894.17708,503.9270833,1055.479167,3357.46875,17931.6875,473.6770833,802.4375,1617.708333,13905.89583,1852.09375,616.15625,2812.46875,12351.96875,887.90625,275.1666667,1934.291667,10277.89583,1402.260417,424.8958333,1332.864583,7586.635417,1279.260417,158.3541667,4007.958333,6621.71875,1384.510417,348.1458333,3280.75,719.8333333,512.21875,96,14.97271705,8.800057277,0.809050231,0.864864865,0.6,0.16122135
+2215,35986.44898,987.1836735,1227.989796,1230.530612,30333.06122,780.0510204,1007.520408,1853.142857,17554.9898,593.9183673,688.377551,1811.142857,24504.72449,1460.785714,2115.959184,1614.387755,8465.591837,1474.663265,384.4387755,2560.979592,17379.16327,591.7244898,140.2959184,570.5714286,20874.28571,486.8367347,131.9285714,1639.040816,15850.93878,1731.540816,541.1734694,2863.959184,13884.90816,1301.520408,304.5204082,1915.897959,11520.83673,1007.244898,462.5918367,1334.316327,8764.520408,669.0816327,167.0714286,1776.959184,7095.540816,1470.489796,206.5,3392.918367,730.8469388,511.3367347,98,11.75426607,10.96446852,0.360374823,0.97029703,0.628205128,1.344287495
+2216,35503.875,820.8625,515.225,1102.5625,32305.2625,671.725,645.025,1673.05,16862.125,507.55,855.6875,1731.975,24544.225,1242.0125,5305.95,4609.6875,8550.35,1258.15,342.925,2676.725,16929.975,3120.5,797.75,608.025,20347.075,443.075,133.4875,4246.3875,16027.7,1636.9875,684.675,2806.1,13344.9,598.9875,265.2375,4374.5125,10513.6625,1334.825,406.9125,1345.9625,7631.925,842.7875,164.0625,3599.1625,6413.9875,1276.45,328.975,3249.2,894.6125,512.1125,80,15.02998828,7.175963519,0.878662694,0.930232558,0.559440559,-0.713478614
+2217,20613.56604,819.3962264,993.4150943,1110.849057,16574.5283,597.6415094,869.8490566,1666.377358,8644.113208,460.490566,855.6037736,1776.396226,12713.98113,1150.471698,7678.226415,3410.490566,4695.113208,1162.660377,313.0566038,3424.320755,9243.981132,607.4716981,230.9433962,720.1320755,10696.30189,417.4716981,114.0377358,7796.169811,9064.433962,1666.056604,803.7735849,2803.018868,7709.90566,698.8301887,251.245283,8458.188679,6251.566038,1015.886792,392,1314.056604,4416.09434,667.2264151,156.5471698,6006.943396,3954.792453,1174.245283,328.1320755,3227.396226,915.0943396,509.6981132,53,8.942653404,7.862862514,0.476353495,0.946428571,0.588888889,0.251902917
+2218,18691.71333,764.76,617.06,1102.086667,16698.36667,618.0333333,623.7266667,1781.86,8188.046667,449.74,768.02,1811.566667,12455.72,1142.386667,8781.44,3455.473333,4614.046667,1137.273333,310.48,3082.2,8454.833333,6351.153333,385.1133333,596.8666667,10542.03333,621.3333333,118.1666667,9937.586667,8190.226667,1637.293333,818.76,2821.993333,6680.626667,812.6333333,258.8266667,18172.06667,5326.253333,858.5333333,376.9333333,1312.926667,3302.02,715.6133333,156.9333333,7145.646667,3056.28,1114.213333,248.44,3266.246667,1007.946667,511.3133333,150,13.92892766,13.75967364,0.155418363,0.961538462,0.714285714,-1.396747888
+2219,48409.56944,894.0972222,558.8194444,1114.944444,45955.30556,752.4166667,636.0138889,1689.402778,25630.61111,579.0555556,539.8194444,1835.388889,34142.20833,1356.805556,9294.638889,5008.527778,12440.34722,1435.069444,383.0416667,2434.791667,26634.01389,470.0555556,144.0694444,461.6944444,30964.44444,442.8472222,144.375,5408.944444,24007.52778,1575.069444,952.375,2806.125,21143.15278,658.0277778,320.4583333,2205.638889,15636.05556,912.8888889,470.7777778,1303.805556,12060.51389,687.375,180.1944444,4230.972222,10114.08333,1439.402778,185.1805556,3291.236111,255.0972222,510.8472222,72,12.60399724,7.583102992,0.798765332,0.9,0.6,-0.801844609
+2220,45637.24138,983.4913793,556.8333333,1125.393678,39426.99713,791.9482759,760.6810345,1723.896552,22481.73276,570.5057471,813.0344828,1774.721264,31439.56897,1363.057471,5008.91954,3370.985632,11201.70402,1352.70977,369.7385057,2434.816092,22024.89943,526.8821839,404.5890805,1313.83046,26817.42816,465.3591954,357.0172414,3539.356322,21249.23563,1705.991379,609.5086207,2822.195402,18032.06897,651.3793103,294.2068966,5181.882184,14314.69253,1086.801724,443.566092,1336.445402,10271.17241,801.7643678,169.1293103,4042.58046,8844.232759,1372.034483,359.3850575,3352.218391,877.8103448,517.1264368,348,25.53816293,19.20562433,0.659121746,0.848780488,0.535384615,0.728403973
+2221,55786.58696,956,583.3804348,1158.01087,56241.68478,775.6521739,581.8913043,1814.565217,30026,620.5434783,607.7826087,1802.456522,40421.6413,1404.913043,7230.782609,6210.630435,14832.16304,1493.445652,407.076087,2759.054348,30428.02174,489.923913,160.8913043,566.0434783,37292.05435,458.3804348,144.7065217,4710.23913,28636.72826,1702.391304,711.2717391,2815.978261,24546.42391,649.5434783,343.5869565,3140.043478,18182.03261,978.8913043,483.3804348,1308.043478,13482.59783,685.0434783,178.7934783,3067.673913,11209.73913,1491.934783,174.4347826,3411.706522,227.9673913,511.7717391,92,13.10114185,9.138348905,0.716562309,0.958333333,0.657142857,-1.392003465
+2222,26770.56303,728.4033613,433.6638655,1048.268908,24061.21849,594.3529412,406.7647059,1443.773109,13345.35294,487.7394958,454.2689076,1764.92437,18251.44538,1146.02521,5563.260504,2410.117647,6854.487395,1274,330.6218487,2392.806723,13240.79832,392.4705882,531.9663866,415.0336134,16002.10924,386.3697479,119.9495798,3147.756303,12314.71429,1435.521008,773.2689076,2812.815126,10965.42857,623.4957983,257.1932773,1634.87395,8342.655462,818.1512605,413.9663866,1304.831933,6459.823529,683.8487395,160.5630252,3259.042017,5976.327731,1257.436975,500.0588235,3158.302521,336.4957983,513.5294118,119,15.20978461,10.28548423,0.736680208,0.937007874,0.653846154,0.568838512
+2223,26429.28774,829.0377358,542.4575472,1065.084906,23140.67453,664.0141509,743.3867925,1519.867925,13452.33019,515.4716981,924.7688679,1764.127358,18716.53302,1274.141509,4855.179245,3642.485849,6486.806604,1249.372642,324.745283,2452.023585,13106.94811,524.3066038,171.7075472,796.1037736,15162.95283,1289.924528,118.6226415,3036.745283,12023.74057,1453.433962,735.8490566,2831.919811,10664.60849,777.4245283,269.0377358,2074.674528,8427.95283,1123.641509,412.9858491,1308.589623,6361.915094,633.7311321,159.745283,4392.938679,5777.518868,1314.825472,403.8160377,3192.561321,592.5660377,516.9103774,212,22.89431525,12.68006756,0.832614981,0.844621514,0.560846561,0.422552024
+2224,26362.27273,830.9393939,520.9393939,1041.212121,21997.21212,643.4848485,528.1212121,1460.106061,13153.34848,503.1363636,565.1969697,1701.787879,17767.5303,1262.075758,2876.757576,2795.166667,6479.151515,1320.651515,324.3030303,2420.121212,12803.01515,439.9242424,213.6818182,578.0151515,15145.42424,421.530303,124.8484848,1980.727273,11594.4697,1490.136364,763.4545455,2781.848485,10239.66667,654.7424242,263.5606061,1663.393939,8174.621212,875.1969697,403.1818182,1293.606061,6347.80303,647.9393939,156.7575758,1907.439394,5515.909091,1319.151515,516.3030303,3078.80303,600.5454545,511.6363636,66,11.6880261,7.436524166,0.771481708,0.942857143,0.66,0.697119972
+2225,39883.14815,937.9382716,652.3703704,1153.777778,34121.38272,746.7037037,824.962963,1678.506173,19268.46914,581.9135802,1502.839506,1803.864198,28211.2716,1379.592593,4571.320988,4221.753086,10048.37037,1333.259259,378.2716049,2847.91358,19667.01235,512.9876543,502.7037037,1966.049383,23791.54321,477.4320988,168.7777778,2399.666667,18215.23457,2025.938272,658.5432099,2816.876543,15602.01235,938.2469136,291.4938272,1898.123457,13067.54321,1625.580247,435.5679012,1320.82716,9619.888889,781.1481481,167.0864198,2934.777778,8255.283951,1427.987654,288.4197531,3366.777778,756.8148148,513.037037,81,11.32266269,9.595111831,0.530914504,0.89010989,0.613636364,-0.656427168
+2226,24934.15493,1022.014085,625.9295775,1074.661972,21447.88732,747.5211268,653.2394366,1564.352113,11558.69014,573.5915493,1597.309859,1859.971831,16824.98592,1340.042254,6025.450704,4958.197183,5704.56338,1226.338028,339.6338028,2500.225352,11313.69014,519.5070423,479.7464789,1432.450704,13267.66197,494.3239437,234.0985915,4022.957746,10480.61972,2251.56338,580.8169014,2797.591549,8845.746479,687.3943662,252.4507042,2882.788732,7110.098592,1222.014085,396.2394366,1309.521127,5311.309859,720.7323944,161.3098592,4977.197183,4321.56338,1216.676056,633.6338028,3470.71831,854.6197183,513.1267606,71,10.4308126,9.299805641,0.452881773,0.946666667,0.645454545,-0.225462825
+2227,34609.4,878.5612903,659.9935484,1115.535484,30811.21935,703.2322581,881.5483871,1742.509677,16087.44516,519.1290323,1473.929032,1737.470968,23506.22581,1277.503226,6696.567742,4596.412903,8295.890323,1249.322581,349.5870968,3834.406452,16346.25161,2980.819355,569.6193548,1004.529032,19769.93548,468.9870968,141.3806452,4407.470968,15435.92258,2085.496774,583.4967742,2821.812903,12859.23226,675.483871,273.7225806,5531.393548,10130.06452,1805.748387,416.116129,1326.232258,7457.270968,757.1612903,170.0451613,3883.264516,6221.464516,1279.341935,399.0645161,3299,904.2193548,515.5419355,155,17.32525282,12.19699328,0.710199097,0.870786517,0.574074074,-0.340272986
+2228,27341.31667,751.4777778,507.2166667,1084.488889,15973.17778,524.5222222,521.4277778,1464.1,8815.227778,417.6777778,656.4333333,1694.416667,12519.87222,1012.744444,5626.872222,2260.177778,4611.844444,1054.761111,291.0888889,3671.872222,8630.438889,8445.683333,223.8222222,538.7277778,10002.78889,407.2777778,107.4777778,4532.994444,8391.772222,1536.333333,544.9,2774.583333,6940.8,569.2333333,232.0388889,12140.32222,5403.1,830.2777778,352.1166667,1302.816667,3552.111111,667.5611111,148.0277778,3184.327778,3229.216667,1031.872222,212.5722222,3111.288889,948.1388889,514.8944444,180,17.52825463,13.64982859,0.627355615,0.909090909,0.62283737,0.805447084
+2229,21965,796.4298246,451.2368421,1043.289474,20277.90351,607.9122807,352.4736842,1379.631579,10764.29825,488.2192982,463.9122807,1759.833333,14432.86842,1148.131579,2783.508772,1589.754386,5495.385965,1277.429825,326.0175439,2416.903509,10839.24561,411.7368421,418.7631579,433.0701754,12692.14912,354.4912281,117.9473684,2093.254386,9600.789474,1487.850877,648.1491228,2825.263158,8497.508772,831.1929825,249.5,1219.061404,6609.807018,745.7105263,408.254386,1384.429825,5180.885965,664.9912281,165.2017544,4031.605263,4669.447368,1223.061404,204.7368421,3218.22807,349.5789474,514.3684211,114,13.79203792,10.89017636,0.613623469,0.919354839,0.626373626,0.64161582
+2230,32460.86957,963.5652174,530.4492754,1126.898551,28643.98551,742.9275362,620.5362319,1611.594203,15906.92754,576.2753623,539.0289855,1777.884058,21537.46377,1366.246377,4929.057971,3478.666667,7841.492754,1379.594203,374.6086957,2453.565217,17168.78261,490.8695652,308.2173913,567.4057971,18592.85507,442.7536232,135.2753623,4631.724638,14390.50725,1594.985507,1154.202899,2811.405797,12922.69565,625.2318841,300.9710145,1854.507246,10177.68116,921.0289855,465.6666667,1318.753623,7937.391304,701.3478261,175.8985507,3292.681159,6841.101449,1405.768116,154.6666667,3367.492754,406.2608696,512.8550725,69,10.80553292,9.013092559,0.551585615,0.896103896,0.570247934,-0.748659264
+2231,30426.0625,822.4375,528.2767857,1088.732143,25975.44643,666.7321429,804.8571429,1557.678571,14839.45536,508.8125,1268.705357,1771.276786,21109.83929,1264.848214,8182.089286,3580.714286,7462.035714,1226.107143,336.4642857,2596.017857,14954.44643,1395.955357,371.8839286,1599.044643,17662.94643,627.4285714,198.6875,3684.008929,13511.25893,2071.098214,565.4464286,2782.089286,11559.78571,726.9910714,255.5535714,2013.633929,9315.392857,1178.526786,403.4375,1286.044643,6908.776786,672.0089286,156.1428571,5025.5625,5878.928571,1224.410714,292.0178571,3187.866071,814.1785714,513.8303571,112,15.60091562,9.369291636,0.799579417,0.933333333,0.615384615,-0.788451604
+2232,49441.41379,937.637931,560.2758621,1152.051724,20830.37931,505.637931,268.7413793,1440.396552,10034.37931,380.4482759,572.2241379,1666.62069,15418.25862,958.362069,3870.982759,2516.586207,5930.603448,1008.448276,285.3103448,2803.396552,10857.81034,342.8965517,249,452.0862069,13230.13793,300.0172414,106.1896552,3347.534483,10200.58621,1491.758621,477.9482759,2815.396552,8239.482759,491.2413793,210.3448276,2707.551724,5995.224138,735.4482759,330.2758621,1269.431034,3125.758621,585.4137931,135.9137931,1311.206897,3237.431034,930.637931,149.4827586,2963.982759,1076.172414,510.8275862,58,13.78264465,5.45684094,0.918284498,0.920634921,0.69047619,1.424533256
+2233,32874.70248,956.0495868,496.8181818,1080.099174,29113.09917,745.9008264,643.6363636,1568.983471,16295.66116,577.231405,571.9256198,1742.22314,22287.29752,1383.892562,3891.958678,2560.991736,7994.380165,1733.082645,384.5454545,2423.68595,14633.90083,428.7107438,362,528.0247934,16856.71074,436.8099174,127.4876033,2357.280992,13050.04132,1449.280992,733.0165289,2817.859504,11515.71901,1002.272727,278.4132231,1584.909091,9321.942149,859.7355372,439.2809917,1332.92562,7274.132231,687.7933884,180.8512397,4579.173554,6398.950413,1364.586777,328.1735537,3212.818182,423.1157025,516.553719,121,17.49943758,9.115706037,0.853609024,0.923664122,0.593137255,-0.498665644
+2234,24377.7027,895.0720721,520.8198198,1061.477477,21094.2973,692.1891892,503.4414414,1441.72973,12042.21622,554.4414414,445.972973,1720.117117,17026.3964,1315.855856,6668.891892,2943.108108,6032.468468,1315.513514,360.4774775,2378.774775,11974.6036,424.6936937,345.4324324,435.4144144,14097.33333,386.7837838,127.5495495,4230.864865,10939.90991,1499.099099,718.8288288,2803.414414,9634.837838,611.1171171,276.9369369,1596.45045,7565.981982,867.1711712,438.8918919,1302.198198,5843.612613,699.981982,171.5315315,3261.126126,5268.09009,1356.792793,1102.684685,3232.927928,464.2702703,515.1351351,111,14.24032497,10.10240222,0.704783788,0.965217391,0.656804734,0.919304377
+2235,29894.67358,868.5906736,528.3471503,1082.393782,25485.5285,682.1813472,657.2901554,1521.958549,14358.27979,542.7409326,660.9222798,1738.264249,20061.54922,1295.891192,5214.062176,3395.73057,7214.357513,1561.777202,358.2487047,2425.88601,14190.76166,452.7668394,847.1606218,486.2072539,16764.20207,415.0777202,126.2279793,2672.854922,12843.74093,1681.450777,871.5440415,2804.362694,11337.03109,777.4974093,286.0673575,1661.217617,8898.84456,1011.176166,435.5388601,1326.937824,6990.207254,821.4093264,169.7979275,2459.663212,6115.611399,1338.865285,507.238342,3283.165803,516.3367876,516.4352332,193,18.66220322,13.34266727,0.69916873,0.927884615,0.72556391,1.382452779
+2236,31339.54688,1037.289063,617.796875,1129.539063,25366.73438,763.4609375,595.6015625,1634.515625,14408.58594,592.1640625,534.8125,1774.601563,19483.6875,1385.945313,6526.421875,4250.570313,6693.992188,1346.773438,371.7421875,2444.390625,13829.77344,476.109375,662.234375,522.2265625,15871.13281,441.359375,129.453125,7070,12281.85938,1533.15625,810.9296875,2809.203125,11017.05469,708.6328125,298.4921875,2013.953125,8683.625,896.9375,444.1796875,1313.476563,6678.640625,767.4921875,177.84375,5529.921875,5930.679688,1344.492188,522.703125,3312.867188,543.53125,517.6796875,128,14.94550152,11.32915521,0.652218388,0.948148148,0.775757576,-0.25150333
+2237,30931.39706,847.75,534.4117647,1099.419118,26285.43382,672.8897059,563.4779412,1613.911765,14903.51471,509.6323529,811.9779412,1797.558824,21175.54412,1329.727941,5357.330882,3930.580882,7483.051471,1241.963235,336.3529412,2484.933824,14918.875,1847.610294,1423.169118,793.7426471,17785.13235,573.75,132.3161765,2792.485294,13318.69118,1686.007353,641.9779412,2784.147059,11526.58088,622.1617647,250.9264706,1850.132353,9226.816176,1179.963235,410.4852941,1322.860294,6655.654412,998.7720588,162.2647059,4541.683824,5619.808824,1254.970588,300.7573529,3210.610294,821.2794118,519.6176471,136,18.2782736,10.42446258,0.821422698,0.839506173,0.472222222,-0.56868558
+2238,33815.31304,1004.765217,540.5695652,1094.743478,31108,772,733.2130435,1577.808696,16907.3913,597.6652174,920.9,1791.265217,22993.07826,1361.73913,3758.73913,3204.134783,8184.765217,1427.173913,367.9565217,2461.973913,16509.63913,3413.934783,1628.608696,675.4347826,19748.17826,471.4913043,280.8,3293.691304,15182.4087,1950.93913,714.0347826,2814.621739,13490.64783,719.6826087,306.6,1838.630435,10299.46957,1010.795652,462.5086957,1383.065217,7892.508696,1098.091304,180.1304348,4538.134783,7057.108696,1391.53913,181.1826087,3341.913043,367.0652174,518.0347826,230,24.76545668,12.51407754,0.862941565,0.851851852,0.666666667,1.492110263
+2239,41969.67188,1128.5625,536.796875,1114.875,34903.25,815.1875,563.953125,1604.203125,20618.53125,651.71875,636.328125,1743.359375,27249.375,1481.8125,4763.21875,2573.109375,9501.875,1497.21875,384.46875,2495.796875,16089.29688,443.5,212.09375,495.96875,18852.125,406.703125,130.21875,2818.359375,15099.60938,1679.359375,792.5625,2817.203125,13346.28125,670.1875,284.078125,1374.421875,10455.15625,919.4375,445.46875,1316.046875,7790.921875,653.921875,168.09375,2553.96875,7112.40625,1346.453125,136.21875,3441.609375,413.921875,515.5625,64,9.835029673,8.358351218,0.527016243,0.984615385,0.711111111,-0.482786759
+2240,35389.49863,897.0438356,525.2136986,1090.857534,31338.43288,713.6465753,565.3863014,1527.726027,17819.88767,572.9945205,496.9506849,1758.136986,24330.34795,1332.052055,5966.082192,3229.605479,8678.676712,1377.128767,387.2630137,2401.739726,18122.96438,1460.605479,896.539726,479.290411,21069.50959,437.4849315,132.1643836,2868.134247,16020.08219,1702.082192,817.2465753,2805.863014,14133.78904,678.6136986,295.7150685,1518.583562,11166.92603,976.1232877,448.7260274,1319.331507,8688.539726,844.4219178,178.2493151,3168.00274,7686.512329,1394.432877,433.6410959,3318.753425,441.1068493,523.3863014,365,25.84265227,18.94789201,0.680010582,0.881642512,0.634782609,-0.940634886
+2241,25490.17021,888.606383,593.3510638,1062.489362,21449.1383,698.2021277,946.6170213,1482.212766,12334.03191,549.0106383,1587.425532,1802,16802.41489,1295.553191,5523.840426,4381.276596,6070.702128,1297.574468,352.3297872,2764.93617,12047.03191,448.3191489,1531.244681,948.4361702,13535.48936,1388.489362,122.7553191,2412.595745,10902.53191,1953.255319,1017.734043,2802.617021,9800.329787,657.0638298,264.0957447,1572.840426,7581.989362,1542.43617,425.5319149,1340.553191,5576.468085,912.9361702,167.8297872,3893.191489,5085.606383,1309.861702,436.3404255,3261.542553,553.6914894,516.9680851,94,12.12857198,10.81159094,0.453187935,0.912621359,0.602564103,0.387316565
+2242,47337.19079,916.1864035,569.9232456,1149.14693,26211.22149,594.7171053,470.2258772,1629.866228,12575.14035,437.5350877,522.2938596,1682.328947,19712.03509,1108.692982,8331.673246,3423.739035,7241.410088,1141.475877,310.3355263,2732.95614,13469.13377,477.4934211,181.8991228,475.7324561,16123.0943,355.6096491,116.5526316,6375.359649,12563.07675,1469.243421,499.622807,2791.195175,10127.13596,558.9605263,244.3267544,4818.27193,7025.583333,748.5899123,364.4561404,1280.300439,3761.780702,586.9758772,140.4890351,2143.210526,3814.046053,1031.710526,315.0526316,3144.407895,1075.287281,524.3464912,456,26.78061895,23.40068705,0.486300084,0.868571429,0.651428571,0.150727073
+2243,21369.28947,816.6578947,706.5263158,1111.421053,24151.34211,648.3684211,562.3421053,1684.315789,10705.63158,521.4736842,560.3684211,1825,15592.55263,1157.710526,10490.73684,9841.105263,5928.894737,1259.5,336.5,2399.526316,13588.42105,409.2368421,133.2105263,454.2105263,15158.92105,427.3157895,123.9736842,7871.289474,10867.65789,1373.315789,958.2368421,2791.473684,9820.263158,616.1315789,263.1315789,5783.394737,7501.052632,788.2105263,412.5263158,1299.184211,6271.868421,626.2368421,180.2105263,5593.763158,4433.789474,1276.921053,300.3157895,3369.184211,238.6842105,515.7894737,38,9.472588591,5.559921283,0.809624299,0.88372093,0.527777778,1.047401335
+2244,55879.78832,937.8978102,584.8540146,1183.007299,16982.26277,455.2189781,296.5182482,1295.708029,8926.058394,386.6131387,567.2992701,1715.854015,11849.81752,915.9781022,4881.167883,3461.277372,4911.781022,973.4379562,268.4452555,2399.058394,9329.635036,271.5547445,97.59854015,406.2554745,10713.83212,275.6715328,100.189781,5639.007299,8066.10219,1252.781022,460.080292,2782.773723,6849.145985,474.1313869,218.2043796,4470.153285,4453.963504,668.8321168,343.459854,1273.722628,3383.948905,509.8686131,139.8321168,1498.364964,2876.131387,932.8321168,115.3868613,2933.59854,176.1386861,519.8175182,137,15.5806498,11.38675948,0.682562746,0.925675676,0.702564103,-0.224910001
+2245,38643.02469,879.7777778,535.0740741,1098.17284,37824.4321,736.2962963,540.1358025,1673.148148,18804.35802,644.7407407,550.7283951,1829.469136,26306.97531,1313.814815,7010.493827,4478.123457,10108.74074,1439.222222,605.4938272,2359.246914,19133.03704,451.0987654,3060.54321,502.8395062,23822.07407,453.4938272,136.1234568,4070.962963,17377.01235,1687.691358,625.4567901,2808.469136,14616.28395,628.8148148,303.4444444,3814.851852,10132.08642,844.2962963,451.4074074,1346.975309,7727.345679,1250.617284,178.8395062,4967.888889,6448.54321,1358.530864,165.962963,3332.432099,196.7530864,518.4691358,81,11.36376642,9.296091654,0.575151799,0.920454545,0.75,0.085418043
+2246,43661.56291,1042.953642,569.5496689,1114.602649,39632.74834,721.1258278,601.384106,1602.543046,22381,573.4635762,922.781457,1751,30212.39073,1312.476821,8663.463576,4622.417219,10921.62914,1403.708609,366.8476821,2409.476821,22801.71523,442.8344371,174.4569536,498.4437086,26578.82119,459.6357616,134.1986755,5494.562914,21188.76159,1532.350993,762.2516556,2812.496689,18419.39073,633.4635762,306.1456954,2237.84106,13859.57616,991.0331126,459.2450331,1309.980132,10533.25828,650.4238411,179.602649,3914.821192,9129.801325,1381.238411,208.9139073,3360.556291,277.7682119,522.0927152,151,18.03464969,10.92324014,0.795707754,0.932098765,0.662280702,-0.351848622
+2247,34852.42282,1018.013423,555.2348993,1118.691275,30375.94631,817.2281879,834.8657718,1615.174497,17072.10067,594.5100671,1343.248322,1787.469799,23239.49664,1402.355705,4900.020134,3295.38255,8477.362416,1413.771812,388.4228188,2491.268456,15745.9396,472.6845638,629.0134228,1294.120805,17783.22148,456.5838926,703.7919463,3611.979866,13740.71141,2051.939597,783.6577181,2799.255034,12154.68456,626.2818792,299.4026846,1754.369128,9444.067114,1012.52349,448.7516779,1333.577181,7227.38255,816.852349,179.0604027,5189.583893,6447.281879,1384.161074,322.3624161,3334.926174,397.6845638,518.9530201,149,17.67122434,11.08750337,0.778670824,0.93125,0.653508772,1.335464172
+2248,41829.34826,908.8358209,541.9701493,1125.004975,35984.56219,743.3731343,712.0298507,1614.691542,21734.58209,575.8059701,932.7860697,1769.557214,29650.27861,1414.636816,4845.41791,4266.626866,9939.20398,1393.756219,366.1641791,2524.636816,20300.97512,499.0547264,274.2089552,592.5422886,23205.54229,850.3432836,132.2835821,3499.21393,18738.44776,1613.945274,911.8308458,2818.597015,16486.80597,642.0597015,314.5970149,1889.746269,13108.58209,1203.870647,466.6268657,1312.38806,9744.820896,699.0049751,173.9154229,2696.21393,8695.208955,1433.318408,301.9303483,3259.049751,570.1840796,522.199005,201,21.03171876,14.27914488,0.734199487,0.810483871,0.503759398,-0.995534657
+2249,24369.49351,945.7532468,598.7922078,1074.363636,20800.12987,705.1818182,439.5584416,1496.974026,11507.81818,547.8961039,492.1168831,1781.532468,15613.67532,1306.74026,7804.064935,4077.103896,5744.428571,1253.519481,324.6753247,2382.376623,11137.62338,439.8051948,537.2337662,489.2207792,12979.49351,441.5064935,119.7662338,4805.701299,9835.662338,1592.558442,887.3636364,2802.467532,8569.506494,598.4415584,252.9480519,1999.142857,6831.571429,857.4025974,394.6883117,1299.12987,5330.220779,727.1168831,158.6753247,4663.441558,4201.116883,1237.675325,187.2857143,3348.753247,583.7402597,519.8831169,77,12.67726618,7.833614671,0.786236119,0.974683544,0.6875,0.085463602
+2250,21152.85149,977.3168317,627.049505,1091.455446,19181.78218,730.4851485,658.990099,1547.524752,10231.0396,544.8118812,515.9306931,1767,14723.83168,1320.663366,3334.584158,2384.069307,5426.673267,1238.90099,333.8415842,2390.445545,10151.9703,3839.267327,132.980198,647.7326733,12324.93069,512.2475248,118.6732673,2145.108911,9168.485149,1490.386139,705.6831683,2817.920792,8220.970297,1190.118812,263.6633663,2169,6778.970297,1355.60396,407.1782178,1306.455446,5427.821782,630.5940594,164.8712871,3683.960396,4628.831683,1343.049505,245.4554455,3243.940594,651.7425743,519.5445545,101,13.34596128,10.10054407,0.653618698,0.855932203,0.554945055,-1.002710569
+2251,30612.32468,878.0519481,457.5454545,1076.831169,25957.02597,709,474.4675325,1495.519481,15220.58442,530.3116883,690.2467532,1703.896104,20431.38961,1346.272727,2181.181818,2625.571429,7445.376623,1271.064935,357.7142857,2607.649351,14947.8961,463.6883117,372.8441558,730.3636364,17829.76623,406.3896104,140.4025974,1410.168831,13809,1490.922078,591.974026,2802.766234,12289.96104,629.4545455,270.6883117,1832.896104,10092.37662,931.1818182,415.8701299,1313.246753,7526.467532,696.1428571,161.8701299,2839.519481,6441.623377,1381.077922,481.4415584,3104.909091,711.7662338,516.8181818,77,11.44042013,8.665456623,0.652902261,0.950617284,0.712962963,1.55318673
+2252,29132.16216,789.1351351,434.2162162,1056,24279.89189,633.7027027,713.8243243,1494.932432,14321.36486,492.3378378,1072.459459,1794.824324,20986.36486,1226.851351,3646.22973,2470.013514,7233.986486,1235.905405,412.1891892,2439.918919,14749,589.3648649,247.5405405,953.1756757,17378.27027,423.3783784,114.0405405,1290.702703,13635.24324,1773.405405,540.6216216,2789.364865,11591.14865,1032.22973,260.3513514,1659.513514,9615.27027,2491.810811,398.5810811,1305.824324,6818.581081,661.527027,149.1351351,2700.445946,6219.040541,1262.054054,380,3156.094595,790.3378378,517.4594595,74,10.63542493,9.156751628,0.508660539,0.925,0.611570248,-0.823022224
+2253,32971.83237,811.7283237,572.6127168,1096.202312,20531.75723,580.8786127,576.1387283,1445.184971,11303.79191,427.699422,880.7803468,1694.364162,16637.30636,1071.757225,8026.468208,4345.271676,5999.641618,1103.618497,303.1907514,2899.369942,11812.20231,456.0809249,145.0520231,987.0404624,13580.66474,359.5144509,114.4508671,7770.16185,11604.91329,1689.809249,678.2890173,2773.635838,9637.959538,565.7514451,240.2196532,8910.300578,7624.66474,888.7976879,368.2369942,1300.971098,5368.225434,737.1213873,151.3121387,4163.913295,4805.017341,1100.057803,281.5433526,3075.716763,923.5895954,521.6184971,173,18.43314115,12.77571157,0.720857019,0.891752577,0.565359477,0.80348428
+2254,16717.27778,776.7222222,749.8333333,1112.777778,13248.72222,582.5666667,923,1703.944444,6731.466667,438.3888889,1312.533333,1761.1,9733.8,1102.555556,7983.766667,3661.911111,3671.588889,1089.1,298,4971.366667,6991.9,849.0666667,737.2111111,989.7555556,8450.266667,462.4,114.7888889,9920.822222,6858.433333,1898.211111,661.5222222,2784.722222,5797.466667,632.7444444,250.6888889,21296.25556,4542.555556,932.7777778,369.7111111,1322.788889,2922.533333,768.4222222,153.9777778,6340.133333,2738.466667,1082.611111,275.8555556,3167.622222,985.7444444,517.9666667,90,11.89425066,9.653881004,0.584154282,0.957446809,0.75,-1.471576953
+2255,45973.9661,928.9576271,570.7033898,1152.788136,15129.60169,491.1355932,269,1381.262712,6359.881356,367.1864407,457.0423729,1649.389831,10770.89831,920.5084746,6230.322034,2364.79661,4002.144068,946.3474576,265.5338983,2366.940678,7188.483051,287.0677966,85.83898305,613.5932203,8382.923729,286.8898305,101.9745763,3849.618644,6635.355932,1506.889831,432.9322034,2784.330508,5215.872881,462.1016949,195.5508475,1286.440678,3284.347458,619.5254237,319.7457627,1255.813559,1555.008475,489.2966102,127.8728814,2311.449153,1778.194915,862.7542373,180.7711864,2896.271186,1114.550847,517.6186441,118,15.97200577,9.795431357,0.789859768,0.921875,0.786666667,1.487094375
+2256,58392.11111,949.7569444,571.6875,1158.861111,55263.59028,784.9375,756.7986111,1864.104167,29035.88889,606.6597222,666.7013889,1793.777778,39450.15972,1422.694444,9865.451389,5735.034722,15204.84722,1505.881944,410.4166667,2446.027778,29413.23611,485.2291667,203.6597222,461.7361111,35386.15972,460.4027778,144.6944444,5905.236111,26404.01389,1658.506944,652.7222222,2863.444444,22167.18056,657.5347222,341.1875,5008.409722,14918.16667,913.3611111,474.6597222,1317.125,11148.73611,680.4375,190.1944444,2934.763889,9295.277778,1401.118056,199.5486111,3322.854167,188.0763889,521.8125,144,16.73235669,12.21270458,0.683569421,0.822857143,0.6,0.245969205
+2257,41382.51587,904.031746,690.3412698,1133.055556,34325.38095,733.2539683,746.2777778,1652.97619,20448.63492,560.2619048,1528.674603,1805.047619,27908.94444,1346.960317,4336.214286,3438.642857,9990.753968,1345.111111,365.8095238,2532.936508,20347.59524,494.7698413,134.9126984,972.5079365,24566.92063,467.1904762,249.5873016,2326.02381,18929.6746,2254.547619,672,2824.880952,16678.13492,876.1746032,301.6428571,1772.31746,13893.62698,1434.507937,444.1746032,1310.007937,10130.38095,680.1904762,166.9126984,2119.690476,8737.484127,1455.825397,342.9444444,3266.18254,738.1349206,519.0873016,126,18.57919605,9.254100005,0.867125702,0.863013699,0.583333333,-1.26637493
+2258,36473.45652,892.6956522,992.1521739,1164.717391,32539.8913,691.826087,864.3695652,1991.963768,17213,496.4275362,2236.355072,1844.76087,25162.86957,1244.652174,5401.449275,4024,9049.391304,1291.318841,355.7028986,3517.971014,17161.37681,709.8333333,488.0797101,661.2971014,21165.44928,2167.550725,128.1014493,4994.007246,16954.58696,1852.463768,559.8913043,2843.57971,13881.61594,618.6594203,282.4202899,9736.92029,10711.55072,1545.23913,419.4855072,1310.094203,6730.681159,767.5507246,165.1376812,4840.34058,6218.210145,1245.152174,253.2173913,3289.565217,997.6594203,520.2028986,138,13.91387213,12.93707175,0.368073609,0.93877551,0.707692308,-0.528135527
+2259,39891.4,846.5783784,611.6486486,1121.043243,17395.43784,452.0378378,514.9567568,1234.956757,8314.983784,379.427027,879.2,1676.297297,11414.87568,909.4864865,5005.497297,1457.724324,4501.702703,968.3297297,263.9297297,2830.205405,8265.697297,342.0432432,346.1243243,463.3513514,9899.502703,283.2648649,152.0054054,3419.081081,7303.291892,1323.07027,410.5351351,2794.513514,6030.962162,466.2864865,198.1135135,2214.383784,3562.491892,639.3945946,325.8702703,1278.535135,2729.102703,569.8810811,133.827027,1252.454054,2394.951351,899.9567568,198.9783784,3017.086486,158.4810811,522.7675676,185,17.35077203,14.16598675,0.577420301,0.958549223,0.570987654,0.762633652
+2260,21418.7458,896.6546763,558.4268585,1073.335731,18780.66187,691.0503597,689.0911271,1510.292566,10547.13189,744.9064748,914.6930456,1758.623501,14843.30935,1284.522782,2982.990408,2535.196643,5347.081535,1358.055156,357.2134293,2575.026379,10851.39089,447.3693046,481.1294964,698.2517986,12714.4988,572.5275779,116.8872902,1446.36211,9772.932854,1700.889688,631.1079137,2799.033573,8659.119904,773.3165468,263.8848921,1694.7506,7005.776978,1053.453237,403.9688249,1376.002398,5522.776978,793,156.7673861,2889.316547,4689.316547,1321.64988,530.1270983,3183.340528,609.294964,526.9760192,417,25.66690334,20.97733585,0.576224775,0.939189189,0.758181818,-0.419072093
+2261,29146.19355,830.5806452,432.9139785,1071.967742,25323.30108,669.6989247,597.3548387,1474.698925,14514.91398,528.6666667,393.2258065,1709.268817,20721.91398,1286.580645,2735.354839,2024.935484,7525.107527,1234.784946,350.9462366,2362.129032,15121.75269,495.9354839,233.9139785,449.2795699,18398.54839,415.655914,119.7956989,2092.107527,14028.49462,1450.516129,756.5376344,2788.935484,12559.5914,621.7419355,275.8709677,1999.247312,10301.02151,825.0537634,407.1075269,1314.139785,7564.16129,663.3978495,167.0537634,3208.301075,6658.236559,1391.731183,1422.236559,3154.83871,664.5376344,520.2580645,93,11.18535573,10.87730334,0.233072703,0.939393939,0.645833333,-0.567331237
+2262,55924.16667,927,521.0208333,1152.916667,45464.89583,770.3541667,555.1875,1848.458333,26845.5625,553.6666667,450.4375,1724.229167,35701.5625,1377.958333,5574.270833,4375,13152.375,1378.166667,384.5416667,2480.520833,25969.08333,1277.791667,156.2291667,475.1041667,29822.91667,460.7083333,135.5625,4304.166667,25797.3125,1534.104167,671.4375,3106.395833,21747.35417,653.5,318.0833333,2433.583333,16611.41667,892.9166667,447.6875,1302.354167,11110.29167,661.9791667,169.8333333,2672.5,9940.875,1394.979167,137.1458333,3361.25,912.2916667,519.2708333,48,8.200085046,7.520453201,0.398613689,0.96,0.666666667,-0.087543186
+2263,26243.93363,824.1238938,582.2964602,1092.504425,23392.85398,676.0929204,940.3982301,1736.119469,11925.26549,495.3982301,1947.123894,1808.163717,18134.15929,1213.20354,7402.929204,2931.283186,6687.482301,1213.415929,338.9646018,6554.022124,12429.74336,2873.336283,3103.336283,993.6504425,15512.36283,658.6017699,133.1460177,2733.858407,12001.39823,2238.057522,519.3982301,2809.09292,9768.942478,617.5840708,270.1637168,6927.955752,7508.066372,1659.216814,405.2345133,1516.393805,4732.207965,1385.00885,159.7477876,5730.80531,4390.331858,1188.902655,338.5132743,3212.765487,1012.977876,523.7920354,226,19.83531381,15.05336737,0.651186749,0.941666667,0.697530864,-0.922842658
+2264,23237.7541,751.6557377,533.057377,1099.795082,17313.86885,532.5245902,745.4344262,1498.852459,8822.540984,413.4754098,931.5163934,1756.885246,13380.22131,1104.5,7004.352459,2327.819672,4908.090164,1053.811475,294.8360656,3200.754098,8948.106557,4539.688525,549.9098361,751.5245902,10872.10656,427.1803279,115.4180328,5890.47541,8666.483607,1832.508197,556.9836066,2788.622951,7003.196721,594.0737705,217.5901639,5436.45082,5328.07377,1112.606557,350.057377,1288.97541,3124.557377,764.6065574,139.2295082,3979.139344,3011.065574,1017.016393,190.2295082,3138.877049,1027.540984,521.8606557,122,15.09419293,10.61818389,0.710733347,0.93129771,0.625641026,0.656144176
+2265,56691.60504,945.5210084,562.1344538,1150.378151,56285.10924,786.6218487,684.9915966,1791.663866,31213.05042,614.0672269,527.1344538,1763.285714,41073.65546,1409.739496,6823.529412,5391.352941,15387.37815,1509.966387,403.6806723,2404.487395,30820.01681,487.5210084,158.7647059,434.6890756,37966.40336,450.4705882,140.7815126,5111.504202,29176.59664,1578.420168,689.4033613,2865.579832,25052.16807,642.3697479,346.0588235,3037.344538,18252.26891,941.7142857,492.2268908,1311.478992,13524.97479,684.3277311,183.0420168,2414.512605,11522.21849,1474.470588,163.4705882,3363.579832,227.907563,520.8319328,119,17.69344614,8.908518856,0.863999549,0.92248062,0.601010101,-1.293361085
+2266,42671.20645,889.9419355,622.883871,1134.909677,41512.3871,718.2064516,678.6064516,1721.63871,23322.25806,571.8193548,528.2064516,1802.541935,30523.73548,1311.406452,10202.32258,7731.012903,11234.93548,1418.890323,379.2451613,2368.174194,23677.65806,462.3096774,147.3741935,445.3225806,28088.70968,438.9935484,138.2516129,7539.393548,21393.87097,1508.683871,986.8193548,2821.683871,18570.71613,643.2580645,312.6451613,3159.03871,13509.61935,880.8258065,462.7806452,1305.174194,10361.84516,654.7032258,181.3225806,3484.729032,8647.670968,1392.03871,184.2967742,3341.683871,241.5419355,524.5096774,155,18.30382529,11.64467296,0.771534122,0.885714286,0.569852941,-0.728792132
+2267,16522.68208,794.5491329,451.4971098,1061.99422,14396.20809,628.6763006,464.5722543,1403.878613,8105.040462,482.6878613,420.9248555,1733.66474,11509.66474,1246,1588.092486,1030.739884,4132.901734,1256.473988,334.9768786,2394.67052,7552.682081,392.9942197,188.3294798,436.9017341,8706.849711,397.6878613,119.6763006,1193.34104,6669.930636,1509.485549,652.583815,2822.294798,5978.398844,783.9884393,259.4277457,1334.791908,4823.156069,776.0231214,414.5780347,1305.982659,3916.780347,639.734104,173.3294798,2449.942197,3443.16763,1361.445087,5494.190751,3193.531792,473.9710983,524.583815,173,17.17342482,12.91679795,0.659004802,0.950549451,0.640740741,-0.45077654
+2268,13136.14423,759.9711538,416.8461538,1028.894231,11701.68269,609.9326923,415.7403846,1338.605769,6548.432692,490.1923077,377.0288462,1675.836538,9437.076923,1218.75,2149.644231,1222.807692,3435.990385,1499.182692,316.0480769,2348.605769,6943.394231,417.1634615,442.4711538,445.8846154,8312.336538,362.3942308,116.1923077,875.7980769,6331.913462,1317.384615,631.9615385,2782.432692,5719.125,608.8076923,242.125,1563.490385,4842.673077,841.3846154,383.7019231,1296.5,3720.144231,689.4230769,147.7884615,1476.692308,3325.375,1347.701923,5016.384615,3012.807692,688.9807692,521.2211538,104,12.22689591,10.85672147,0.459963796,0.95412844,0.787878788,-0.491649813
+2269,35777.90789,906.5263158,804.3421053,1161.815789,31165.76316,747.8552632,1009.986842,1736.644737,18032.31579,553.7368421,865.4078947,1840.631579,25116.10526,1367.223684,4220.328947,3361.684211,8909.697368,1341.631579,373.0657895,2481.381579,18165.55263,537.8684211,566.5131579,3286.684211,21805.65789,463.4736842,130.0394737,2013.592105,16759.98684,1701.552632,588.3026316,2833.039474,14868.82895,1049.565789,292.2631579,1894.355263,12321.81579,2218.644737,437.0789474,1333.684211,9007.75,1086.184211,169.3552632,3256.828947,7734.223684,1435.447368,385.3947368,3609.815789,724.5657895,521.4342105,76,12.29371585,8.123373957,0.750584478,0.915662651,0.575757576,-0.723426464
+2270,29320.49677,783.2258065,431.5548387,1096.870968,24573.84516,645.9354839,550.1290323,1571.406452,14400.52258,492.7548387,1616.070968,1876.083871,20177.54839,1242.219355,3135.458065,2478.909677,7239.664516,1200.554839,322.716129,2490.219355,14428.26452,9600.606452,251.7032258,750.9096774,16955.61935,452.0774194,122.9354839,1333.645161,12965.67742,1544.290323,536.7612903,2784.754839,11263.93548,803.4322581,258.1096774,1751.774194,9109.6,2716.954839,392.0193548,1296.606452,6637.980645,672.2451613,158.1612903,3218.76129,5721.025806,1221.941935,167.6064516,3199.845161,800.7870968,522.4580645,155,15.38951916,13.1456958,0.519947932,0.945121951,0.607843137,-1.347610962
+2271,30568.55556,968.5686275,568.9673203,1089.738562,27561.39216,651.2418301,653.3071895,1593.457516,15114.53595,500.2941176,570.5555556,1748.496732,22726.8366,1249.366013,6218.535948,3737.901961,7953.614379,1223.503268,340.7385621,2450.921569,16335.69281,450.7124183,432.2614379,1136.457516,19501.54902,481.0457516,166.7058824,4274.30719,15220.04575,1643.385621,565.2941176,2797.509804,13225.37255,609.3660131,275.372549,2424.052288,10418.70588,1154.535948,418.2875817,1297.03268,7731.653595,776.7254902,167.5228758,5297.535948,6336.908497,1272.058824,242.8300654,3381.653595,865.8823529,523.4248366,153,17.35631078,12.30822416,0.705057852,0.874285714,0.5625,0.870480229
+2272,36413.06667,821.9809524,464.9809524,1099.666667,13958.47619,469.4952381,379.3809524,1333.142857,6353.228571,369.752381,639.2761905,1686.019048,10385.2381,928.6761905,4776.552381,1612.038095,3874.847619,964.6190476,266.0095238,2489.92381,6993.761905,289.3333333,96.51428571,624.9619048,8190.961905,296.9333333,156.7238095,1707.247619,6594.495238,1490.438095,411.4952381,2792.590476,5216.047619,475.0952381,194.3238095,1210.695238,3523.009524,758.4666667,323.8095238,1246.342857,1723.638095,506.1047619,128.4190476,1686.838095,1906.67619,895.0761905,368.8,2994.390476,1102.438095,521.7809524,105,13.07549816,10.26749096,0.619183106,0.981308411,0.807692308,-0.006797332
+2273,44154.13158,844.2368421,553.4605263,1078.026316,41201.31579,699.9605263,632.1315789,1578.486842,23299.72368,561.1842105,518.6052632,1741.078947,30693.71053,1291.986842,12040.73684,5658.565789,11087.01316,1393.342105,375.1447368,2398.302632,23845.57895,441.3157895,142.2894737,435.8815789,28203.59211,418.9210526,135.3815789,5906.131579,21829.78947,1481.671053,825.6842105,2805.407895,19144.57895,647.7631579,311.1315789,2351.368421,14130.05263,929.3289474,451.2631579,1307.473684,10847.47368,646.7368421,175.7105263,4560.026316,9330.210526,1395.473684,235.1184211,3238.539474,253.9868421,520.6447368,76,12.16113024,8.155109021,0.741829915,0.974358974,0.791666667,1.475429383
+2274,25126.29762,818.5178571,477.0714286,1071.446429,22961.94048,678.702381,468.8988095,1539.14881,12368.69048,521.6964286,525.2261905,1756.666667,16771.67857,1243.357143,6777.97619,3897.154762,6056.196429,1311.535714,358.1904762,2356.154762,12439.93452,430.2380952,1085.107143,463.9821429,14469.63095,402.7738095,129.5952381,4028.85119,11199.2381,1508.440476,856.577381,2808.327381,9866.220238,888.4821429,271.1488095,1892.60119,7540.357143,832.1130952,428.2202381,1320.577381,5868.72619,827.7380952,172.3630952,4058.142857,5377.630952,1342.083333,1545.964286,3251.964286,328.4166667,524.4345238,168,17.18625425,12.93484064,0.658447001,0.928176796,0.617647059,-0.666610897
+2275,19096.39683,841.8624339,561.4338624,1070.89418,17066.00529,666.6931217,567.7195767,1491.253968,9479.925926,571.4391534,925.0793651,1772.84127,13346.32275,1255.936508,4046.878307,3167.936508,4758.809524,1297.793651,430.1216931,2461.984127,9665.814815,438.037037,710.4497354,599.4391534,11171.95767,444.015873,190.9470899,2827.724868,8606.079365,1764.888889,722.6772487,2822.296296,7627.57672,854.978836,271.5185185,1636.94709,6085.645503,1085.338624,426.2592593,1325.380952,4811.21164,811.7777778,167.6507937,3292.936508,4257.407407,1306.994709,905.6719577,3262.227513,457.6349206,526.2328042,189,19.30347004,13.38385876,0.720611062,0.887323944,0.555882353,-0.412801736
+2276,24309.88194,739.4375,471.3333333,1060.631944,14502.15278,545.4166667,585.2847222,1431.527778,7554.305556,401.9166667,604.8611111,1690.125,11121.84722,1018.777778,4387.659722,2090.145833,4072.409722,1077.430556,287.2708333,2958.805556,7721.854167,5980.013889,239.0625,631.8402778,9014.277778,402.8611111,111.7847222,3053.097222,7402.041667,1429.979167,542.1736111,2783.805556,6236.0625,571.6736111,221.3333333,7294.5,4874.902778,795.6666667,350.1666667,1303.708333,3441.201389,746.7916667,149.9791667,2273.395833,2983.208333,1017.152778,242.4583333,3070.791667,940.0555556,523.7083333,144,15.4212936,11.97663879,0.629957053,0.972972973,0.692307692,1.211896635
+2277,37231.68317,895.8679868,463.9009901,1083.465347,31940.79538,786.2310231,952.2409241,1578.785479,18836.22442,569.6237624,2225.580858,1780.052805,25807.9703,1358.580858,4829.211221,4146.643564,9302.270627,1340.174917,353.8910891,2739.69637,18729.66667,503.9009901,196.9339934,1556.871287,22637.47195,1153.247525,375.5280528,1869.874587,17359.51155,1861.957096,579.6732673,2797.389439,15333.89439,626.8481848,283.8613861,1756.438944,12784.29373,1741.894389,426.650165,1318.359736,9429.128713,670.1320132,168.0429043,3300.808581,8227.90099,1412.864686,524.4488449,3223.059406,706.0363036,527.0759076,303,23.80153895,17.50286726,0.677669031,0.863247863,0.601190476,1.224450485
+2278,42180.12281,931.3421053,549.1315789,1113.877193,35584.03509,746.1315789,527.4210526,1737.438596,20322.09649,549.7105263,426.622807,1731.798246,28539.76316,1378.912281,5793.719298,2863.666667,9992.447368,1331.657895,381.8596491,2409.833333,19833.13158,517.2719298,528.7982456,464.6491228,24388.23684,443.254386,136.1052632,4282.324561,19444.64912,1517.140351,543.4473684,2794.77193,16131.25439,651.8070175,295.2192982,4949.824561,12906.2807,860.6754386,445.7631579,1345.982456,9229.438596,833.6754386,172.2105263,2984.991228,7913.254386,1359.263158,305.0526316,3276.824561,892.8157895,523.4736842,114,13.67524796,10.95502277,0.598551898,0.897637795,0.678571429,-1.032829949
+2279,41991.63712,853.7174515,512.2132964,1113.476454,24336.74238,560.4293629,505.8421053,1475.468144,12285.30471,422.598338,1111.919668,1677.243767,18339.32133,1078.725762,7281.795014,2440.168975,6827.770083,1100.00277,298.9307479,3622.947368,13060.07202,602.7867036,187.1523546,831.166205,15269.76731,356.6565097,111.6759003,3223.282548,12333.61219,1720.540166,465.6620499,2801.088643,9857.99723,542.8725762,235.7867036,3662.842105,7299.98615,860.265928,361.498615,1280.66205,4075.418283,637.6121884,143.5595568,2623.387812,3982.844875,1039.409972,223.2880886,3073.459834,1057.127424,529.3268698,361,24.80559394,19.20810884,0.632762592,0.952506596,0.683712121,0.642106934
+2280,49988.44681,928.7943262,553.9787234,1147.48227,18149.98582,538.9716312,386.070922,1481.120567,8448.248227,393.8652482,521.6312057,1706.87234,13504.37589,1006.624113,6556.056738,3087.787234,5031.978723,1027.539007,285.3049645,2365.886525,9370.624113,327.6241135,117.6595745,575.0425532,11219.93617,316.4964539,106.7021277,5670.397163,8636.021277,1504.758865,459.2553191,2780.58156,6869.964539,527.5035461,210.8439716,1563.361702,4855.865248,736.4609929,342.8014184,1265.390071,2441.560284,520.4113475,129.0638298,1863.22695,2610.510638,939.5460993,207.4680851,2989.304965,1091.574468,525.2340426,141,15.40242917,12.19748976,0.610625019,0.854545455,0.671428571,-0.365066522
+2281,27025.92222,786.6666667,452.5111111,1054.988889,24562.3,638.5555556,478.2888889,1438.688889,13698.85556,525.5555556,461.2333333,1735.155556,18247.4,1207.888889,4273.244444,2579.033333,6713.711111,1339.733333,360.2555556,2391.288889,12538.67778,441.2777778,1598.822222,442.3777778,14708.91111,384.2111111,125.9555556,2733.877778,11466.97778,1569.766667,764.6111111,2801.644444,10205.6,843.4333333,257.8888889,1372.866667,7837.988889,802.4222222,419.3444444,1377.144444,6069.544444,960.4,166.8111111,4529.2,5557.144444,1284.155556,401.8555556,3168.833333,345.1888889,523.9222222,90,11.27569933,10.45688797,0.374114171,0.947368421,0.681818182,-1.453045424
+2282,40641.35484,970.5698925,709.3548387,1149.634409,34602.16129,789.7741935,894.7311828,1711.946237,20714.08602,585.1505376,1211.010753,1839.247312,28386.83871,1432.978495,2687.236559,3290.569892,10105.98925,1430.591398,380.9139785,2419.784946,20095.16129,519.4623656,217.2795699,1199.483871,24351.56989,483.6774194,143.516129,2284.27957,18422.19355,1852.333333,745.3763441,2811.892473,16262.8172,1007.11828,310.8387097,1758.139785,13571.55914,1407.354839,447.9462366,1324.27957,9541.010753,696.7526882,165.6129032,2506.430108,8491.086022,1464.634409,144.1505376,3257.634409,756.7419355,524.5053763,93,12.70720929,9.678629379,0.647971673,0.948979592,0.596153846,0.699405611
+2283,44345.39216,905.1568627,481.4509804,1121.117647,35873.21569,721.6470588,501.8823529,1586.333333,21743.60784,550.1372549,842.2941176,1788.215686,30731.03922,1354.745098,3354,3734.960784,10855.11765,1319.529412,400.6666667,2445.156863,21770.11765,510.8431373,263.2156863,1047.078431,25731.37255,502.0980392,126.372549,2273.470588,20221.88235,1724.254902,704.0588235,2790.137255,17293.21569,691.4117647,282.5882353,1854.431373,14281.17647,1532.294118,447.4901961,1316.529412,9935.176471,685.8431373,162.1960784,2547.294118,8971.509804,1394.215686,528.6862745,3198.705882,784.9607843,523.745098,51,9.607564163,6.936908596,0.691866197,0.980769231,0.566666667,0.597213215
+2284,23981.81699,776.7320261,518.9934641,1087.581699,12255.32026,499.0196078,743.3660131,1401.130719,6521.575163,392.2222222,1366.150327,1703.019608,9332.862745,995.254902,6798.444444,2458.679739,3490.333333,997.5424837,273.5163399,5107.69281,6480.326797,767.1764706,697.5686275,876.6666667,7630.437908,428.9084967,106.4901961,2481.294118,6365.339869,1748,501.3464052,2771.124183,5244.189542,816.6535948,212.5098039,5192.745098,4130.810458,1310.202614,338.1176471,1334.248366,2718.895425,790.6797386,140.1960784,3267.562092,2458.392157,979.9215686,293.9738562,2998.666667,960.0915033,525.3986928,153,14.44343564,13.5532394,0.345641271,0.95625,0.728571429,-1.12589528
+2285,34077.55357,835.7738095,529.5357143,1109.589286,33895.0119,707.9940476,482.4404762,1679.142857,17069.7381,608.0178571,552.3928571,1823.869048,23225.39881,1269.380952,7540.761905,4876.119048,8941.607143,1374.291667,452.6488095,2418.910714,17466.76786,459.5535714,7962.041667,460.6666667,20955.1369,450.4047619,134.5,3537.642857,15589.38095,1772.5,700.8035714,2824.410714,13044.89286,606.1547619,289.8452381,2705.142857,9287.267857,894.1785714,434.1190476,1416.327381,7049.577381,2403.125,181.8511905,8175.470238,5858.440476,1339.005952,187.3511905,3340.666667,202.7738095,527.5595238,168,19.04064705,11.41458551,0.800385865,0.96,0.583333333,-0.914776114
+2286,37818.17692,862.4846154,548.3153846,1102.546154,34978.50769,709.6461538,598.7615385,1657.176923,19108.14615,555.7307692,651.7538462,1778.115385,25576.19231,1270.969231,8158.384615,5137.9,9473.6,1361.576923,358.5153846,2507.315385,19882.59231,440.2,483.3692308,476.2384615,22860.66923,427.8384615,128.8461538,4174.284615,17499.17692,1520.469231,713.2538462,2810.2,15292.86923,711.0538462,302.0230769,4594.638462,11401.6,912.5692308,446.9923077,1314.815385,8797.769231,722.8846154,173.4923077,4070.284615,7400.2,1367.661538,388.4615385,3246.815385,264.2307692,526.8230769,130,18.15319201,9.494992058,0.852303183,0.921985816,0.577777778,-0.889003796
+2287,27638.22963,928.1703704,538.9407407,1086.696296,24632.62222,717.7111111,743.8222222,1529.311111,13813.26667,564.237037,910.9407407,1727.688889,18884.4963,1371.096296,4078.8,3040.125926,6726.533333,1656.422222,373.3037037,2493.177778,11825.34815,429.9703704,647,587.6444444,13340.12593,650.0148148,142.1555556,2489.925926,10282.19259,1459.340741,723.037037,2808.22963,9117.362963,875.162963,280.4148148,1517.444444,7230.851852,931.2888889,436.6888889,1354.259259,5864.037037,743.6592593,179.7111111,6533.059259,5082.496296,1354.688889,641.4592593,3211.377778,423.7925926,528.6518519,135,19.68926657,9.055466783,0.8879609,0.9375,0.567226891,-0.604173364
+2288,27325.5,903.2638889,613.9722222,1091.958333,19793.33333,634.4722222,520.7638889,1458.138889,11108.54167,519.9861111,905.4166667,1760.347222,15973.43056,1216.5,7787.833333,4337.041667,5779.694444,1164.444444,324.3611111,2700.541667,11675.04167,473.4861111,3475.291667,749.6527778,14272.77778,443.8611111,121.0555556,2351.861111,11003.80556,1936.194444,537.9444444,2801.041667,9499.513889,717.0555556,250.2083333,1722.513889,7763.513889,1279.222222,392.1388889,1378.097222,5708.902778,1615.277778,159.0416667,3846.402778,4927.847222,1181.666667,308.6805556,3262.361111,849.3194444,524.1805556,72,10.62166217,9.575627315,0.432740097,0.935064935,0.654545455,1.551361676
+2289,33458.21667,1137.05,576.0166667,1071.15,27002,778.7166667,721.4166667,1608.25,16026.21667,611.7166667,848.95,1743.65,20959.81667,1329.716667,6637.9,3158.85,7507.133333,1276.466667,344.95,2701.4,14948,487.7333333,855.2166667,858.7166667,17105.86667,428.8166667,128.1833333,3262.533333,13928.86667,2007.05,498.2666667,2815.133333,12004.76667,603.9,265.4166667,1596.183333,9222.283333,997.7833333,401.2833333,1326.466667,6621.55,795.1666667,158.7666667,2127.7,5323.7,1179.45,150.3,3519.966667,857.0833333,525.9166667,60,12.31912898,6.533261487,0.847788366,0.909090909,0.714285714,0.144830767
+2290,51502.90722,939.0927835,588.5051546,1154.195876,51248.1134,781.185567,625.185567,1867.206186,27800.41237,598.4639175,537.7010309,1802.824742,37255.51546,1387.742268,7122.927835,6404.474227,13871.51546,1500.474227,402.5773196,2383.742268,28138.79381,1143.835052,915.6082474,435.8659794,33594.93814,460.814433,146.2164948,6010.216495,25480.51546,1586.443299,955.9484536,2822.896907,21644.4433,646.1237113,344.5360825,3441.824742,15760.08247,912.2886598,491.8556701,1319.865979,11647.75258,874.8865979,193.1752577,3855.113402,9735.412371,1436.824742,157.5773196,3390.14433,215.9381443,526.9381443,97,13.94307985,9.65081299,0.721746098,0.91509434,0.532967033,-0.917222307
+2291,34197.44848,1060.927273,570.4242424,1101.187879,28646.45455,754.4727273,710.7878788,1523.387879,15925.78182,604.6,787.2121212,1778.945455,22184.24242,1384.278788,5175.824242,3030.50303,7882.8,1400.648485,366.2060606,2645.181818,16577.58788,490.0909091,223.0727273,603.4424242,19071.82424,536.6727273,139.4666667,4860.612121,14952.75152,1740.672727,699.4121212,2801.327273,13249.38182,686.6121212,291.6969697,1672.175758,10302.68485,941.0727273,450.6484848,1322.672727,7952.787879,674.9212121,177.2242424,3946.733333,7074.8,1369.769697,155.5151515,3408.854545,404.2484848,528.830303,165,23.65834527,9.526872683,0.915338399,0.846153846,0.485294118,-0.959437943
+2292,25103.40191,958.784689,569.722488,1090.913876,22224.88995,710.2392344,654.277512,1554.492823,12443.66029,571.7799043,1144.339713,1805.37799,17166.03828,1332.956938,5472.124402,3925.090909,6113.870813,1347.784689,360.3588517,2510.555024,11882.09091,450.215311,472.5215311,686.507177,13772.05263,827.1196172,125.5885167,3466.521531,10317.57416,1549.167464,729.8325359,2801.368421,9183.191388,781,269.5311005,1747.296651,7162.291866,1290.842105,417.0239234,1308.521531,5671.985646,752.3923445,166.9425837,3958.191388,4917.157895,1301.779904,443.9665072,3357.162679,494.2870813,530.6411483,209,18.91525756,14.18745039,0.661377444,0.945701357,0.696666667,-0.027146469
+2293,34663.79221,980.012987,510.3506494,1099.064935,30419.53247,804.2727273,713.2077922,1592.025974,16844.57143,580.0519481,1848.714286,1807.376623,22496.98701,1359.987013,4964.701299,3700.337662,7699.090909,1352.961039,366.8961039,2551.779221,16450.32468,483.0649351,353.5714286,760.3766234,19123.20779,1106.480519,125.3376623,2337.714286,14982.8961,2088.350649,678.6103896,2799.688312,13425.80519,649.4675325,293.6753247,1576.285714,10687.49351,1761.415584,455.038961,1306.207792,7947.87013,700.8051948,185.3506494,2711.74026,7097.805195,1389.922078,441.7922078,3273.727273,556.5584416,525.6623377,77,12.0944181,8.383776536,0.720751173,0.93902439,0.7,-1.157600039
+2294,43848.50206,854.691358,512.5596708,1102.720165,36874.25926,703.382716,616.781893,1611.452675,21375.72428,535.1934156,1380.012346,1767.843621,30135.03704,1299.662551,4981.99177,4141.790123,10525.99177,1283.279835,350.9547325,2581.345679,21230.66667,572.1646091,897.5802469,843.3004115,25357.14815,436.3045267,138.2674897,2520.222222,19115.86008,2068.662551,669.2962963,2802,16766.27572,750.6131687,276.0493827,1680.26749,13598.68313,1565.880658,418.1563786,1316.786008,9581.580247,839.9218107,165.0987654,3075.152263,8319.773663,1313.559671,214.9423868,3231.17284,808.0452675,532.6584362,243,22.32444762,14.6464314,0.754698834,0.886861314,0.552272727,-0.847004985
+2295,38586.51282,898.6307692,549.8871795,1137.907692,15023.35385,486.7230769,433.1179487,1414.2,5527.307692,369.3846154,624.1794872,1634.564103,9900.082051,937.0512821,3782.764103,1164.584615,3598.835897,980.4051282,262.3282051,2326.989744,6433.497436,2225.2,144.2871795,622.5589744,7399.471795,311.7384615,505.2205128,1729.015385,5606.646154,1315.471795,371.5692308,2777.323077,4477.928205,477.4871795,193.2410256,941.8,2554.861538,590.4358974,310.7538462,1261.061538,1236.635897,506.9794872,125.1076923,1088.45641,1455.779487,858.5179487,144.6102564,2932.54359,1137.907692,529.4769231,195,17.98611463,13.95766337,0.630702916,0.960591133,0.637254902,0.673420723
+2296,38209.29319,860.1937173,676.7958115,1169.465969,26518.46597,575.5602094,403.4973822,1647.994764,12576.42932,457.2198953,456.5811518,1751.319372,17795.49738,1063.811518,6370.041885,3314.057592,6609.497382,1133.664921,350.8848168,2417.272251,12774.36649,624.9842932,895.895288,442.8638743,14657.10995,353.6544503,117.1623037,8941.329843,10900.10471,1557.989529,730.8691099,2978.015707,8764.926702,546.6020942,260.565445,8200.790576,4915.905759,698.9685864,359.5968586,1292.910995,3665.057592,712.5235602,145.2198953,2918.366492,3218.518325,1029.596859,187.5078534,3146.303665,149.1780105,533.7643979,191,21.5510031,13.07257099,0.795016665,0.864253394,0.44212963,-0.482318638
+2297,44379.89091,1093.181818,551.2545455,1119.6,35857.18182,794.8545455,661.0181818,1625.909091,21520.29091,615.9454545,450.2181818,1730.963636,29343.90909,1443.254545,2751.8,2279.309091,10518.27273,1349.072727,354.6181818,2348.072727,18080.87273,692.3818182,144.4909091,478.5272727,22052.07273,428.4363636,118.6181818,1946.8,16751.83636,1491.654545,812.0181818,2785.745455,14903.09091,684.0545455,272.5090909,1759.545455,12202.47273,921.1272727,413.7818182,1309.509091,9170,649,163.4181818,2217.545455,7521.945455,1338.527273,459.3090909,3226.963636,658.5454545,526.5636364,55,10.05193417,7.192600047,0.698567782,0.982142857,0.55,0.910931479
+2298,37495.68293,918.2835366,536.6036585,1111.628049,32908.26524,714.7987805,667.0670732,1606.637195,18603.16768,569.7164634,1102.307927,1773.634146,26397.50305,1344.39939,4056.027439,3681.972561,9476.015244,1334.27439,366.4817073,2476.768293,18990.67683,698.0426829,307.8902439,686.6676829,22922.90244,970.3506098,127.1768293,2247.237805,17264.02744,1623.060976,873.3079268,2800.036585,15433.03659,723.1280488,286.3506098,1719.655488,12688.24695,1208.304878,428.7591463,1318.362805,9360.515244,779.9176829,167.5030488,2968.932927,8079.094512,1386.871951,383.570122,3167.658537,743.1829268,534.5640244,328,27.05177838,17.1674767,0.772828067,0.849740933,0.700854701,0.185013075
+2299,37948.58537,866.4878049,493.1097561,1109.878049,33469.17073,727.1219512,963.8902439,1643.853659,19074.80488,548.5731707,1957.414634,2016.97561,26863,1283.634146,4700.621951,4723.987805,9476.780488,1309.317073,354.4634146,2852.158537,19620.60976,663.1585366,119.1463415,1053.963415,23431.41463,485.6829268,135.1341463,2196.585366,17757.43902,2142.512195,666.8780488,2806.719512,15233.87805,634.3902439,286.4268293,2079.146341,12844.95122,1420.195122,428.5121951,1314.682927,9196.207317,640.2439024,171.6341463,3848.329268,7988.902439,1360.146341,283.4390244,3224.646341,775.4390244,526.597561,82,12.5112215,8.875232558,0.704824441,0.891304348,0.621212121,-0.978989788
+2300,11626.47674,954.1860465,511.1395349,1047.244186,12731.05814,678.2093023,473.1046512,1356.116279,5534.151163,524.3023256,569.3604651,1712.418605,7896.918605,1235.186047,3178.604651,2522.465116,3083.744186,1212.360465,330.3023256,2387.604651,6554.639535,500.1744186,1021.116279,555.5116279,6748.22093,368.9418605,134.8604651,2966.976744,4921.930233,1541.77907,675.1511628,2799.267442,4515,743.255814,252.0348837,1555.337209,3654.581395,776.1627907,404.8139535,1356.046512,3159.197674,864.755814,164.2325581,5663.860465,2487.488372,1265.534884,142.0813953,3262.569767,391.7906977,528.5697674,86,13.06195712,9.608715162,0.677387924,0.826923077,0.601398601,-0.068523648
+2301,39712.64706,961.1352941,514.6176471,1100.5,33837.37059,744.0882353,769.3941176,1572.176471,19558.87059,588.8529412,883.3352941,1744.076471,27039.40588,1394.311765,3657.447059,3340.488235,9405.529412,1411.417647,376.4647059,2536.288235,18545.9,474.1352941,196.5058824,543.0529412,21776.91176,439.5235294,132.2823529,2610.994118,16632.49412,1717.629412,717.0058824,2821.817647,14545.84706,814.5529412,307.1235294,1697.929412,11525.20588,975.4176471,455.9588235,1317.329412,8992.829412,670.4235294,175.8176471,2887.347059,7960.441176,1401.8,404.6352941,3307.7,518.3352941,529.3823529,170,18.55456118,12.14867914,0.755841767,0.880829016,0.688259109,1.501568717
+2302,27015.38889,850.3968254,680.7460317,1075.444444,23657.31746,690.3809524,708.3095238,1517.968254,13187.92857,527.9603175,871.6428571,1837.801587,18411.73016,1290.428571,5286.579365,2719.02381,6718.777778,1291.047619,334.3253968,2440.793651,13003.62698,464.3412698,1329.634921,961.6349206,15243.96825,618.047619,219.4365079,1645.150794,11840.42857,1863.603175,1307.690476,2860.539683,10357.61111,643.3174603,275.6984127,1662.436508,8336.214286,1080.103175,421.7301587,1331.873016,6300.484127,918.7222222,162.8015873,2560.507937,5539.563492,1333.730159,413.1031746,3292.071429,580.2142857,530.547619,126,14.93791783,11.65204599,0.625740287,0.868965517,0.494117647,0.530306173
+2303,18584.63366,838.450495,466.0940594,1054.811881,16855.81683,656.2920792,653.8910891,1438.688119,9309.668317,512.3910891,569.0445545,1751.881188,13334.13366,1269.415842,3631.29703,2127.633663,4872.841584,1216.678218,324.7524752,2374.722772,9858.029703,2126.940594,731.2277228,509.6386139,11880.16832,416.6534653,116.6584158,1193.707921,8996.381188,1857.717822,999.529703,2809.59901,8103.886139,678.3019802,254.9257426,1651.737624,6736.089109,1131.376238,391.2178218,1317.168317,5253.678218,768.460396,156.6534653,2985.054455,4567.118812,1351.851485,1474.648515,3118.282178,674.7574257,532.1881188,202,20.53165507,12.90916012,0.777612156,0.930875576,0.660130719,0.853389196
+2304,24756.04833,786.4907063,520.1003717,1069.713755,22001.5316,646.1524164,612.9405204,1529.052045,12254.36431,527.0855019,924.66171,1745.011152,17512.72119,1218.137546,5397.977695,3871.799257,6201.189591,1273.223048,325.4795539,2591.501859,12570.58364,503.2342007,1984.687732,931.4609665,15003.07063,661.1189591,120.669145,2423.39777,11425.83271,1683.628253,702.4609665,2787.315985,10066.95167,664.9516729,255.3717472,1993.698885,8245.572491,1300.070632,403.2565056,1355.591078,5949.817844,1182.349442,160.7806691,4166.286245,5158.520446,1243.828996,300.5539033,3157.434944,828.0780669,532.2118959,269,22.45566772,15.62851554,0.71806894,0.924398625,0.674185464,-0.758212293
+2305,51205.25253,925.2424242,540.3232323,1133.707071,45457.18182,770.1313131,624.6464646,1844.313131,25281.12121,558.3939394,481.8989899,1752.878788,35631.28283,1391.747475,6619.666667,4552.929293,12655.26263,1383.323232,388.3535354,2399.656566,25210.25253,527.5353535,240.3838384,561.0909091,30242.30303,458.8282828,134.6767677,4367.545455,24487.68687,1552.747475,607.2323232,2890.868687,20408.77778,736.7373737,311,4661.292929,16016.80808,897.010101,457.030303,1323.070707,11162.25253,720.7373737,168.1313131,2775.737374,9635.111111,1423.484848,224.6666667,3328.434343,904.9494949,527.8787879,99,16.37602018,8.489718801,0.855123822,0.860869565,0.61875,-1.422245214
+2306,42469.16667,892.0679012,547.4506173,1150.296296,19362.41358,576.5,369.5555556,1495.012346,8108.345679,402.4012346,599.9444444,1658.709877,13637.88889,1018.882716,9023.481481,2701.882716,5039.91358,1080.216049,300.9259259,2369.882716,9184.469136,329.691358,98.95061728,643.9320988,10740.90741,342.1790123,109.1728395,6319.740741,8524.462963,1503.197531,463.6111111,2784.524691,6665.364198,521.2160494,218.0740741,1921.635802,4365.382716,729.117284,337.6975309,1276.240741,2102.796296,529.0802469,140.6296296,3178.388889,2419.703704,952.9074074,454.1728395,3105.808642,1114.907407,528.1111111,162,17.3734905,12.00616968,0.722794902,0.97005988,0.794117647,-1.333129158
+2307,23150.33621,1199.974138,654.7758621,1053.146552,19156.73276,539.9655172,353.0086207,1304.189655,10759.03448,463.8275862,552.2327586,1746.767241,14961.74138,1093.913793,9600.525862,3962.215517,5570.37069,1210.034483,308.2672414,2354.689655,10835.51724,363.6724138,210.2931034,419,13228.16379,386.9051724,116.3965517,5905.362069,10217.55172,1311.293103,707.1293103,2794.387931,8827.474138,530.3189655,235.3793103,1577.284483,6622.775862,755.2068966,382.8103448,1279.232759,5026.594828,597.2758621,151.5431034,2683.077586,4616.017241,1167.413793,133.2327586,3327.594828,300.9310345,529.7672414,116,13.79657164,11.01822767,0.601834679,0.892307692,0.743589744,1.296952896
+2308,39779.625,1014.140625,581.828125,1168.25,37198.17188,786.46875,782.984375,1829.578125,19538.82813,615.109375,724.53125,1818.4375,26692.26563,1421.234375,4803.4375,3631.84375,9258.921875,1442.28125,388.0625,2447.453125,18752.09375,8785.296875,327.203125,724.3125,22266.59375,532.4375,145.21875,5863.640625,16625.64063,2225.84375,810.078125,2801.625,14950.85938,734.859375,321.296875,1808.78125,11585.29688,970.203125,485.046875,1344.71875,9177.234375,844.421875,193.09375,4269.171875,7736.015625,1437.59375,168.921875,3389.859375,362.625,527.328125,64,10.93282601,7.858158766,0.695250635,0.941176471,0.592592593,1.195143974
+2309,33185.5625,989.0625,524.40625,1115.635417,29653.09375,785.5104167,693.6354167,1586.8125,16616.96875,578.7291667,573.1458333,1797.104167,21978.17708,1352.291667,4457.114583,3693.895833,7919.885417,1364.729167,378.8229167,2497.770833,15260,762.1458333,1718.96875,620.3854167,17882.13542,433.9895833,134.2083333,3151.229167,13710.78125,1679.458333,825.3229167,2808.0625,12082.33333,667.28125,288.9479167,1645.135417,9256.416667,925.8541667,451.6979167,1361.34375,7112.291667,1078.895833,178.6770833,5698.354167,6247.4375,1386.125,181.3020833,3362.416667,374.7395833,528.6875,96,12.35279125,10.17812911,0.566657004,0.932038835,0.727272727,-1.299848258
+2310,40068.6,948.7,509.0625,1092.4,34261.45,815.625,842.7625,1606.1125,20440.025,601.2875,1955.4,1809.85,27725.525,1439.575,3368.0375,3703.5875,9769.9125,1432.9625,392.25,2504.2375,18114.2875,590.3875,1930.5,851.7875,22213.6875,444.5375,356.7875,2423.1875,17756.6625,2447.1875,684.8375,2825.05,15242.4375,808.1625,318.45,1574.5,11874.4,1316.95,491.4875,1437.3625,8722.7125,1254.5375,194.075,8004.975,8265.2,1479.925,210.1375,3238.3625,384.05,530.725,80,14.33392258,7.299908448,0.860603842,0.909090909,0.714285714,0.042239138
+2311,50106.57813,932.265625,490.84375,1125.328125,42996.40625,771.140625,997.9375,1647.046875,25559.15625,632.890625,1832.09375,1886.3125,34937.85938,1424.015625,3481.703125,3224.421875,12649.95313,1407.140625,379.640625,2457.609375,25303.71875,505.453125,202.65625,1554.578125,30434.20313,467.828125,162.234375,1677.421875,23662.82813,2178.0625,613.875,2812.46875,21083.57813,690.484375,303.421875,1650.84375,17355.89063,1866.078125,455.328125,1315.171875,12540.84375,713.203125,174.390625,2353.71875,10848.07813,1485.90625,590.71875,3292.875,728.46875,528.390625,64,12.50548775,6.81217623,0.838608273,0.914285714,0.547008547,-1.180721728
+2312,49015.25,917.25,602.0357143,1145.625,40601.07143,762.4285714,569.8571429,1873.892857,22512.19643,541.3214286,625.8035714,1767.178571,31691.08929,1331,8671.589286,6034.607143,11118.92857,1329.982143,368.8214286,2429.303571,22221.58929,519.0178571,149.5714286,715.9107143,26231.5,432.7857143,137.2678571,5360.089286,21703.14286,1575.642857,720.2142857,2804.75,17742.05357,630.2321429,293.3214286,3759.464286,13863.92857,882.9107143,450.2857143,1315,9628.696429,633.0892857,173.1428571,3511.910714,8319.517857,1323.696429,169.5357143,3273.178571,915.2321429,528.5,56,10.10325378,7.458783193,0.674521119,0.903225806,0.622222222,-0.289705116
+2313,24388.27027,757.9256757,477.4662162,1116.087838,20702.21622,615.4662162,503.4459459,1701.209459,11055.56081,464.0743243,722.2027027,1784.959459,15546.58108,1120.459459,4333.5,2262.358108,5846.972973,1153.689189,318.7364865,2778.405405,10901.64865,12577.43243,277.972973,570.3310811,13048.58108,544.5067568,124.972973,3548.263514,10705.63514,1623.432432,625.777027,2774.925676,8873.358108,632.8648649,247.1756757,4636.310811,6690.027027,884.0945946,383.9662162,1308.614865,4227.283784,691.6486486,148.8378378,2741.689189,3854.858108,1153.689189,184.4256757,3205.141892,987.3513514,529.3310811,148,16.41710073,11.55684278,0.710248039,0.973684211,0.822222222,1.174550855
+2314,46973.01498,917.3333333,610.6404494,1150.816479,45989.82397,750.258427,578.6029963,1807.097378,23963.70037,583.8838951,536.505618,1799.580524,32129.49064,1343.876404,8715.70412,7722.846442,12070.53184,1427.928839,387.9850187,2380.254682,24647.44569,1136.846442,209.4344569,439.8838951,29117.14607,453.3033708,139.5805243,6045.734082,22099.56929,1540.640449,867.4531835,2829.2397,18853.11236,648.9438202,322.2808989,4551.078652,13636.44944,886.3445693,463.4456929,1319.153558,10216.40824,694.1460674,183.6142322,4194.602996,8568.981273,1424.681648,200.6367041,3401.992509,223.7902622,534.6029963,267,26.82960622,13.51053716,0.863955464,0.855769231,0.508571429,-1.099296078
+2315,40580.90411,869.8082192,639.109589,1124.630137,38463.86301,712.7808219,536.7671233,1725.753425,20934.69863,568.630137,489.2739726,1785.013699,27366.60274,1296.356164,9554.287671,7244.821918,9981.671233,1396.041096,373.3561644,2359.712329,21580.54795,452.5205479,152.5342466,433.7945205,25297.78082,427.5479452,131.9178082,5341.561644,19449.49315,1467.821918,1255.534247,2816.972603,16942.89041,616.5616438,311.0273973,3377.643836,12288.49315,893.4520548,448.3150685,1304.931507,9538.30137,653.5342466,177.739726,5176.69863,8067.684932,1395.726027,231.6986301,3373.671233,251.109589,529.0410959,73,12.56752273,7.540019426,0.800029492,0.973333333,0.760416667,-1.306434144
+2316,35167.52688,950.8602151,587.9354839,1091.11828,25462.3871,721.6344086,588.4193548,1558.397849,14338.67742,544.9569892,811.311828,1796.193548,19697.76344,1303.548387,6936.11828,4086.129032,6944.634409,1334.010753,360.8602151,2527.032258,13003.39785,449.4623656,154.7849462,720.2473118,16121.05376,725.2795699,127.0215054,4218.55914,12287.97849,1542.344086,729.7311828,2782.569892,10767.03226,716.9139785,268.2473118,2077.247312,8526.365591,956.0107527,428.4193548,1302.150538,6418.139785,652.483871,169.3763441,4245.193548,6016.365591,1336.010753,415.7741935,3246.591398,543.0752688,529.1505376,93,13.9102095,9.215994825,0.749031327,0.853211009,0.603896104,1.131349107
+2317,41868.60227,882.9659091,521.3636364,1107.477273,36600.06818,747.7272727,707.6931818,1751.954545,21804.92045,558.3295455,675.8295455,1763,29456.70455,1371.204545,6991.5,3401.238636,10713.82955,1347.647727,364.3522727,2794.75,22008.27273,515.8522727,1698.443182,566.6590909,25659.52273,715.4886364,135.3636364,3884.284091,20359.81818,1647.670455,628.4545455,2805.170455,17831.15909,755.75,295.8863636,1867.454545,14228.39773,1014.477273,432.1931818,1349.556818,9947.579545,1110.193182,171.6477273,2991.75,8543.147727,1377.465909,577.375,3226.715909,842.9545455,530.5227273,88,11.47409604,10.38942546,0.424414788,0.916666667,0.666666667,1.144682029
+2318,57742.87143,914,554.4142857,1146.571429,43043.65714,647.6285714,705,1635.042857,22102.97143,516.9,1479.785714,1793.371429,28271.62857,1198.157143,5191.571429,3354.757143,10994.17143,1265.485714,342.5714286,2629.657143,22064.61429,391.7428571,146.4,516.8285714,25520.54286,366.8142857,121.0142857,3026.514286,19889.91429,1705.642857,538.9571429,2842.228571,16816.97143,578.7142857,281.7857143,3845.928571,10616.74286,968.3571429,404.2,1283.571429,7958.814286,605.7142857,161.4571429,1985.757143,6831.757143,1184.842857,210.7285714,3132.771429,180.1,530.1428571,70,12.87913388,7.269207648,0.82548953,0.921052632,0.673076923,-1.448240433
+2319,37829.65347,971.7821782,507.3168317,1076.930693,32270.41584,789.4950495,361.1683168,1438.871287,18932.9505,601.2970297,368.9207921,1664.90099,26215.0099,1589.60396,1165.990099,1165.831683,9653.138614,1439.188119,384.1386139,2364.485149,18744.58416,602.4059406,195.039604,451.2178218,22463.44554,433.6534653,134.1188119,1018.425743,17205.0297,1490.386139,639.990099,2797.257426,15445.68317,717.1584158,297.0891089,1450.455446,12770.30693,928.8910891,443.3762376,1288.09901,9635.19802,692.4950495,190.2673267,1371.584158,8581.80198,1660.029703,2883.970297,3088.237624,649.8217822,530.2178218,101,14.87167942,8.93438583,0.79942561,0.943925234,0.748148148,1.343458843
+2320,17471.25,814.125,479.125,1060.875,19394.40625,726.75,548.9375,1450.46875,8449,495.46875,1570.3125,1765.53125,14445.75,1261,6273.5,5201.53125,5097.28125,1201.125,333.59375,2495.6875,9847.1875,426.8125,175.09375,1086.875,12086.03125,422.875,144.8125,3266.4375,8276.6875,1843.96875,622.25,2758.875,7316.4375,723.0625,265.5,2389.5,6270.03125,1114.5625,392.25,1309.3125,5264.96875,620.3125,157,5329.28125,4048.1875,1273.96875,792.84375,3035.03125,718.90625,529.34375,32,7.065106965,5.835496,0.563728676,0.941176471,0.653061224,-0.616735354
+2321,39993.41667,915.9166667,562.2166667,1086.266667,34008.61667,705.7833333,667.5333333,1553.466667,19766.45,548.2833333,792.3166667,1834.45,28056.61667,1328.133333,5050.35,3283.816667,10051.91667,1372.5,352.2,2416.233333,20058.06667,472.4833333,268.4666667,639.0333333,24346.11667,618.1,127.4833333,3564.583333,18276.01667,1797.866667,1465.55,2791.35,16421.03333,627.7166667,290.1666667,1967.033333,13675.83333,1037.766667,417.3666667,1348.566667,9922.466667,701.2666667,169.4,4900.016667,8684.6,1366.916667,151.6166667,3220.483333,751.9333333,531.0333333,60,10.57386401,7.59634853,0.695621981,0.952380952,0.495867769,0.824376362
+2322,35167.12903,815.4919355,484.516129,1081.846774,30182.59677,698.3306452,844.8870968,1589.032258,17446.49194,531.233871,2022.008065,1895.564516,24656.54839,1278.024194,5779.91129,4647.217742,8639.233871,1260.104839,348.8709677,2805.612903,17757.52419,641.266129,235.6209677,2266.282258,21226.47581,690.233871,226.5322581,3135.403226,16121.45161,2281.758065,549.7096774,2800.112903,13846.29032,618.5887097,270.0645161,2426.774194,11448.50806,2319.048387,415.9032258,1318.040323,8274.08871,704.7096774,167.8951613,4911.024194,7264.25,1315.806452,214.0483871,3231.491935,790.3064516,532.3467742,124,15.99111539,10.31532727,0.76412673,0.925373134,0.632653061,-0.889093692
+2323,34896.12857,816.0714286,538.4857143,1090.207143,28647.95714,665.5285714,888.2285714,1740.221429,14713.9,493.3071429,2949.021429,1812.2,21759.44286,1192.135714,8182.235714,3729.135714,7996.992857,1237.057143,338.1428571,5055.785714,15149.78571,896.8,1684.364286,1257.814286,18927.50714,479.8285714,200.8928571,2195.285714,14626.85,2467.278571,496.1928571,2825.7,11871.96429,574.6857143,259.75,3429.007143,8972.864286,2603.235714,392.2357143,1352.685714,5534.114286,1090.628571,159.6071429,4284.928571,5200.978571,1207.385714,422.4285714,3180.578571,1019.342857,533.9214286,140,19.11918319,10.36023094,0.840458297,0.848484848,0.549019608,-0.993495481
+2324,36495.41216,861.3175676,556.4662162,1137.364865,28324.89189,643.1621622,753.7027027,1668.047297,14352.80405,464.6418919,1750.885135,1761.243243,21604.4527,1228.013514,6939.810811,2379.006757,7824.283784,1228.716216,334.8648649,3415.290541,14878.37838,2725.175676,207.3513514,870.0067568,18393.96622,477,574.777027,2307.905405,14449.9527,2180.777027,479.7905405,2869.655405,11715.33784,618.4662162,258.3716216,6305.52027,8791.074324,1262.756757,396.027027,1315.27027,5165.513514,865.0202703,150.8243243,3290.148649,4970.72973,1160.297297,237.4797297,3187.108108,1033.675676,533.7094595,148,15.36749928,12.36585917,0.59371407,0.948717949,0.660714286,-0.470060383
+2325,29326.79839,886.1532258,487.7419355,1073.064516,26021.47581,711.3064516,522.5241935,1520.112903,14458,557.8306452,474.4919355,1737.395161,19813.79839,1337.241935,4929.266129,3164.137097,6957.483871,1395.66129,378.7177419,2366.362903,13497.92742,1100.330645,1142.112903,472.4677419,15666.50806,418.9758065,134.2016129,2612.564516,12328.54839,1771.233871,787.3145161,2813.983871,10854.70161,775.0241935,295.8387097,1614.177419,7956.572581,826.3790323,457.5080645,1370.145161,6076.419355,856.5725806,178.3306452,5074.83871,5602.887097,1398.830645,1151.395161,3253.58871,334.8387097,533.9354839,124,14.47974921,11.70259829,0.588901949,0.925373134,0.596153846,-0.503956555
+2326,36990.14859,972.0562249,601.7349398,1142.417671,33657.67068,760.6506024,722.9236948,1713.638554,18706.93574,596.2048193,707.9036145,1769.903614,25726.77912,1405.582329,6516.361446,4209.317269,9341.180723,1462.831325,391.8072289,2438.036145,18183.32129,521.2610442,1061.353414,719.124498,21286.14859,528.6184739,155.2449799,5021.48996,16399.82731,1772.096386,771.2128514,2815.064257,14611.05622,723.7831325,313.2008032,2035.445783,11303.21687,1017.453815,467.9759036,1336.779116,8717.851406,940.9518072,188.5662651,5536.827309,7685.666667,1444.698795,192.6064257,3350.473896,352.3052209,535.3654618,249,19.0463903,16.80890207,0.470266816,0.965116279,0.691666667,-1.215940655
+2327,44660,1056.304878,607.3536585,1106.280488,40352.07317,775.4512195,620.1097561,1639.182927,22774.04878,624.4634146,562.8292683,1770.304878,30042.59756,1342.914634,7072.341463,4179.47561,10814.41463,1415.365854,368.2682927,2347.45122,22418.76829,449.1707317,253.3292683,418.8292683,26555.90244,434.0243902,135.0487805,6850.634146,20745.97561,1527.829268,842.8170732,2815.54878,17859.53659,628.0243902,306.804878,2165.695122,13350.57317,882.5243902,449.8536585,1297.865854,9841.573171,670.9634146,182.7073171,4002.646341,8912.146341,1336.012195,166.4146341,3434.219512,270.3414634,534.1219512,82,11.64604327,9.053920887,0.628976107,0.987951807,0.683333333,-0.478603749
+2328,26744.32184,969.5517241,517.7241379,1064.563218,18934.09195,672.862069,676.7701149,1409.931034,10583.67816,544.0114943,1071.747126,1773.873563,14800.44828,1268.643678,2934.310345,2329.827586,5427.08046,1558.068966,344.3103448,2441.402299,10564.83908,407.954023,376.4712644,594.6321839,12734.37931,882.0804598,146.8965517,1814.482759,9971.172414,1681.183908,669.9310345,2835.609195,8755.045977,973.1609195,272.6321839,1386.114943,6862.770115,1030.862069,429.9195402,1339.551724,5306.091954,681.0229885,173.9425287,6011.83908,4881.804598,1294.287356,279.6436782,3249.195402,411.8045977,533.9885057,87,11.81732996,9.996078924,0.53336844,0.935483871,0.608391608,-0.446947403
+2329,25291.40196,913.0980392,429.3235294,1037.715686,21526.80392,691.5098039,450.8431373,1414.715686,12768.57843,565.3823529,1134.794118,1719.990196,17680.51961,1368.058824,1557.009804,1394.764706,6355.45098,1395.22549,344.4607843,2432.715686,12815.04902,485.2745098,236.5294118,972.0882353,15383.5,395.6176471,215.5882353,1113.656863,11975.90196,1512.205882,624.9117647,2786.72549,10731.40196,812.3823529,264.9117647,1520.862745,8899.039216,991.4313725,414.6078431,1307.862745,6667.607843,648.1862745,165.0588235,1467.411765,5950.343137,1439.068627,4254.156863,3100.147059,688.372549,532.4901961,102,11.8426903,11.54186895,0.223959016,0.944444444,0.708333333,1.127616885
+2330,31933.29091,823.9909091,491.2272727,1083.618182,27939.28182,667.1818182,590.8909091,1528.190909,16082.53636,508.5636364,751,1773.690909,22946.22727,1241.218182,4984.027273,3796.027273,7936.763636,1243.945455,337.4727273,2601.8,16519.70909,454.0727273,130.7272727,612.3181818,20145.18182,555.1,120.7272727,3328.727273,14958.56364,1560.718182,557.2727273,2794.1,12936.96364,636.9636364,264.0454545,2593.863636,10792.61818,974.1181818,413.5727273,1300.5,7867.918182,644.5181818,161.1090909,5467.909091,6959.354545,1321.354545,406.1818182,3171.563636,778.3545455,534.9909091,110,15.03243654,9.964236893,0.748753019,0.909090909,0.564102564,-0.6966309
+2331,30592.03968,864.5,601.4920635,1116.309524,26369.87302,690.0238095,832.6984127,1727.333333,14138.24603,499.5396825,2711.984127,1753.634921,20609.52381,1259.246032,6201.555556,4388.293651,7665.087302,1271.722222,356.1269841,3871.642857,14576.2381,571.6587302,1471.619048,1519.412698,18218.98413,499.3492063,317.6825397,3147.380952,14405.7381,2638.428571,574.5873016,2835.888889,11873.30159,625.3492063,289.3809524,14281.51587,9081.063492,2547.777778,419.5555556,1364.626984,5773.857143,1123.920635,202.8888889,6256.634921,5324.595238,1273.642857,489.8333333,3265.007937,1000.412698,533.6269841,126,13.52829851,12.27601046,0.420199042,0.926470588,0.692307692,-0.496643118
+2332,28905.27083,865.4375,525.8680556,1093.618056,25117.54167,699.4375,720.875,1559.833333,14198.09028,557.2777778,915.2013889,1810.25,19375.59028,1312.902778,5069.833333,3446.826389,6871.902778,1353.236111,362.4930556,2600.763889,14025.86111,498.4930556,651.0694444,671.9791667,16542.88889,797.9791667,125.8680556,2024.75,12648.05556,1722.868056,790.6180556,2900.263889,11198.70833,1032.763889,286.3263889,1765.409722,9007.388889,1201.534722,440.7361111,1333.805556,6800.694444,766.2291667,171.2569444,3071.645833,6110.743056,1356.965278,605.0416667,3306.354167,554.375,535.5,144,16.9464281,11.62906881,0.727388993,0.857142857,0.642857143,-1.102249244
+2333,30015.99187,910.097561,621.9268293,1107.756098,26027.45528,781.0406504,817.3821138,1616.853659,14834.47967,572.2601626,1726.073171,1862.341463,20490.72358,1376.845528,2574.699187,2379.560976,7200.219512,1341.463415,338.9756098,2469.658537,14192.52846,500.1219512,211.2764228,1598.504065,16602.60163,544.0813008,720.5365854,1230.585366,12805.34959,1789.756098,660.7317073,2807.398374,11273.13008,713.0894309,284.7073171,1938.300813,9045.634146,927.5203252,444.1138211,1338.439024,7008.495935,654.5853659,167.398374,2690.97561,6040.325203,1416.341463,512.1300813,3231.520325,588.9268293,536.9186992,123,16.69834005,9.877215444,0.806298527,0.911111111,0.549107143,-0.579865067
+2334,17687.92661,796.706422,460.0275229,1143.376147,15252.93578,643.5321101,469.8715596,1621.12844,8829.550459,487.6605505,367.8440367,1693.211009,12469.61468,1245.577982,1834.779817,1336.587156,4597.137615,1195.917431,317.6238532,2381.66055,8784.458716,431.2844037,124.1192661,445.1743119,10409.6422,384.6880734,112.7706422,1185.220183,8075.889908,1304.908257,644.4862385,2794.036697,7202.422018,845,251.1376147,1903.155963,5948.137615,770.7155963,377.2844037,1294.110092,4594.522936,599.0550459,154.5321101,2047.880734,4131.431193,1338.862385,1641.770642,3032.06422,637.7798165,534.0550459,109,12.01499541,11.65203161,0.243938246,0.947826087,0.698717949,-1.22461145
+2335,19557.74747,974.6969697,467.6969697,1045.424242,16148.37374,715.2020202,472.989899,1431.868687,9571.505051,562.7171717,424.4040404,1680.838384,12925.69697,1328.777778,1710.575758,1860.535354,4666.575758,1221.141414,321.5252525,2345.525253,9093.020202,479.2929293,178.1212121,419.6363636,10477.81818,580.040404,115.4545455,1412.737374,8085.979798,1350.676768,700.5959596,2790.292929,7133.353535,637.0606061,254.4242424,1599.666667,5923.616162,854.8585859,386.2121212,1304.89899,4518.111111,612.0505051,155.6969697,1687.424242,4013.575758,1342.676768,1725.606061,3149.373737,664.3232323,537.0606061,99,16.26140202,8.091522243,0.867411959,0.9,0.582352941,0.135740464
+2336,19124.24242,1115.763636,588.1030303,1042.436364,15526.75758,693.2060606,403.7575758,1466.515152,8063.848485,538.1151515,460.0121212,1710.157576,11672.71515,1234.412121,6208,2723.715152,4032.278788,1153.830303,313.6909091,2433.2,7989.806061,401.8848485,371.2,508.4606061,9148.945455,419.0848485,112.4666667,5240.563636,7003.636364,1407.569697,551.9212121,2772.933333,6024.89697,711.0787879,228.1515152,1806.793939,4681.860606,750.7393939,361.0848485,1283.454545,3489.509091,653.6969697,144.8363636,4050.612121,2863.357576,1093.339394,235.0060606,3488.781818,866.7030303,537.0121212,165,16.21754366,14.91518419,0.392634944,0.873015873,0.647058824,-0.272563803
+2337,18189.05263,840.5526316,773.1052632,1111.394737,15563.07895,665.3947368,482.1315789,1676.157895,6255.394737,461.6315789,1025.289474,1777.894737,11012.57895,1192.947368,12982.02632,7762.447368,4000.052632,1147.947368,318.0526316,2518.052632,7849.684211,448.4210526,142,1099.315789,9178.078947,394,122.4210526,8137.631579,7129.605263,1611.315789,1355.973684,2775.710526,6099.473684,611.7105263,258.6842105,8086.394737,4897.210526,906.0263158,401.3421053,1306.631579,3822,648.8421053,162.2631579,5370.289474,3019.947368,1187.368421,265.6052632,3123.026316,922.5789474,532.3157895,38,8.279143138,6.110601067,0.674722312,0.926829268,0.59375,0.779006466
+2338,59672.22826,944.7173913,591.3804348,1160.206522,55762.92391,784.326087,582.6521739,1864.51087,29791.26087,610.6195652,608.3586957,1790.826087,40489.23913,1437.913043,7994.75,6488.652174,14947.5,1519.891304,398.2608696,2441.032609,30353.8587,488.2173913,203.7608696,466.25,36617.36957,476.5869565,142.8478261,6867.25,27441.21739,1682.021739,716.8586957,2835.065217,23126.32609,659.8913043,338.8586957,2697.130435,15841.23913,890.7826087,480.6630435,1301.304348,11784.21739,674.5434783,181.7391304,2943.315217,9881.51087,1417.717391,145.0217391,3253.858696,189.7065217,535.1521739,92,13.30672905,9.388232077,0.708684877,0.893203883,0.547619048,-0.909083572
+2339,29838.69492,971.9943503,809.6666667,1180.531073,26800.46893,787.2429379,892.779661,1702.745763,14828.35593,597.6779661,1001.553672,1819.429379,20279.62712,1447.531073,2349.870056,2876.694915,7364.327684,1471.661017,383.9265537,2506.954802,13325.28814,494.1525424,148.5988701,648.7966102,15672.83616,680.6384181,149.700565,1805.559322,11670.72316,1705.112994,694.519774,2824.310734,10298.31638,714.4745763,304.8305085,1566.751412,8188.548023,1105.237288,473.4689266,1327.502825,6702.288136,660.9548023,181.6271186,2241.344633,5790.548023,1488.59322,916.3672316,3312.858757,465.9378531,538.2768362,177,16.4346144,14.29253156,0.493650662,0.946524064,0.578431373,-0.824497635
+2340,31185.03774,791.3018868,510.3018868,1071.660377,20349.35849,587.8679245,441.2641509,1345.90566,10489.98113,854.2264151,568.0943396,1726.245283,17321.39623,1136.207547,3954.584906,2707.301887,6169.679245,1374.566038,391.5849057,2517,11879.01887,373.0566038,546.7735849,562.9056604,14943.98113,350.7735849,111.754717,2456.886792,10600.98113,1652.54717,733.1320755,2772.830189,9350.037736,906.8301887,233.3396226,1660.113208,8072.566038,892.3584906,370.2641509,1309.962264,6353.509434,731.3773585,155.1320755,3316.037736,5312.490566,1200.45283,343.4528302,3008.773585,731.0943396,535.3773585,53,9.89978599,7.254657181,0.680433864,0.868852459,0.588888889,-0.616106975
+2341,23412.9,835.1,617.125,1065.6,20414.45,650.2875,498.8125,1580.4,11109.2,487.475,401.825,1731.125,15697.9,1174.575,6982.4,3279.8625,5682.65,1180.0125,344.7,2419.3,10772.45,486.2375,2711.825,480.975,13310.4875,412.8375,127.35,6288.7375,10301.85,1440.725,628.175,2772.4375,8413.8625,643.825,255.2,3895.3125,6744.5,761.6625,393.575,1370.375,4919.0375,1486.7375,164.0125,6097.95,4158.9625,1204.0875,428.0125,3196.1625,897.9375,535.525,80,12.20778399,9.565433079,0.621326263,0.833333333,0.512820513,0.605534756
+2342,46890.1875,955.3194444,627.4375,1158.305556,30908.60417,635.4861111,550.7916667,1599.902778,16828.39583,485.5347222,456.8958333,1725.986111,23823.06944,1213.909722,7588.854167,4837.645833,8623.652778,1214.708333,337.875,2465.395833,16857.375,451.0347222,142.7916667,482.2430556,20240.23611,387.6666667,121.9513889,5817.680556,16474.5625,1394.826389,575.7222222,2781.333333,13702.99306,618.7152778,270.0625,5741.951389,10663.25,813.1597222,409.6666667,1307.083333,7350.354167,648.2986111,155.6666667,2303.180556,6524.472222,1216.479167,238.9513889,3203.875,929.0069444,538,144,17.78266814,10.89843761,0.790184896,0.872727273,0.5625,-0.688850533
+2343,26748.64567,775.7480315,514.1338583,1073.401575,22936.83465,646.6220472,1261.181102,1610.330709,12288.41732,471.8503937,2127.496063,1829.110236,17417.22047,1184.165354,8487.92126,3041.874016,6432.566929,1181.653543,325.9291339,4929.771654,12415.44094,517.2440945,1416.425197,1185.519685,14680.9685,445.6692913,218.4724409,3048.574803,12368.5748,2293.874016,505.0551181,2815.574803,10175.70079,718.984252,263.6141732,10175.47244,7681.543307,1553.574803,395.7086614,1352.472441,5104,1106.086614,154.8267717,4480,4574.614173,1161.299213,417.3700787,3198.267717,971.7007874,536.2519685,127,17.88841007,10.26640366,0.818915784,0.852348993,0.529166667,-0.514182378
+2344,47182.66667,913.7063492,545.9126984,1143.952381,24993.27778,569.7777778,456.047619,1515.888889,11570.83333,409.8095238,756.4126984,1856.809524,17690.96032,1049.238095,7050.960317,3374.047619,6651.063492,1096.380952,294.8888889,2367.531746,12270.63492,345.1190476,98.57936508,920.6904762,14757.4127,403.9444444,120.0714286,4023.269841,11544.76984,1860.746032,467.4285714,2794.515873,9108.190476,519.9365079,229.1587302,1341.142857,6244.595238,771.3492063,349.9444444,1274.34127,3103.896825,527.7777778,135.4920635,2053.571429,3413.730159,992.1904762,134.3571429,3037.214286,1096.396825,535.4761905,126,15.82867288,10.47767441,0.749554445,0.940298507,0.7,-1.157395665
+2345,36924.22831,954.4703196,524.8584475,1090.767123,23602.86301,656.1461187,445.5068493,1457.990868,12559.05936,520.456621,650.2420091,1759.611872,16776.87671,1182.452055,7611.424658,3367.60274,6060.360731,1245.630137,335.543379,2466.60274,11396.94521,568.3652968,433.0913242,679.6118721,13176.46119,370.196347,294.0319635,4648.767123,10278.23288,1680.684932,635.4840183,2792.013699,8924.863014,563.1415525,251.7488584,1641.141553,6569.283105,779.9817352,390.1232877,1288.799087,4975.543379,675.6757991,162.3333333,4535.547945,4536.237443,1204.205479,633.8310502,3379.771689,317.4429224,539.7990868,219,17.41127705,16.44094581,0.329172068,0.943965517,0.606648199,-0.810850042
+2346,36691.66667,955.7017544,603.4035088,1119.017544,33603.64912,778,665,1642.578947,18398.61404,595,546.3684211,1758.649123,24940.36842,1416.052632,6668.982456,4450.45614,9160.263158,1432.982456,411.2280702,2552.157895,18561.33333,841.6842105,756.9824561,508.3859649,22313.15789,490.9473684,152.6666667,8164.491228,17017.91228,1681.684211,809.1052632,2815.350877,15165.24561,727.7017544,325.6666667,1776.087719,11682.75439,1021.105263,475.0350877,1321.491228,8916.596491,862.877193,190.4385965,6397.438596,8031.333333,1537.052632,213.0877193,3382.140351,365.6315789,535.754386,57,12.3295511,6.274672923,0.860817763,0.863636364,0.575757576,-0.525543138
+2347,36437.33486,964.0275229,618.0366972,1145.307339,30777.33028,751.4311927,774.8119266,1681.697248,17580.79817,589.5229358,1311.899083,1815.784404,24306.40826,1399.701835,3942.788991,4233.53211,8545.96789,1414.247706,373.3440367,2579.298165,17489.16055,489.5963303,163.5825688,808.3073394,20182.86697,704.8256881,136.9220183,2638.073394,15228.51376,1844.770642,740.0137615,2813.321101,13430.29358,761.3256881,298.5229358,1871.633028,10577.37615,1505.573394,459.1559633,1320.954128,8420.018349,675.6146789,175.3394495,3837.495413,7281.422018,1421.298165,295.6146789,3338.366972,522.940367,539.3761468,218,26.11034404,11.81054135,0.891849684,0.810408922,0.512941176,-1.190772428
+2348,32465.46667,904.7666667,514.9833333,1096.55,28066.68333,703.3666667,836.8833333,1546.85,17295.06667,574.8,2328.483333,1781.083333,23908.66667,1354.533333,5085.983333,5246.233333,7953.383333,1432.516667,370.1833333,2484.416667,15725.25,576.2166667,310.9166667,836.7833333,18001.46667,2333.7,127.3166667,2629.783333,14750.9,1650.433333,758.0666667,2825.633333,12844.33333,789.5833333,290.9,1626.116667,10273.9,1535.083333,445.9,1320.116667,7560.233333,697.4,165.4666667,4178.15,6888.433333,1370.95,427.1833333,3252.15,565.2833333,535.4,60,12.52985526,6.650184161,0.847530254,0.869565217,0.545454545,-0.692385251
+2349,32644.03256,814.7255814,491.7488372,1077.223256,28299.52093,664.2651163,552.2604651,1578.651163,15867.68372,508.1116279,629.6744186,1746.465116,22887.2,1232.534884,4206.906977,3047.72093,8168.144186,1243.530233,341.0465116,2767.27907,16486.75814,443.2883721,733.2930233,722.572093,19646.29302,452.3348837,122.5488372,2646.07907,15047.26977,1566.488372,544.144186,2829.283721,13165.36744,1185.827907,268.9069767,1991.432558,10660.26047,1026.251163,411.4744186,1320.060465,7612.390698,822.4186047,160.7023256,3184.404651,6565.916279,1297.037209,948.6604651,3202.427907,848.1395349,540.6930233,215,19.15157917,15.87135991,0.559658548,0.846456693,0.511904762,-0.792548066
+2350,36533.85053,899.1209964,543.7615658,1111.341637,32041.84698,703.4483986,633.0142349,1654.145907,17077.16014,520.4590747,497.2348754,1734.284698,24447.31673,1284.640569,5597.174377,4318.608541,8312.362989,1281.544484,352.7081851,2390.782918,16605.90747,474.341637,890.2064057,532.9715302,20160.6548,516.8896797,129.0177936,5199.320285,15268.34164,1629.02847,614.7758007,2785.775801,13157.04982,671.3309609,273.341637,2575.209964,10022.56584,880.5871886,419.6441281,1316.448399,7157.882562,838.6049822,162.9786477,4842.455516,5878.128114,1271.871886,599.7366548,3306.455516,880.6797153,542.4234875,281,26.82397345,14.80811908,0.833812377,0.805157593,0.635746606,0.127506569
+2351,33848.22018,823.6788991,496.4587156,1090.770642,23863.80734,602,816.5504587,1549.770642,13612.04587,457.2477064,1090.238532,1817.651376,18093.44037,1264.220183,7306.477064,2766.284404,6816.110092,1159.743119,315.6238532,2948.486239,12928.61468,484.9816514,599.5963303,528.266055,15427.34862,442.5504587,119.5412844,2987.954128,12878.77982,1933.834862,587.2293578,2825.743119,10730.33945,1001.348624,251.4495413,2979.559633,8264.825688,1078.183486,390.6146789,1311.688073,5519.385321,740.9449541,155.853211,3763.752294,4938.385321,1168.192661,185.4587156,3170.944954,941.9449541,535.4862385,109,13.24170023,11.00043335,0.556658,0.96460177,0.698717949,-0.889404136
+2352,38455.51563,896.203125,563.0625,1101.015625,35596.30469,724.8125,557.9609375,1640.757813,19638.36719,551.2578125,710.1328125,1794.578125,26477.8125,1313.3125,7834.640625,4851.390625,9541.132813,1396.523438,371.578125,2419.375,19920.79688,474.875,202.8203125,551.8671875,23794.01563,892.6328125,134.7578125,5062.609375,18202.05469,1551.945313,834.8203125,2814.632813,15775.19531,610.7421875,306.6015625,2398.34375,11977.82813,950.2265625,451.8828125,1294.0625,9160.804688,696.1328125,183.921875,7443.773438,8048.90625,1420.28125,177.734375,3320.828125,289.6875,538.53125,128,17.41381462,10.83655551,0.782781638,0.790123457,0.547008547,-0.31656203
+2353,34643.10236,1005.92126,586.8582677,1117.653543,30980.03937,753.6692913,709.1732283,1611.11811,17714.09449,616.8031496,510.8031496,1736.653543,24323.12598,1372.779528,4528.692913,3224.692913,8262.80315,1420.511811,382.1417323,2397.086614,15963.70079,498.8740157,1125.417323,464.7244094,18549.86614,437.7322835,127.3858268,2458.511811,14285.3937,1745.062992,1079.165354,2827.700787,12517.1811,650.7874016,292.2204724,1919.984252,9731.472441,999.6299213,453.7401575,1340.771654,7558.787402,922.0944882,175.5275591,2449.125984,6889.913386,1400.015748,465.8740157,3376.669291,435.519685,537.8818898,127,16.54365753,10.29023901,0.783013207,0.875862069,0.574660633,1.222985908
+2354,20644.86316,1117.989474,547.5263158,1058.547368,18721.97895,754.7789474,605.8,1439.831579,10324.64211,604.1263158,551.8421053,1734.178947,14198.28421,1323.452632,3300.8,2008.863158,4918.578947,1329.642105,331.9894737,2377.536842,10060.95789,673.5894737,724.7789474,515.8947368,12025.96842,429.3789474,128.9789474,2960.621053,9188.642105,1710.978947,777.2421053,2789.589474,8086.126316,613.0421053,275.4,1632.621053,6211.642105,914.5578947,417.7157895,1313.821053,4887.494737,781.9789474,160.9684211,2234.673684,4448.231579,1301.126316,260.6210526,3463.473684,448.3263158,537.5368421,95,11.455486,10.69648691,0.357942539,0.969387755,0.659722222,0.660198
+2355,23463.01724,1070.767241,598.2758621,1075.939655,20947.44828,755.8706897,607.4224138,1488.051724,11683.12931,607.9741379,828.1293103,1798.206897,16221.75862,1353.482759,6058.387931,3493.887931,5775.051724,1325.775862,344.2327586,2487.517241,11696.33621,463.612069,169.4568966,738.0862069,13844.62069,852.8534483,139.5258621,4636.318966,10615.86207,1663.887931,696.9741379,2803.172414,9374.663793,629.137931,277.7672414,1816.681034,7290.913793,1065.991379,422.0862069,1313.87931,5816.25,643.5862069,171.4051724,4718.939655,5149.413793,1294.482759,283.6982759,3434.448276,505.5172414,538.0086207,116,15.05727006,10.77818282,0.698292488,0.878787879,0.524886878,-1.144962911
+2356,44679.58594,947.3515625,582.7734375,1126.75,37652.60938,768.4375,884.25,1683.484375,21819.76563,610.203125,1086.734375,1845.804688,30012.46094,1429.929688,4658.453125,4380.859375,10354.96875,1477.960938,391.734375,2589.101563,20321.94531,496.9453125,160.3984375,806.1640625,23954.59375,1016.90625,135.6328125,2703.726563,18501.42188,1531.484375,735.9921875,2805.945313,16241.82813,668.171875,317.8515625,1871.984375,12941.66406,1383.367188,463.0390625,1323.796875,9838.382813,681.109375,176.2265625,3362.765625,8916.539063,1458.09375,276.890625,3330.429688,535.875,540.1796875,128,22.03416171,8.222172228,0.927768749,0.820512821,0.418300654,-0.672441263
+2357,40690.35593,955.8474576,566.0169492,1104.983051,34714.62712,767.1694915,749.5254237,1645.576271,20856.37288,601.0677966,614.6610169,1777.372881,28992.79661,1431.288136,5485.627119,3084.694915,9394.152542,1385.440678,360.4067797,2438.254237,16664.91525,507.3898305,716.9322034,525.0847458,19901.54237,681.4067797,129,2495.135593,16222.94915,1743.355932,967.3898305,2819.033898,13944.32203,773.7457627,289.779661,1707.101695,11320.86441,1092.779661,452.0169492,1319.847458,8195.779661,775.1355932,180.1694915,2531.915254,7691.423729,1441.677966,256.8813559,3241.389831,573.6779661,536.9661017,59,10.35005808,8.030364531,0.630885095,0.855072464,0.595959596,-1.541241164
+2358,43644.89655,865.4827586,500.3448276,1081.482759,36122.96552,650.4482759,641.5862069,1447,19672.48276,504.4827586,837.3103448,1709.551724,28782.48276,1229.551724,3880.724138,2827.827586,10157.24138,1268.344828,341.6551724,2412.413793,21199,430.6206897,120,663.6206897,26077.44828,384.137931,118.7931034,2335.413793,19166.37931,1699.482759,614.3448276,2782.206897,17173.06897,586.1724138,262.2758621,1753.344828,14479.13793,984.5172414,411.4137931,1279.965517,10776.10345,619.5517241,161.0689655,2361,9082.310345,1349.517241,133.5517241,3154.068966,723.5517241,535,29,7.256290996,5.644037467,0.628495774,0.852941176,0.591836735,0.460171631
+2359,33897.29167,841.6666667,484.5277778,1083.111111,28647.72222,733.2916667,530.6527778,1568.902778,17384.22222,540.9166667,914.8611111,1806.375,23579.06944,1308.111111,4190.805556,2950.402778,8428.722222,1282.638889,361.4305556,2385.013889,17173.66667,520.8611111,115.2777778,856.1944444,20621.38889,424.2916667,126.2916667,2244.25,15682.93056,1603.333333,801.7916667,2785.736111,14047.09722,650.4861111,275.9861111,2072.222222,11578.15278,1179.513889,416.9583333,1306.791667,8064.041667,641.2083333,165.6111111,4795.138889,7245.555556,1353.597222,477,3239.652778,766.3194444,536.1805556,72,10.00954594,9.56203152,0.295666457,0.923076923,0.654545455,0.072493424
+2360,15105.1,711.675,496.3,1073.525,13065.7625,582.925,987.625,1617.4125,6809.1625,441.5375,2025.7,1748.5875,9858.125,1194.0875,6741.225,3006.425,3668.9875,1112.4125,297.8,5104.3625,6929.6625,705.15,748.1125,1392.1875,8176.3,657.6875,150.675,3510.4875,6824.525,2319.95,528.55,2788.2375,5525.275,1494.1375,234.7,7657.0875,4334.075,1788.75,369.7375,1324.5125,2914.85,957.4875,153.875,5472.6,2594.1,1102.7375,425.8125,3136.8,962.375,536.9125,80,10.53374227,9.963321418,0.324609208,0.91954023,0.661157025,0.204509503
+2361,45197.04412,891.2598039,538.8970588,1125.063725,39800.90686,718.1372549,717.6323529,1797.784314,20219.89216,506.2990196,777.872549,1750.666667,29718.19608,1296.95098,11420.62255,4923.656863,10979.53431,1332.460784,360.7647059,2996.705882,21020.93137,1057.897059,139.7156863,617.1715686,26080.96569,459.2058824,132.3529412,6443.009804,20089.2598,1778.715686,521.9656863,2804.666667,16236.68137,626.9509804,287.6715686,4806.784314,12034.52941,904,419.9852941,1313.906863,6831.75,700.9607843,160.4754902,2849.794118,6575.740196,1254.808824,168.9558824,3228.02451,1047.269608,543.3284314,204,26.02855749,11.1010427,0.904490045,0.80952381,0.472222222,0.48961649
+2362,40919.20619,883.6030928,516.6185567,1120.979381,26716.21649,616.742268,558.128866,1612.273196,10814.95876,443.2164948,989.1804124,1701.298969,17123.06186,1102.783505,6055.953608,2622.283505,6330.587629,1143.551546,306.5360825,2704.391753,11771.8299,358.7474227,656.0154639,686.4639175,13834.21134,516.8247423,127.0360825,4112.010309,10897.62887,1816.824742,383.628866,2833.953608,8580.835052,652.3762887,241.185567,1373.21134,5409.278351,901.5103093,357.7010309,1273.85567,2572.824742,699.6082474,140.8247423,2399.010309,3093.618557,1047.979381,808.8505155,3162.396907,1123.072165,539.4020619,194,18.1018974,13.69633786,0.653849728,0.950980392,0.713235294,-0.906184348
+2363,48605.24719,903.752809,664.2247191,1169.292135,29401.69663,599.1348315,491.258427,1624.58427,16023.61798,466,459.3258427,1719.573034,20272.26966,1120.898876,10660.13483,4574.674157,8212.764045,1208.539326,333.6292135,2355.685393,15670.95506,402.8539326,160.8426966,407.5730337,18217.31461,355.752809,119.3595506,10459.59551,14306,1379.505618,568.5393258,2812.685393,11994.19101,558.258427,278.011236,6734.168539,7418.337079,754.7752809,401.7865169,1295.876404,5656.224719,589.011236,159.3258427,2919.820225,4894.640449,1113.640449,150.7303371,3211.831461,172.1910112,538.8426966,89,11.59655827,10.15391352,0.483042037,0.956989247,0.73553719,-1.156423206
+2364,48120.88,911.7866667,622.2333333,1143.846667,47023.40667,753.6333333,695.1333333,1777.486667,25676.67333,584.7733333,533.34,1796.906667,34097.4,1354.953333,8056.526667,6943.753333,12535.15333,1450.686667,393.1066667,2392.12,25969.66667,489.4933333,153.6333333,447.5466667,30927.58667,448.6866667,140.46,5714.42,23409.36,1542.666667,1005.913333,2819.633333,20416.81333,651.4466667,324.84,3021.153333,14896.41333,923.6866667,479.56,1325.613333,11185.12667,672.76,181.9,3630.666667,9568.693333,1445.846667,205.7733333,3403.266667,241.8733333,539.78,150,22.62908111,9.361636813,0.910413545,0.862068966,0.46875,-0.879805637
+2365,43586.39286,875.625,592.8571429,1152.803571,40910.01786,731.8928571,677.0892857,1699.375,22531.375,569.8571429,503,1779.5,29656.16071,1323,6454.642857,6186.482143,10667.57143,1385.660714,363.4821429,2349.678571,22677.03571,453.0892857,220.2321429,440,27162.03571,425.9642857,138.7857143,6011.785714,20599.89286,1518.160714,1065.142857,2803.321429,17880.89286,672.7678571,308.1785714,3180.821429,13204.23214,882.2857143,469.8928571,1313.714286,10079.875,694.9285714,180.7321429,6737.892857,8668.375,1412.910714,203.375,3413.625,256.0714286,537.5178571,56,9.935657268,7.967540037,0.597439838,0.861538462,0.622222222,0.281671018
+2366,23625.89474,797.7631579,592.5789474,1082.263158,23971.63158,635.6052632,540.1578947,1537.605263,12160.47368,506.6842105,537,1849.868421,16564.31579,1180.105263,10196.05263,7728.105263,6279.394737,1260.973684,338.8157895,2376.763158,13657.28947,402.0789474,296.3684211,436.3157895,15525.94737,412.0789474,131.8157895,5686.342105,11423.02632,1415.815789,1100.710526,2810.342105,10059.39474,1403.763158,274.9473684,2797.210526,7905.078947,832.0263158,416.1578947,1312.078947,6361.684211,646.0526316,163.3947368,6844.421053,5138.157895,1310.631579,201.0526316,3347.657895,263,538.0263158,38,8.681184005,6.616937258,0.647322783,0.826086957,0.527777778,-0.013334851
+2367,39592.91866,870.0047847,543.6698565,1098.995215,34213.32536,716.2679426,544.5933014,1701.69378,18780.11962,523.3110048,456.7894737,1744.933014,27123.21053,1283.526316,5796.205742,4412.665072,9544.54067,1313.229665,355.6842105,2394.660287,18805.19139,496.6698565,1282.08134,588.9665072,22312.15789,437.5167464,130.9952153,3653.521531,17930.05263,1531.607656,599.6315789,2800.54067,14748.6555,641.2870813,283.291866,4869.354067,11525.23445,867.0909091,420.6220096,1352.038278,8180.851675,1019.052632,165.1100478,3062.961722,7013.779904,1302.210526,293.9473684,3239.421053,911.6698565,539.1578947,209,20.42540593,13.45379062,0.752423866,0.928888889,0.710884354,-1.521741277
+2368,49411.73516,913.7077626,557.6712329,1149.232877,36129.87671,674.8949772,540.0273973,1767.86758,16395.26484,467.3789954,924.6347032,1701.972603,25645.90868,1182.881279,7979.826484,3356.347032,9467.09589,1245.657534,329.0639269,2396.707763,17734.04566,437.8310502,137.9269406,673.6575342,21442.88584,423.7625571,191.0958904,6791.643836,16822.83562,1865.100457,463.1552511,2946.100457,13160.93151,556.7488584,257.9863014,1538.347032,8757.986301,918.4794521,387.6073059,1285.447489,4274.986301,576.347032,150.4246575,2619.141553,4855.041096,1106.310502,151.8584475,3167.872146,1106.949772,542.8219178,219,19.24996644,15.19539884,0.61391422,0.901234568,0.644117647,-0.501627211
+2369,51062.35417,933.875,589.2916667,1158.479167,19842.14583,490.7291667,343.7083333,1392.833333,7438.458333,409.8125,545.9166667,1723.541667,11270.3125,1009.854167,9143.395833,5396.729167,5022.1875,1106.041667,291.2708333,2386.625,12055.0625,318.4375,106.5,420.125,13343.875,350.6458333,113.1875,6425.166667,8321.8125,1363.375,605.5625,2770.458333,7831.270833,560.25,242.2916667,8285.020833,5596.583333,741.4375,368.8333333,1296.125,4999.833333,552.3125,153.0208333,3206.8125,3219.9375,1070.895833,215.6458333,3069.395833,181.0625,538.2291667,48,11.4641092,6.083153445,0.847606121,0.774193548,0.48,0.635478189
+2370,15398.5,1114.72,667.78,1133.54,16812.46,735.52,923.04,1585.1,7474.34,601.92,749.88,1805.06,9930.46,1274.18,2695.02,1858,3823.68,1222.54,333.86,2627.6,9118.18,1406.9,470.64,791.98,9306.84,409.8,122.94,1633.38,6277.34,1648.38,650.86,2839.28,5721.62,2247.04,250.02,1371.24,4674.08,972,396.5,1320.74,4067.38,672.28,158.86,2725.2,2714.1,1187.74,132.02,3427.78,377.94,538.3,50,9.803553657,7.525472456,0.640896866,0.847457627,0.505050505,-0.254887705
+2371,39318.42857,917.4744898,555.9438776,1124.469388,33900.98469,736.4846939,953.4234694,1640.076531,19986.96939,666.8571429,1021.530612,1803.632653,27293.94388,1372.97449,3321.219388,2926.755102,9838.454082,1359.239796,361.8367347,2533.52551,19963.55102,2460.336735,291.0459184,834.6785714,24227.82653,584.4030612,322.2244898,1659.44898,18356.04082,1875.846939,666.1989796,2804.010204,16305.40306,682.872449,295.7244898,2039.387755,13646.33673,1214.908163,428.8571429,1341.040816,10142.35204,728,167.8367347,3006.744898,8622.484694,1445.795918,369.4336735,3237.158163,695.7806122,541.4795918,196,21.64466861,11.83375187,0.837310108,0.942307692,0.6125,-1.061212488
+2372,43173.90099,938.7821782,560.1386139,1147.356436,36749.38614,800.4554455,791.5346535,1669.108911,21818.09901,572.7524752,1420.544554,1804.752475,29667.33663,1348.752475,3735.623762,3795.346535,10612.16832,1356.059406,369.8910891,2626.861386,21512.85149,490.1980198,370.4950495,708.980198,25826.9703,476.2772277,151.3267327,1912.534653,19702.9901,1900.990099,609.9405941,2835.009901,17568.69307,666.8613861,285.1485149,1976.29703,14489.65347,1277.168317,432.970297,1336.742574,10406.44554,736.5742574,166.0693069,3060.128713,9110.237624,1431.821782,235.9306931,3289.613861,714.4356436,539.1980198,101,14.57001377,9.408825209,0.763535047,0.918181818,0.517948718,-0.998372075
+2373,34595.51087,827,553.326087,1086.48913,29905.29348,708.7608696,1419.228261,1732.826087,16375.1087,498.7173913,3101.554348,1902.543478,23554.41304,1212.945652,10745,4225.804348,8505.380435,1248.913043,335.2173913,5726.097826,16625.22826,1028.347826,678.9891304,2576.75,19877.52174,523.2608696,1051.554348,3994.48913,16323.57609,2893.434783,532.9347826,2794.945652,13438.67391,637.9891304,273.6956522,7719.956522,10187.29348,1719.054348,412.8695652,1336.076087,6689.130435,922.673913,157.5108696,5850.23913,6065.152174,1239.086957,562.326087,3234.369565,978.3478261,540.4673913,92,17.62415692,6.97522353,0.918346952,0.901960784,0.469387755,-0.774764157
+2374,33379.45946,914.2432432,592.5405405,1088.972973,30310.12838,687.4527027,542.4459459,1603.621622,16584.97297,543.6621622,620.1689189,1808.175676,22211.2027,1248.689189,12462.11486,4653.635135,8198.060811,1344.594595,350.0810811,2392.439189,16651.36486,442.4662162,1059.527027,475.3851351,19960.01351,810.6824324,132.277027,6510.310811,15323.06081,1503.97973,716.4459459,2795.689189,13378.85811,604.3783784,286.0540541,2753.675676,9962.432432,897.5472973,431.6216216,1311.391892,7556.756757,876.8716216,178.777027,6182.297297,6813.864865,1336.081081,325.7094595,3360.418919,298.0608108,543.2027027,148,19.19418622,10.50362287,0.836982671,0.865497076,0.578125,-0.745254707
+2375,38957.60256,995.9102564,531.974359,1128,34054.5,791.8333333,709.2564103,1726.961538,19850.82051,602.2692308,590.3846154,1747.205128,26986.83333,1454.679487,5037.179487,3038.153846,8936.794872,1436.384615,381.3589744,2449.128205,17960.0641,676.6794872,1070.102564,553.8205128,21301.0641,477.6410256,140.1538462,3844.910256,16801.02564,1618.205128,692,2844.961538,14842.71795,700.2051282,319.9102564,1475.269231,11534.55128,1061.012821,479.5,1320.307692,8363.846154,930.474359,188.4230769,3093.282051,7677.717949,1527.692308,149.8076923,3546.75641,370.5128205,541.2179487,78,13.28062353,7.698872581,0.814824893,0.896551724,0.619047619,-0.255751266
+2376,22113.94839,854.8258065,543.1032258,1053.277419,19090.94839,680.0645161,472.1096774,1484.619355,10792.03226,517.5483871,370.2064516,1677.954839,15610.09677,1352.567742,1180.754839,1013.574194,5594.387097,1245.909677,339,2334.767742,10369.49677,742.7548387,218.0709677,429.083871,12412.40645,425.283871,112.3483871,861.3225806,9272.748387,1357.903226,630.3419355,2791.864516,8342.735484,881.3935484,256.2903226,1640.309677,6982.367742,856.6322581,402.7096774,1306.670968,5553.012903,633.7419355,157.7935484,1395.954839,4842.877419,1427.935484,3555.387097,3016.225806,650.4,540.4258065,155,16.96709415,11.84082452,0.716224535,0.945121951,0.759803922,-1.497559503
+2377,30724.58889,807.9222222,542.4555556,1067.522222,27711.93333,713.6444444,586.2555556,1538.933333,15954.35556,511.3222222,910.1666667,1928.3,22027.71111,1248.533333,4256.977778,2990.766667,7979.077778,1339.577778,354.1666667,2409.055556,16178.41111,491.0111111,113.0222222,683.5111111,19520.74444,461.9333333,141.1666667,2179.177778,14342.73333,1818.577778,1867.366667,2808.422222,12905.54444,621.2888889,270.3222222,1835.011111,10737.13333,1068.933333,413.7888889,1328.544444,7862.088889,628.0777778,166.5555556,5367.5,6815.9,1324.133333,199.0888889,3200.755556,757.8222222,540.5222222,90,11.72163136,10.0554463,0.513893778,0.909090909,0.681818182,-0.147368308
+2378,25994.63514,914.1486486,558.4189189,1032.216216,22110.55405,635.2837838,409.8243243,1516.391892,11633.54054,487.0135135,425.4594595,1692.972973,16745.98649,1181.608108,5423.756757,2451.554054,5844.162162,1171.418919,313.6756757,2350.297297,11374.89189,419.6621622,464.1891892,456.972973,13761.24324,419.5810811,113.8648649,3920.662162,10701.72973,1348.959459,495.6621622,2780.148649,8900.837838,577,246.9864865,3595.527027,6934.608108,747.4324324,373.4324324,1314.108108,4951.675676,707.8783784,150.8108108,3244.878378,4046,1164.945946,1535.527027,3256.675676,891.7432432,541.1351351,74,10.62669467,9.714681699,0.405314809,0.936708861,0.611570248,-0.302956611
+2379,28011.256,824.944,594.08,1070.304,23409.752,632.936,526.072,1594.8,13131.92,478.632,784.464,1760.432,18423.128,1219.272,7272.792,3117.088,6641.064,1215.896,330.792,3059.8,12391.04,450.384,4691.776,616.112,14723.296,427.728,121.616,3335.392,12132.536,1709.52,575.608,2826.112,10004.304,671.584,255.264,6341.096,7581.496,1238.352,389,1400.856,4929.464,1753.36,155.128,4633.52,4424.048,1176.976,448.72,3198.24,950.264,542,125,13.05150569,12.78745727,0.200133002,0.932835821,0.637755102,-0.674631123
+2380,41293.95359,894.2025316,692.1054852,1158.291139,34588.44304,668.535865,636.9831224,1693.042194,17053.40506,524.4599156,954.1223629,1762.611814,23701.1097,1242.28692,11580.80169,6709.864979,9012.974684,1313.206751,469.0759494,3006.088608,17652.19831,427.0801688,871.6244726,567.8270042,21525.37553,422.1814346,130.3037975,11825.54852,15719.64135,1807.624473,726.2827004,2811.687764,13088.57806,596.5400844,292.7510549,5990.016878,7756.78481,951.0379747,408.4852321,1306.345992,5886.033755,755.8227848,161.5907173,3172.383966,5214.122363,1215.683544,240.6160338,3261.113924,155.3206751,545.4599156,237,20.24714653,15.57268799,0.639092348,0.901140684,0.5925,-0.622622188
+2381,53356.48837,913.9186047,586.9651163,1135.883721,51766.82558,776.9767442,677.7209302,1831.837209,27941.01163,601.755814,581.4767442,1767.790698,37442.47674,1395.290698,7418.255814,6404.255814,14372.84884,1518.662791,405.5465116,2405.337209,27736.68605,489.8023256,617.6046512,458.6162791,33943.60465,486.8953488,141.7674419,6200.360465,25763.73256,1667.825581,624.4069767,2808.081395,21834.74419,653.3488372,332.5465116,3564.976744,15116.02326,886.3372093,481.8139535,1318.151163,11072.34884,779.3255814,183.4186047,3021.709302,9554.383721,1436.488372,171.8837209,3268.965116,194.2906977,541.5581395,86,15.17084,7.419171066,0.872260492,0.914893617,0.511904762,-0.951256535
+2382,37337.46154,946.0865385,598.6538462,1134.865385,34010.71154,763.4711538,514.625,1717.442308,18759.00962,575.2596154,518.0288462,1817.884615,24786.33654,1336.125,9303.721154,6801.442308,9088.548077,1393.096154,371.5673077,2369.509615,18754.77885,461.9519231,160.4038462,444.1634615,22091.49038,454.6442308,137.5769231,5246.480769,16805.26923,1489.980769,933.4903846,2815.971154,14577.22115,621.2692308,310.7211538,2412.240385,11060.21154,870.6826923,452.8269231,1308.288462,8514.269231,655.0961538,183.2884615,5807.711538,7301.903846,1391.163462,147.8653846,3380.403846,279.8942308,541.9807692,104,13.02769802,10.57291259,0.584252669,0.904347826,0.675324675,-0.157156928
+2383,23741.71795,1049.316239,552.1965812,1067.333333,21468.52137,694.4102564,556.9230769,1465.094017,11843.94017,555.4017094,525.2991453,1744.111111,16229.05983,1269.948718,2719.803419,1668.034188,5889.692308,1358.222222,337.8717949,2377.504274,11459.17949,3038.299145,336.8888889,457.4957265,13509.58974,443.982906,126.8803419,2381.444444,10598.34188,1521.25641,705.3333333,2828.905983,9321.307692,805.7606838,265.2905983,1447.923077,7317.273504,833.6581197,427.5897436,1382.384615,5727.57265,714.6153846,167.5726496,4713.521368,5118.213675,1283.401709,118.6581197,3427.307692,392.1025641,541.4700855,117,13.26531626,11.79392298,0.457752491,0.936,0.692307692,-0.810673381
+2384,34980.30928,1186.845361,593.7835052,1093.948454,28671.30928,810.4226804,1057.639175,1563.865979,16471.57732,641.9381443,1508.649485,1742.072165,22194.02062,1390.185567,4214.762887,3146.927835,7742.835052,1427.298969,358.0824742,3044.463918,14921.17526,452.8969072,330.2783505,547.4123711,17702.62887,676.0412371,126.0618557,2952.701031,13987.19588,2102.268041,677.4639175,2823.051546,12159.48454,621.3608247,289.1443299,1422.701031,9282.041237,1201.680412,439.7525773,1325.773196,7233.597938,688.8453608,175.7216495,2764.670103,6400,1294.113402,170.8247423,3496.597938,406.2164948,542.3402062,97,12.77096662,9.843707907,0.637091711,0.932692308,0.621794872,0.592096872
+2385,27520.40805,745.3735632,440.3045977,1050.304598,23706.06897,624.5,560.3448276,1489.068966,13987.8908,490.7988506,978.2298851,1791.643678,19954.75862,1181.83908,3913.310345,2577.011494,7033.011494,1187.344828,316.3908046,2544.655172,14110.72414,4913.522989,888.2298851,876.9712644,16820.58046,503.7586207,122.4770115,1522.327586,12939.64943,1791.821839,530.3735632,2794.275862,11400.20115,722.6494253,255.0804598,1599.471264,9336.752874,1308.810345,393.0114943,1325.442529,6624.224138,853.7701149,156.2873563,4309.706897,5866.241379,1205.373563,245.0287356,3185.666667,815.3045977,544.2413793,174,19.45228995,12.8428518,0.751069514,0.832535885,0.527272727,-1.562700029
+2386,34407.02222,827.4444444,478.9888889,1086.755556,28652.31111,703.7666667,1089.522222,1698.977778,16223.57778,499.9111111,2387.222222,1756.977778,22676.58889,1215.477778,4746.666667,3192.066667,8527.522222,1255.955556,346.3333333,4485.8,16125.24444,774.9,1741.611111,953.5111111,19358.98889,615.0777778,197.5777778,2156.877778,15931.08889,2330.533333,525.7666667,2864.888889,13203.02222,649.6,266.0777778,4237.988889,9790.3,2231.544444,414.1,1375.533333,6246.9,1105.355556,175.9333333,4386.966667,5868.577778,1263.011111,733.4333333,3220.633333,990.4,540.5222222,90,14.42996697,8.356457038,0.815253408,0.891089109,0.642857143,1.337348012
+2387,51635.28906,923.703125,575.1875,1154.554688,50317.89844,775.2421875,550.5625,1805.289063,27174.98438,593.7734375,511.28125,1817.101563,35770.21094,1380.820313,7702.195313,5647.84375,13402.625,1476.25,392.734375,2357.796875,27290.48438,496.7734375,153.9140625,449.7578125,32780.58594,458.859375,138.75,4818.898438,24552.10938,1578.9375,809.09375,2820.890625,21157.77344,646.71875,330.734375,3656.359375,15434.54688,897.40625,478.765625,1317.710938,11523.53906,706.9140625,185.8359375,4248.460938,9768.382813,1453.179688,207.9140625,3407.273438,228.4375,544.9453125,128,18.72907289,9.013128047,0.876590373,0.920863309,0.571428571,-0.651851898
+2388,33953.42553,841.9468085,531.0851064,1074.659574,28981.31915,697.0851064,980.4148936,1547.340426,17134.02128,552,1832.095745,1850.648936,23261.3617,1286.957447,4070.074468,4649.946809,8184.702128,1357.276596,380.0212766,2674.840426,16624.05319,508.6382979,410.5212766,1211.468085,19512.1383,1061.787234,130.2978723,1660.787234,15221.60638,1823.62766,844.8723404,2813.882979,13421.06383,651.9680851,281.4787234,1727.361702,10699.62766,1736.531915,438.4787234,1334.212766,8095.93617,704.3617021,162.0106383,3122.978723,7276.010638,1360.56383,362.9574468,3304.978723,543.3085106,543.8723404,94,13.67468898,9.334568147,0.7307768,0.94,0.556213018,-0.827706636
+2389,28009.62205,953.5826772,511.6850394,1071.047244,24723.7874,740.5433071,947.0629921,1504.370079,13348.27559,564.1338583,2451.889764,1882.377953,19391.7874,1267.354331,6160.685039,5014.007874,6729.677165,1240.062992,425.0787402,2992.779528,13723.77953,451.0866142,1247.858268,1580.370079,16205.18898,1555.173228,170.6692913,1599.992126,12105.54331,2166.937008,537.3779528,2800.874016,10458.68504,729.8740157,261.5354331,1754.566929,8614.866142,1667.519685,399.1496063,1324.425197,6379.519685,1036.031496,161.496063,4141,5412.944882,1260.551181,394.8503937,3290.850394,790.503937,543.8188976,127,14.79203478,12.15036296,0.570334488,0.852348993,0.604761905,-0.595836025
+2390,44021.17057,882.9297659,552.9531773,1127.762542,39685.91639,719.4147157,1030.424749,1747.658863,21052.51171,529.1237458,1964.404682,1763.153846,30482.35117,1292.240803,6808.384615,4880.685619,11203.97324,1333.347826,363.1304348,3556.120401,21409.92642,665.5852843,855.2006689,1018.602007,26646.23077,475.1304348,195.8561873,3246.237458,20460.04682,2026.568562,608.7826087,2832.688963,16837.96321,713.1204013,296.0133779,5354.314381,12620.20067,2191.802676,432.4113712,1344.501672,7916.384615,902.0167224,171.5183946,4170.167224,7241.575251,1312.812709,330.4013378,3277.856187,1007.849498,548.0334448,299,21.8921065,18.78680369,0.513391981,0.897897898,0.56952381,1.114656267
+2391,42853.02105,897.3263158,551.8,1130.894737,17257.35789,566.2842105,539.3368421,1471.989474,8196.852632,405.6105263,1020.494737,1995.094737,12411.67368,986.3894737,10579.96842,3300.863158,4799.673684,1021.157895,276.7473684,2389.4,8868.147368,359.2315789,236.4526316,1379.494737,10682.73684,329.6315789,123.9578947,4666.305263,8449.2,2128.968421,434.8631579,2798.873684,6758.336842,592.3263158,221.2315789,2150.715789,5096.589474,712,354.2736842,1267.694737,2622.126316,571.9263158,137.0210526,2796.221053,2875.378947,1002.410526,221.0736842,3048.263158,1084.210526,542.7157895,95,12.70335041,9.685157943,0.647094588,0.940594059,0.659722222,-0.861036651
+2392,25585.37333,834.32,458.2933333,1055.706667,23389.28,680.7866667,447.8666667,1501.146667,13130.36,535.1866667,449.9866667,1731.466667,17925.05333,1280.026667,5095.92,2247.306667,6333.866667,1321.24,351.1733333,2342.973333,12233.96,434.4,476.1066667,433.9866667,14305.90667,382.4133333,130.9733333,2848.96,11238.12,1512.506667,687.0533333,2820.04,9942.266667,645.3466667,278.92,1573.586667,7646.346667,844.2,436.5066667,1388.36,5890.106667,719.84,172.8,5770.853333,5496.8,1365.613333,990.9733333,3230.266667,330.3333333,543.5866667,75,10.96321093,8.949676931,0.5775756,0.9375,0.625,0.512633442
+2393,40898.55556,980.6732026,543.7254902,1123.748366,37102.51961,801.3006536,698.254902,1675.287582,20956.36928,612.5620915,799.0490196,1766,28325.86928,1461.372549,5801.316993,4303.931373,10200.13072,1519.352941,399.9215686,2426.176471,19472.78758,568.2254902,436.9901961,600.0359477,21904.5719,433.8431373,158.4803922,2759.545752,17115.69281,1733.372549,770.9379085,2818.715686,15357.22549,709.5947712,316.6535948,1582.836601,11726.70588,1038.601307,472.375817,1352.352941,9139.754902,730.8104575,186.2777778,4202.941176,8291.160131,1481.251634,220.1993464,3318.849673,338.8856209,552.5424837,306,27.66958739,15.47290007,0.829031157,0.908011869,0.566666667,-0.485598091
+2394,37734.97436,1043.128205,715.2948718,1222.217949,34419.66667,834.6282051,1029.897436,1879.730769,19263.38462,634.1025641,558.6666667,1823.153846,26300.16667,1547.192308,2376.74359,1542.717949,8751.282051,1532.435897,411.1794872,2441.282051,17616.74359,7976.602564,290.3717949,475.4871795,21335.48718,573.3461538,145.1282051,2452.025641,16891.08974,1694.858974,792.2948718,2860.910256,14961.28205,3456.205128,350.0512821,1602.692308,11644.83333,1000.461538,499.8076923,1343.794872,8857.179487,715,187.1410256,3461.987179,7764.269231,1555.474359,140.6794872,3395.346154,382.3717949,544.8717949,78,12.05837214,8.806637899,0.683090331,0.917647059,0.6,-0.236304841
+2395,19356.85276,915.2515337,561.6932515,1073.957055,16107.3681,714.2392638,539.3006135,1468.141104,9236.165644,715.6441718,426.2453988,1713.791411,12646.31288,1360.184049,1123.233129,986.1288344,4514.90184,1424.423313,351.4233129,2368.889571,8767.404908,458.7668712,184.8834356,464.2883436,10165.17178,406.8711656,120.6319018,904.2208589,7877.613497,1460.613497,618.7177914,2798.294479,6985.736196,640.2208589,266.5153374,1923.527607,5548.822086,786.3006135,410.0306748,1346.625767,4554.441718,633.2453988,163.3742331,1240.834356,3819.306748,1561.349693,14623.02454,3212.184049,597.2208589,545.3619632,163,15.17542208,13.71964291,0.427384542,0.976047904,0.724444444,-1.142048275
+2396,30150.35789,801.1263158,505.5368421,1061.105263,26682.13684,665.6210526,883.4631579,1536.757895,14754.75789,530.4631579,1952.705263,1867.557895,20798.29474,1225.452632,5709.189474,3978.084211,7425.589474,1236.978947,338.7578947,2676.831579,15653.36842,456.8105263,1212.536842,964.0526316,18244.75789,654.2105263,129.9684211,2021.684211,14006.28421,2082.210526,686.8526316,2794.010526,12361.24211,637.4,272.9789474,1772.610526,10126.45263,1460.336842,415.3894737,1316.252632,7256.515789,948.2,157.7473684,3845.010526,6222.631579,1266.926316,236.8315789,3211.684211,833.7052632,542.8421053,95,13.44523536,9.295442879,0.722514367,0.931372549,0.608974359,-0.988228873
+2397,24246.28,926.49,544.21,1086.84,21560.7,744.15,512.42,1538.23,12257.89,651.96,381.03,1668.67,17247.68,1435.06,1113.73,1117.77,5776.81,1438.8,349.7,2390.63,9834.47,455.57,147.01,446.74,11274.29,416.78,117.6,1014.04,8964.33,1419.22,626.92,2793.61,8160.67,650.02,277,1849.19,6507.8,957.01,410.92,1327.38,5148.05,624.1,159.58,1160.52,4664.82,1445.57,1361.6,3073.41,610.54,544.21,100,13.18018198,9.941408507,0.656565007,0.943396226,0.769230769,-0.457032526
+2398,28946.35294,911.3529412,835.7882353,1156.164706,25187.49412,737.0823529,700.1058824,1758.482353,14819.32941,556.2352941,426.2588235,1783.482353,20609.57647,1413.517647,1810.270588,1074.576471,7293.905882,1410.988235,353.5882353,2431.482353,15108.50588,558.4588235,153.4,450.4588235,18009.05882,468.6823529,128.7058824,814.8470588,14116.52941,1562.258824,620.0823529,2813.670588,12625.16471,699.6823529,282.8705882,2426.776471,10295.29412,972.8470588,430.4588235,1330.835294,7877.258824,654.2117647,167.6235294,1014.176471,7008.576471,1511.352941,392.8588235,3206.552941,620.6941176,544.1882353,85,11.11618777,10.06867368,0.423776507,0.885416667,0.772727273,-0.112105427
+2399,39668.77291,866.3944223,507.9521912,1116.354582,33019.05578,712.7689243,575.7330677,1595.581673,19323.40637,579.9083665,619.2151394,1767.621514,26737.78088,1303.705179,4273.2749,3257.187251,9515.219124,1321.63745,350.0358566,2477.944223,19194.48207,452.8167331,570.5298805,568.2231076,23381.08765,437.1115538,122.5179283,2838.689243,17658.22311,1623.099602,682.6533865,2823.326693,15791.9761,758.5537849,278.1354582,1971.047809,12990.40637,995.12749,421.8286853,1320.211155,9412.430279,781.9123506,163.1474104,2736.537849,8300.920319,1380.561753,574.3545817,3239.960159,722.936255,547.5816733,251,23.59300911,13.96620032,0.80596477,0.899641577,0.597619048,-0.930391031
+2400,37507.15,956.8125,776.825,1152.125,33480.175,772.05,647.925,1689,18881.9,571.975,567.6625,1803.6,26968.425,1363.85,5421.8625,3368.9375,9441.55,1322.3875,354.7125,2404.0125,19138,521.8125,112.9,525.6875,23026.7375,451.8625,131.525,3294.425,16809.125,1480.5375,620.65,2800.1375,14736.025,625.675,299.725,2530.75,12281.4125,892.8375,437.625,1317.275,8787.2375,647.8875,174.8,3915.525,7577.5625,1422.875,155.6875,3353.0875,770.8125,544.45,80,12.23205148,9.336724078,0.64604428,0.833333333,0.512820513,-0.68935014
+2401,48458.44961,934.0542636,602.751938,1158.953488,43742.75194,753.8682171,735.2790698,1862.55814,23405.5814,533.9844961,1427.465116,1767.573643,34223.31008,1343.139535,6969.984496,4384.023256,12637.37984,1385.356589,374.0930233,3521.418605,23793.51938,539.6589147,453.4806202,910.255814,29425.14729,481.5658915,188.1782946,3776.457364,23082.31008,2080,532.1860465,2822.410853,18807.85271,653.0620155,305.4186047,9334.511628,13951.09302,1377.844961,443.0155039,1337.604651,8263.302326,890.496124,167.620155,3001.007752,7776.883721,1322.565891,343.9457364,3276.20155,1022.914729,543.9302326,129,15.85775404,10.60624611,0.743409455,0.934782609,0.632352941,-1.489431009
+2402,37310.77108,860.8192771,528.8875502,1104.690763,28568.83133,650.2570281,797.5502008,1624.706827,11686.84739,447.4939759,2435.88755,1727.497992,19968.08434,1129.971888,6891.875502,2759.325301,7325.016064,1183.823293,312.7751004,2712.911647,13622.72691,384.3493976,1299.120482,2222.253012,16095.00402,667.4578313,905.1726908,2250.172691,12541.42972,2439.052209,382.7309237,2821.670683,9837.321285,545.0682731,245.2971888,1036.891566,6001.413655,1028.7751,363.9678715,1308.678715,2828.056225,896.6827309,148.060241,2755.072289,3395.228916,1054.329317,418.9959839,3923.072289,1132.7751,549.6184739,249,21.42905607,15.17510429,0.706056487,0.918819188,0.62406015,-0.571907995
+2403,50436.87,913.98,589.85,1147.1,47133.91,769.69,554.29,1788.06,26249.17,587.9,533.61,1800.57,34596.54,1371.95,7684.95,6865.95,12541.96,1453.93,387.52,2373.8,26333.28,475.96,159.94,441.59,31791.3,445.45,143.97,5257.21,23875.05,1577.45,919.68,2843.76,21109.74,652.62,326.76,2317.91,15477.22,946.85,484.48,1307.48,11784.57,700.01,185.05,3434.01,10142.56,1462.69,145.8,3435.1,248.19,545.32,100,14.10497677,9.083701352,0.765019742,0.943396226,0.641025641,-0.901615055
+2404,38772.07895,856.75,492.8157895,1098.315789,36737.44737,717.7631579,713.1447368,1606.894737,19483.71053,550.5921053,545.3157895,1769.526316,26295.56579,1307.394737,9897.631579,2771.894737,9259.723684,1403.223684,367.9473684,2414.657895,19732.85526,461.9868421,430.5921053,498.0921053,23428.01316,422.5263158,144.2894737,3860.894737,18172.11842,1526.947368,655.4605263,2807.263158,15996.59211,627.1184211,297.5394737,2073.078947,11924.39474,843.4078947,451.5921053,1312.855263,9025.855263,741.8157895,171,4663.618421,8265.723684,1392.526316,195.8157895,3376.236842,307.5921053,546.9078947,76,10.97910313,9.713172555,0.466167731,0.904761905,0.531468531,0.041394977
+2405,25694.47687,1004.836299,547.9572954,1090.355872,23508.02135,747.3451957,587.7010676,1562.384342,12987.29181,593.4163701,697.3523132,1774.701068,17296.4306,1361.75089,2759.925267,2361.313167,6035.957295,1478.142349,357.2241993,2422.747331,11258.28826,1462.078292,824.1281139,542.6512456,12983.5516,444.569395,152.4092527,2810.02847,9876.263345,1605.857651,871.3879004,2830.864769,8785.44484,1126.811388,286.5088968,1881.928826,6726.992883,1076.508897,453.0604982,1353.113879,5327.142349,812.9466192,175.6192171,4644.761566,4697.010676,1349.398577,641.9323843,3367.099644,426.4946619,549.3985765,281,20.97611553,17.57407779,0.545956169,0.915309446,0.638636364,-1.238426794
+2406,37054.59108,907.8884758,507.3159851,1105.929368,34034.75093,739.2267658,909.9739777,1611.95539,19403.85502,582.9442379,1096.888476,1762.947955,26502.66171,1362.817844,4104.159851,4663.033457,9466.05948,1413.695167,372.4795539,2696.825279,19327.83271,455.8884758,925.6245353,1713.01487,22060.79554,674.9330855,136.1635688,2733.468401,16761.55762,1746.490706,735.9144981,2813.081784,14732.9777,758.732342,308.6579926,1851.375465,11785.33086,1295.743494,465.4349442,1326.39777,9316.30855,964.4312268,180.6802974,4177.442379,8097.219331,1460.684015,418.6765799,3509.98513,472.1933086,551.9516729,269,28.71857649,12.7243554,0.896486748,0.835403727,0.517307692,-0.473781239
+2407,45259.44601,929.3333333,557.9107981,1244.605634,40273.66197,754.7746479,753.3192488,1889.849765,23228.23005,595.4413146,1183.868545,1816.765258,31936.28638,1403.384977,3753.098592,4293.784038,11204.44131,1476.549296,387.3192488,2635.671362,23092.10329,479.5680751,168.2253521,670.1830986,26961.41315,612.9061033,138.57277,3109.352113,20647.64319,1785.723005,741.2816901,2834.431925,18250.51643,769.0375587,320.9295775,1775.840376,14433.9061,1252.502347,478.6384977,1312.784038,11129.41315,685.7652582,180.2347418,2918.276995,10087.32394,1497.399061,286.0892019,3351.037559,485.915493,549.1173709,213,24.96649292,11.2354914,0.893017059,0.91416309,0.560526316,-0.692566074
+2408,22976.1123,931.1390374,501.7860963,1066.909091,20014.7861,692.7005348,594.5828877,1502.176471,11375.26738,560.0213904,510.8395722,1770.090909,16144.43316,1275.256684,3774.203209,1751.652406,5499.342246,1290.855615,326.7593583,2404.791444,11182.29947,2560.074866,346.9304813,496.7914439,12880.92513,547.3101604,125.0106952,2051.513369,10397.66845,1631.561497,851.6417112,2828.058824,9158.427807,1134.165775,266.3582888,1575.106952,7275.786096,935.1871658,420.5454545,1318.513369,5519.235294,726.8877005,158.2834225,2400.524064,4990.144385,1279.149733,263.3048128,3335.315508,571.0641711,546.2352941,187,18.2425462,14.98773297,0.570091515,0.903381643,0.578947368,-1.450321061
+2409,31794.81373,921.8235294,549.1960784,1322.911765,25812.9902,720.8529412,568.872549,2402.970588,15966.56863,519.4411765,396.1568627,1740.009804,22017.4902,1366.745098,1294.745098,1608.04902,7950.421569,1290.009804,335.9607843,2388.843137,15284.43137,468.7352941,109.5098039,435.3627451,18339.37255,432.9313725,120.2745098,1136.313725,14443.7549,1434.254902,645.627451,2792.392157,12721.13725,1145.156863,269.4705882,1870.931373,10490.80392,911.372549,414.9117647,1310.45098,7795.852941,628.0980392,161.2254902,1446.54902,7140.029412,1477.196078,1234.637255,3093.911765,631.9313725,545.8137255,102,11.99540673,11.1227238,0.374446364,0.886956522,0.708333333,1.423301023
+2410,34433.42647,911.8676471,465.9558824,1077.779412,28522.77941,727.4558824,558.6617647,1506.705882,17190.72059,557.9411765,584.2794118,1736.367647,23212.77941,1399.411765,2509.161765,2269.25,8314.161765,1340.794118,360.5882353,2372.411765,17198.58824,508.5441176,441.3823529,610.2794118,20287.52941,456.0294118,128.2058824,1444.75,15533.08824,1598.176471,759.5588235,2793.794118,14034.92647,629.0735294,285.6617647,1751.602941,11473.63235,1295.279412,427.6617647,1289.014706,8759.897059,724.5735294,174.1617647,1804.882353,7509.367647,1507.897059,2573.441176,3133.044118,671.0147059,544.5441176,68,11.93941414,7.452075877,0.781298478,0.957746479,0.68,-0.676538135
+2411,40248.9798,861.2222222,475.6363636,1117.393939,33897.53535,702.989899,593.6262626,1635.686869,20205.82828,528.3131313,433.2121212,1712.575758,27738.24242,1292.939394,4628.858586,2118.777778,9974.737374,1297.181818,351.5959596,2471.121212,20381.64646,475,171.1414141,492.8888889,23913.47475,447.4141414,127.9090909,2686.909091,18986.20202,1448.686869,514.5757576,2798.585859,16747.85859,684.0606061,284.5050505,1736.717172,13247.25253,885.2929293,435.1212121,1300.616162,9147.575758,660.7777778,167.4343434,3404.535354,8131.959596,1368.040404,984.7878788,3222.313131,858.989899,546.4545455,99,13.69365203,10.00427745,0.682829522,0.876106195,0.475961538,-1.312615159
+2412,55369.11842,957.8815789,596.9342105,1165.039474,41578.93421,661.6315789,395.1447368,1645.421053,22005.52632,479.5526316,407.0131579,1701.552632,30966.30263,1239.013158,7907.618421,4349.460526,11885.93421,1284.328947,339.5131579,2412.381579,22029.72368,897.6973684,149.0131579,453.9342105,26595.86842,410.7894737,130.7236842,6493.026316,21566.18421,1457.539474,560.6315789,2818.289474,17625.97368,586.8815789,271.8157895,2859.197368,12500.32895,791.2368421,401.1710526,1278.776316,6879.776316,626.1447368,161.5789474,2789.736842,6848.736842,1207.434211,126.0394737,3205.868421,1057.421053,543.4605263,76,12.03607732,8.351349065,0.720110206,0.938271605,0.64957265,1.389561658
+2413,32860.2233,866.592233,592.0194175,1108.242718,30380.80583,699.9417476,545.5533981,1657.815534,16734.80583,549.4854369,527.9514563,1820.980583,22097.72816,1256.106796,8301.029126,6254.941748,8255.553398,1346.728155,355.9708738,2370.796117,16776.08738,532.6893204,170.5728155,455.1553398,20220.79612,423.0194175,130.5533981,6765.058252,15069.56311,1492.165049,1207.038835,2808.737864,13025.29126,666.7378641,299.8737864,2727.281553,9956.84466,877.6601942,438.6213592,1304.368932,7607.990291,679.4660194,184.9514563,7661.912621,6546.019417,1347.970874,225.631068,3391.407767,270.1456311,546.3495146,103,12.42173604,10.88638455,0.481587537,0.903508772,0.715277778,0.090597708
+2414,25232.33557,1341.302013,608.4765101,1080.006711,23914.96644,833.6375839,681.2214765,1511.161074,11871.75168,709.3154362,802.8389262,1753.114094,15523.7047,1409.66443,5753.308725,2625.805369,5029.818792,1371.765101,340.3489933,2447.637584,10773.14094,492.0872483,551.9127517,520.8993289,11905.2953,696.8053691,126.409396,5199.557047,8722.691275,1551.892617,634.1812081,2810.328859,7827.255034,776.7785235,261.5234899,1302.899329,5756.845638,901.3489933,407.5503356,1332.751678,4604.201342,684.5637584,163.5436242,2721.416107,3545.577181,1216.52349,154.6979866,3653.993289,361.0738255,548.4832215,149,15.41645628,12.54734231,0.581015111,0.908536585,0.620833333,0.658897972
+2415,35746.63636,986.6545455,471.2545455,1078.445455,30223.31818,769.7181818,525.8727273,1500.918182,18305.70909,592.3909091,857.4909091,1695.636364,25229.38182,1457.727273,2233.463636,2116.436364,8803.881818,1352.227273,361.7727273,2404.863636,18627.52727,507.8090909,203.0818182,768.3272727,22548.11818,442.3363636,130.2363636,1338.4,17402.15455,1689.527273,640.1727273,2797.145455,15785.3,718.5,295.4363636,1689.427273,13088.67273,1518.918182,445.1272727,1313.627273,9754.063636,677.5181818,173.2090909,1840.972727,8811.354545,1578.836364,2423.8,3103.981818,680.5636364,546.7,110,13.6229237,10.39065455,0.646713421,0.956521739,0.714285714,0.167262081
+2416,36679.91429,805.4857143,455.1714286,1059,29475.85714,642.1428571,583.2285714,1533.6,19174.11429,499.1142857,611.2285714,1790.857143,25417.25714,1214.171429,4164.628571,2576.971429,9097.2,1232.828571,333.8857143,2392.142857,18117.02857,440.9714286,119,626.0857143,21266.71429,454.4,125.4857143,2750.285714,16777.91429,1461.742857,530.8,2801.685714,14698.54286,602.2,270.6,2069.371429,12002.45714,836.2285714,419.6285714,1301.4,8071.885714,637.2,158.6857143,4122.257143,7589.857143,1292.542857,239.6,3159.885714,780.7428571,544.0571429,35,7.334107999,6.15635085,0.543492974,0.972222222,0.833333333,-0.492764847
+2417,40543.45745,993.9680851,530.0851064,1078.212766,33650.52128,776.8191489,930.287234,1570.691489,20482.23404,599.2659574,2410.382979,1895.191489,27967.26596,1344.265957,5333.170213,3593.510638,9552.914894,1308.755319,361.2446809,2752.351064,19697.28723,489.7340426,697.9787234,2102.042553,23052.37234,529.893617,286.9574468,1307.329787,17908.07447,2700.202128,506.0851064,2814.893617,15661.80851,693.1595745,290.1595745,1488.244681,12528.97872,1535.468085,425.9787234,1340.56383,8998.12766,797.1276596,168.1914894,2767.457447,7679,1321.212766,229.3085106,3359.914894,800.8404255,546.8510638,94,13.38576141,9.056296291,0.736385757,0.949494949,0.803418803,0.241913467
+2418,46610.77181,933.4832215,599.1208054,1144.946309,36859.24832,688.8590604,649.5704698,1699.020134,20361.95973,509.3557047,474.1879195,1729.134228,28318.98658,1278.939597,5749.234899,3781.248322,10223.03356,1298.302013,359.7181208,2412.449664,19716.15436,466.9463087,196.0067114,465.3422819,23795.41611,411.1744966,132.8053691,4491.302013,19091.20134,1465.402685,597.0939597,2818.57047,15714.51678,664.557047,290.5973154,6401.248322,12031.55705,845.2818792,428.1744966,1319.818792,8237.604027,673.0738255,160.0939597,2263.90604,7199.006711,1296.95302,321.0604027,3282.395973,937.0201342,547.409396,149,17.53359025,11.05473624,0.776198163,0.961290323,0.689814815,1.414163658
+2419,55675.67961,966.0873786,616.9514563,1173.572816,22311.90291,559.2524272,479.3398058,1453.834951,11519.09709,405.5145631,359.3786408,1674.533981,16610.29126,1050.048544,7088.572816,3587.058252,6407.786408,1089.805825,292.9708738,2376.145631,11886.03883,518.4660194,101.368932,469.4563107,14320.20388,338.815534,112.4854369,9008.708738,11661.37864,1317.165049,502.8252427,2783.601942,9562.582524,529.6796117,234.0582524,2515.145631,6942.563107,668.0970874,352.8932039,1280.699029,3719.728155,562.0873786,144.3300971,1721.650485,3873.650485,1036.009709,150.0776699,3044.786408,1069.271845,546.5825243,103,12.44166156,10.65573879,0.516219617,0.944954128,0.66025641,1.239444226
+2420,40598.45513,854.1666667,557.6410256,1132.019231,32353.78846,653.224359,670.8397436,1634.378205,14924.26923,464.4871795,1293.217949,1815.794872,23069.89103,1154.307692,9682.487179,4202.730769,8615.987179,1215.480769,322.4807692,2560.762821,16272.75641,575.7115385,110.8717949,1725.512821,19965.07051,414.6730769,250.5320513,5257.025641,15190.58333,2489.25641,457.3333333,2816.794872,12059.4359,583.7435897,254.7179487,1909.352564,8344.814103,1000.589744,382.7179487,1285.987179,4339.198718,563.1217949,149.7692308,3818.179487,4483.551282,1096.974359,300.4423077,3160.942308,1090.320513,549.1923077,156,21.02970499,10.72874085,0.860073126,0.816753927,0.547368421,-1.034068109
+2421,50975.9403,944.0895522,560.5671642,1136.41791,47419.74627,792.1791045,527.8358209,1822.029851,26693.37313,704.1492537,558.1044776,1796.238806,35421.65672,1390.119403,7349.298507,6475.074627,13766.22388,1546.38806,433.8656716,2411.104478,25345.10448,500.0298507,4386.567164,467.8955224,30694.28358,529.641791,145.4328358,3507.716418,24268.70149,1738.701493,634.5970149,2843.253731,20389.74627,654.7164179,316.0447761,3035.38806,13910.28358,932.8507463,477.5671642,1400.149254,9843.552239,1525.820896,182.2089552,5055.776119,8771.253731,1434.895522,177.4029851,3244.074627,199.5074627,547.1343284,67,10.52074726,8.534938535,0.584701774,0.917808219,0.609090909,-1.083422577
+2422,49759.30405,924.2364865,577.222973,1149.074324,48928.37838,779.8716216,616.3175676,1860.871622,26822.80405,682.3243243,535.1081081,1822.587838,35023.45946,1391.418919,6507.351351,6082.445946,13341.98649,1498.810811,412.5945946,2648.527027,26138.95946,516.7094595,1383.290541,464.0067568,31292.97297,459.7364865,140.4932432,4519.506757,24371.84459,1680.486486,723.2432432,2824.72973,20321.41892,646.277027,330.3986486,3887.662162,14682.17568,912.472973,483.3918919,1330.898649,10822.24324,950.5675676,188.5472973,3919.243243,9326.689189,1447.567568,174.9054054,3358.209459,212.5810811,547.8445946,148,16.19509481,12.02408648,0.669898859,0.913580247,0.621848739,-1.341860345
+2423,26212.04808,1083.692308,1239.615385,1292.048077,22344.18269,683.0480769,823.0288462,1555.173077,12876.23077,525.7307692,618.7019231,1796.067308,17949.25962,1299.769231,1860.923077,2048.163462,6378.384615,1291.826923,351.5288462,2674.394231,12962.13462,473.5192308,884.5096154,487.5865385,15453.18269,420.7884615,121.875,1261.259615,11539.94231,1494.173077,596.7211538,2805.067308,10313.13462,1103.596154,273.5480769,1928.923077,8483.375,1013.961538,408.7692308,1400.548077,6391.317308,871.4903846,160.0480769,2319.163462,5518.653846,1333.153846,356.6634615,3219.615385,707.1346154,547.9423077,104,12.27993753,10.90934394,0.459094233,0.99047619,0.666666667,1.237874447
+2424,56055.58333,959.4611111,563.7333333,1160.933333,48744.38333,741.9222222,683.2277778,1800,25295.12222,527.6722222,707.0111111,1734.166667,37821.11667,1322.144444,7888.338889,4466.222222,13936.31111,1395.983333,375.4388889,2717,26921.87222,493.8888889,149.1277778,590.0666667,33569.24444,447.9944444,140.05,6291.2,25984.73889,1742.722222,565.9,2820.516667,21310.92778,629.9833333,310.5777778,2310.611111,15888.32778,921.8555556,449.8111111,1314.394444,9009.377778,657.0277778,162.6444444,2058.361111,8748.855556,1334.222222,132.8722222,3281.305556,1039.122222,551.05,180,18.48133882,13.31769887,0.693348429,0.853080569,0.535714286,0.450352911
+2425,61699.45299,982.7692308,591.5726496,1198.623932,48059.47009,729.0769231,500.965812,1860.649573,25162.21368,552.4102564,490.5897436,1769.17094,32416.13675,1307.034188,7357.700855,4474.683761,12620.05128,1402.794872,383.4444444,2365.931624,25434.59829,445.0512821,167.2051282,437.3846154,29879.35897,423.4102564,135.1282051,5090.08547,22752.07692,1536.880342,548.2478632,2811.504274,19291.5641,633.0854701,312.8376068,4712.606838,12369.54701,833.4957265,452.2735043,1300.666667,9579.863248,652.1025641,171.5042735,2406.393162,7938.153846,1331.786325,173.5213675,3277.25641,173.8376068,547.1623932,117,19.58020096,8.138389256,0.909527474,0.860294118,0.722222222,-1.372970428
+2426,43248.18293,885.7195122,598.8658537,1136.02439,38845.12195,728.0609756,641.7560976,1695.45122,22109.76829,560.7317073,547.9634146,1792.743902,29166.13415,1306.292683,5941.792683,7288.695122,10976.70732,1408.707317,364.8292683,2361.670732,21706.29268,463.3170732,252.0609756,448.9268293,26258.5,429.3780488,132.3170732,4146.817073,20253.15854,1503.414634,1196.865854,2812.390244,17686.36585,772.9146341,320.902439,2607.109756,13185.12195,883.5,453.402439,1332.280488,9953.353659,683.3658537,179.3536585,4715.682927,8814.317073,1421.512195,193.8170732,3376.195122,260.5121951,547.5365854,82,12.4810602,9.271215593,0.669488122,0.863157895,0.67768595,0.53802585
+2427,20300.95238,988.9365079,589.2698413,1087.301587,18521.53968,726.8412698,656.2698413,1494.079365,10153.8254,577.4126984,847.3333333,1798.52381,13925.84127,1302.079365,2308.888889,2589.412698,5177.857143,1574.063492,347.7301587,2469.380952,10850.92063,498.3968254,501.3333333,833.5079365,12175,445.968254,124.9365079,2905.253968,9492.825397,1926.571429,731.3015873,2839.190476,8313.84127,864.8095238,272.7301587,1691.380952,6574.666667,1057.52381,459.2063492,1429.603175,5392.666667,820.7619048,175.0634921,4826.666667,4565.984127,1313.396825,128.8571429,3431.746032,397.8888889,548.1269841,63,11.19234955,7.806564412,0.716593426,0.875,0.525,-1.145992239
+2428,37134.21622,967.1351351,567.2297297,1159.689189,32487.12162,787.7567568,1047.418919,1764.189189,19271.44595,604.2162162,1933.094595,1925.648649,26162.83784,1394.027027,3157.689189,3574.027027,9046.297297,1411.932432,376.4594595,2509.878378,18612.81081,489.7432432,231.5945946,1803.378378,22153.51351,550.1756757,196.5810811,3153.513514,17369.35135,2295.621622,708.7162162,2892.351351,15316.05405,660.1891892,314.6486486,1700.378378,11867.89189,1374.391892,462.7027027,1341.864865,9151.175676,704.7297297,182.6486486,3751.432432,8551.635135,1437.756757,255.027027,3402.756757,500.2972973,547.0675676,74,11.03060664,9.292578418,0.538796667,0.891566265,0.611570248,0.546212428
+2429,28038.58442,946.8181818,559.1818182,1092.077922,24441.37662,794.7012987,719.2337662,1619.090909,13754.41558,564.1558442,1232.714286,1967.987013,18759.03896,1319.558442,3625.883117,4236.038961,6830.454545,1341.12987,359.1558442,2485.220779,13493.4026,708.6233766,314.4155844,1142.519481,16070.57143,477.5194805,590.025974,3186.519481,11990.27273,2090.220779,808.2987013,2803.766234,10535.03896,606.4025974,289.1428571,1868.545455,8227.571429,1167.883117,437.038961,1330,6854.441558,696.1428571,174.0649351,6348.532468,5910.688312,1334.987013,262.5064935,3353.584416,509.9350649,548.5844156,77,11.44692291,9.742501996,0.52499994,0.827956989,0.583333333,1.305866266
+2430,35608.98892,886.2908587,533.6232687,1106.927978,30804.69529,715.0249307,609.299169,1670.977839,17329.29086,517.0055402,560.9639889,1737.65651,24285.79501,1281.797784,5259.68144,3286.506925,8637.257618,1269.955679,350.6371191,2404.157895,16959.75346,2185.534626,495.2880886,557.8531856,20264.74792,446.800554,129.8504155,3593.795014,16177.61219,1529.180055,581.565097,2800.720222,13486.78116,647.3601108,276.434903,3203.778393,10362.26039,811.1772853,423.2797784,1311.382271,7347.434903,758.9473684,164.531856,2854.293629,6370.285319,1288.961219,308.5927978,3280.141274,918.2077562,554.0277008,361,25.8207985,19.58960082,0.651469003,0.853427896,0.626736111,1.191492153
+2431,36401.68,824.6533333,552.7533333,1125.066667,32853.10667,675.66,683.34,1715.806667,17875.03333,490.1466667,884.8266667,1742.166667,25776.99333,1249.053333,6042.84,3938,9301.593333,1273.8,338.6733333,2859.433333,18248.95333,1250.666667,149.26,668.9533333,22163.78,470.6333333,140.8266667,4251.7,17799.23333,1650.346667,661.18,2834.286667,14649.48667,1310.913333,277.9333333,5410.9,11189.27333,1104.393333,409.3533333,1314.753333,7377.293333,741.9,168.4266667,4926.133333,6609.48,1253.613333,294.2866667,3201.153333,982.5066667,549.2,150,19.39430785,10.42657399,0.84319362,0.867052023,0.510204082,-1.245012409
+2432,49890.45263,935.7052632,640.8526316,1176.631579,48425.96842,759.8526316,616.9894737,1855.494737,24207.46316,589.3684211,516.0421053,1779.484211,31977.48421,1359.305263,9507.273684,8108.873684,11844.44211,1462.589474,386.8210526,2356.410526,25110.2,476.4421053,159.8210526,436.0736842,29998.06316,477.9368421,140.3473684,7103.168421,21877.14737,1559.705263,902.8,2831.515789,18715.31579,654.5789474,331.9368421,7380.084211,12634.96842,873.0105263,459.0526316,1315.673684,9641.894737,651.6526316,187.0105263,4575.536842,7746.947368,1394.442105,257.5473684,3405.684211,184.0631579,551.7684211,95,14.9297225,8.340921785,0.829384002,0.913461538,0.633333333,-0.290207495
+2433,50591.89583,905.5833333,469.5416667,1103.083333,44290.91667,825.75,1073.635417,1662.114583,26776.5,589.1666667,1606.166667,1885.739583,35985.17708,1396.4375,3853.625,2916.052083,13099.20833,1395.291667,375.0729167,2627.875,26540.91667,2435.90625,134.4479167,967.2291667,32275.47917,473.0833333,447.1354167,2358.84375,24293.34375,2107.041667,589.40625,2810.5625,21614.04167,649.9270833,303.8020833,1852.9375,18015.89583,1265.96875,459.3125,1308.28125,12809.58333,683.5729167,178.90625,3384.25,11382.46875,1490.46875,272.25,3896.104167,760.3958333,551.1666667,96,17.74374618,7.109248621,0.91622584,0.914285714,0.5,-0.571333116
+2434,47064.09804,1088.215686,589.6078431,1166.372549,41608.35294,872.2352941,870.6078431,1821.764706,23283.47059,666.9411765,939.2745098,1840.54902,31797.84314,1551.862745,4249.843137,3589.960784,11325.31373,1579.803922,412.7647059,2501.647059,18527.68627,2259.627451,299.745098,601,22944.88235,1049.098039,173.4117647,3954.72549,18521.82353,1868.764706,731,2819.686275,16453.01961,1025.588235,339.1568627,1824.607843,12594.29412,1131.568627,501.4509804,1367.941176,9340.823529,731.7058824,189.4901961,5478.235294,8646.352941,1549.588235,165.1176471,3450.960784,374.1960784,549.0392157,51,10.27674815,6.980622151,0.733894272,0.910714286,0.579545455,-1.513353892
+2435,37790.14583,1084.354167,572.2916667,1095.020833,34179.22917,776.8611111,651.3472222,1618.770833,19768.64583,617.6666667,731.1041667,1775.805556,26140.22222,1429.263889,4143.402778,2556.041667,9509.958333,1480.569444,382.6319444,2395.486111,19203.69444,484.7291667,308.2708333,562.0347222,22389.72917,490.0763889,136.4444444,4470.854167,17618.21528,1702.986111,732.3194444,2827.9375,15519.42361,681.1458333,324.4861111,1664.847222,11943.69444,1090.118056,477.3194444,1344.930556,9175.409722,735.6875,182.8888889,4166.75,8238.326389,1438.041667,177.0069444,3528.493056,409.2777778,553.0486111,144,16.15657456,12.58850665,0.626828937,0.837209302,0.529411765,-1.118335035
+2436,23957.57955,792.9545455,436.6363636,1068.295455,21916.5,657.2272727,1118.931818,1525.261364,12158.98864,513.6931818,2122.579545,1894.590909,16810.43182,1206.465909,3269.068182,3343.852273,6084.318182,1224.761364,322.8181818,2568.875,12272.95455,2513.727273,124.2840909,1665.306818,14672.22727,459.1590909,124.6704545,1137.863636,10808.76136,1807.761364,608.0795455,2805.670455,9622.238636,697.6590909,250.3295455,1669.715909,7919.193182,1454.5,401.0568182,1309.011364,5971.227273,628.8636364,163,3571.363636,5098.670455,1307.636364,1443.284091,3166.329545,751.125,550.4886364,88,11.52387059,10.0291926,0.492526891,0.916666667,0.666666667,-0.750480114
+2437,40591.81325,858.9457831,522.4096386,1080.548193,35964.28916,712.7650602,727.9819277,1623.361446,20171.87952,522.2289157,454.9578313,1730.638554,28839.55422,1298.373494,5215.837349,2669.283133,9990.951807,1299.361446,360.2831325,2395.566265,20785.57229,566.3433735,248.746988,482.439759,24708.84337,499.2349398,129.2108434,4148.289157,18712.66265,1464.114458,579.060241,2785.710843,16602.98795,738.0963855,282.7650602,1805.493976,13013.53012,876.7228916,430.7409639,1306.078313,9339.813253,683.1927711,164.8915663,3922.036145,7912.301205,1356.126506,767.6084337,3205.771084,869.0060241,552.746988,166,17.59876112,12.38366546,0.710530022,0.954022989,0.610294118,-0.687884904
+2438,29702.91057,927.1300813,511.495935,1066.00813,27197.86992,745.7886179,553.7317073,1549.934959,15049.94309,561.9918699,641.8536585,1765.601626,20435.18699,1320,6230.528455,3805.471545,7334.910569,1357.235772,359.9593496,2419.333333,13782.99187,465.2276423,965.601626,586.1056911,15185.02439,408.804878,138.7235772,4039.373984,11915.56911,1696.788618,618.1544715,2807.406504,10540.30894,644.5609756,281.8455285,1815.097561,8036.252033,947.1219512,437.6829268,1365.739837,6255.276423,891.5528455,175.0813008,5908.918699,5705.601626,1363.804878,849.5203252,3231.512195,325.0650407,553.4796748,123,13.93011855,11.37352969,0.577387269,0.984,0.683333333,-0.298626181
+2439,22203.61538,773.1025641,416.1538462,1025.974359,24170.11966,692.982906,467.1965812,1505.598291,11043.13675,589.4188034,417.5811966,1709.777778,15882.44444,1242.076923,1637.435897,1241.179487,5773.282051,1258.034188,341.2735043,2368.367521,11136.35043,418.6581197,197.8717949,500.017094,13745.17094,379.034188,115.6837607,1038.384615,10208.5641,1360.42735,536.6324786,2823.247863,9152.529915,810.8717949,247.4444444,1477.675214,7648.529915,795,398.7094017,1310.316239,5464.982906,633.0598291,155.5384615,1743.786325,4984.735043,1350.025641,4835.273504,3045.376068,735.6666667,551.7350427,117,15.62398917,9.920980009,0.772525452,0.906976744,0.609375,-1.070587256
+2440,45549.56716,888.1343284,508.1641791,1111.835821,37593.08955,729.7164179,684.6119403,1639.507463,22510.37313,549.880597,1742.925373,1840.208955,30083.74627,1308.029851,3923.328358,3242.41791,10833.19403,1316.477612,367.4029851,2438.940299,22791.38806,477.3134328,315.7910448,1519.223881,26289.8209,491.6716418,511.5522388,1725.791045,20596.29851,2283.731343,564.5223881,2810.41791,18143.07463,680.6119403,294.4179104,1654.731343,14562.56716,1747.597015,427.8059701,1310.58209,10038.07463,691.4477612,169.5522388,2095.179104,8884.940299,1363.119403,363.9104478,3232.985075,837.7761194,550.119403,67,11.27320474,8.242844337,0.68217484,0.827160494,0.468531469,-1.063132671
+2441,39780.38095,897.2063492,555.2539683,1110.396825,33380.38095,735.2380952,660.7460317,1668.84127,19435.73016,527.3015873,475.7777778,1715.873016,26529.85714,1346.428571,6189.301587,3299.920635,9006.968254,1305.238095,372.3333333,2348.904762,17791.06349,486.3333333,1006.111111,538.8095238,21301.52381,459.4444444,131.0793651,3969.968254,16826.60317,1577.031746,507.8412698,2823.285714,14060.65079,607.0793651,291.2857143,2263.079365,10742.98413,854.7936508,422.6984127,1317.412698,7363.174603,878.3968254,162.6507937,3546.68254,6373.507937,1299.809524,442.8888889,3295.730159,891.4285714,549.8730159,63,11.36985327,8.022160461,0.708646089,0.887323944,0.572727273,-0.754951839
+2442,50461.42857,1027.414286,564.3857143,1134.242857,45860.38571,788.8857143,819.1285714,1747.371429,26003.75714,633.0857143,515.0714286,1783.057143,34185.6,1425.285714,6531.957143,4309.985714,12200.04286,1506.871429,388.2285714,2345.157143,25641.57143,502.2142857,157,437.0142857,31443.94286,467.3428571,145.9142857,4462.014286,24087.45714,1582.442857,649.4285714,2828.185714,20708.95714,657.9142857,336.8428571,1696.514286,15739.62857,921.2714286,504.3,1312.014286,12029.68571,690.9571429,186.7142857,4539.742857,10640.32857,1476.042857,133.4857143,3438.185714,281.0571429,551.6571429,70,13.07220111,7.154334139,0.836940581,0.897435897,0.598290598,-1.238154915
+2443,33821.10667,882.1733333,569.04,1125.64,28961.73333,714.6,1107.346667,1667.426667,16950.98667,585.4266667,2116.48,1877.133333,23451.17333,1418.56,3742.88,4003.066667,8170.96,1448.04,369.4666667,2430.053333,17457.8,636.7733333,543.8133333,3293.346667,19894.36,535.1866667,134.04,1774.36,15279.73333,2151.826667,772.4666667,2839.4,13529.72,827.7066667,307.9866667,1546.68,10719.10667,1820.026667,464.1066667,1311.626667,8320.96,765.8666667,177.9066667,3282.826667,7383.52,1447.933333,195.8,3706.533333,520.1866667,550.68,75,12.55981174,8.030061315,0.768919441,0.986842105,0.681818182,-0.869356318
+2444,26988.54067,828.6172249,554.4019139,1080.995215,23404.05742,683.9473684,926.3205742,1536.08134,13405.06699,596.6794258,1304.07177,1810.08134,18564.17225,1308.334928,5178.866029,3639.875598,6715.645933,1324.143541,361.0143541,2570.751196,13356.09569,818.8133971,1264.856459,1141.186603,15715.82297,1007.009569,171.7177033,2449.416268,12273.54545,2173.545455,822.15311,2819.253589,10783.9378,834.1578947,287.2344498,1652.119617,8651.435407,1820.885167,443.6746411,1354.038278,6669.172249,1074.038278,170.7272727,5218.985646,5873.411483,1345.205742,333.2488038,3287.325359,560.4545455,554.9282297,209,20.30373809,13.82552489,0.732343903,0.874476987,0.55,0.68816409
+2445,40420.17318,872.849162,479.8324022,1109.636872,36229.46369,724.6592179,669.1117318,1601.994413,21961.06145,557.8994413,884.9832402,1743.608939,30766.72626,1380.178771,5126.988827,3762.150838,10765.70391,1323.821229,359.7932961,2550.687151,22660.81564,487.7709497,122.5810056,602.6759777,27154.51955,799.3072626,131.5530726,3666.703911,20129.34078,1495.296089,588.6927374,2792.391061,17756.43017,637.7039106,300.027933,2379.670391,14823.54749,1175.49162,436.4916201,1313.642458,10586.89385,664.7150838,170.0614525,4715.519553,9210.614525,1441.899441,188.5642458,3316.653631,775.2849162,555.2905028,179,18.58750534,13.13491265,0.707560473,0.85645933,0.621527778,-0.565914646
+2446,27917.75916,844.6492147,550.0366492,1089.900524,23832.43979,700.3979058,571.5863874,1607.120419,13084.01047,496.6492147,517.5026178,1746.366492,18863.95288,1223.099476,4226.198953,3355.486911,6529.460733,1217.586387,346.0366492,2452.429319,12690.97906,552.7591623,2128.429319,594.4450262,15228.1623,526.895288,125.5811518,3232.623037,11861.44503,1676.664921,573.6282723,2794.706806,10042.95812,629.1099476,259.1518325,2518.460733,7679.298429,835.0994764,398.5026178,1368.04712,5422.298429,1219.256545,157.9528796,5242.905759,4673.82199,1225.696335,542.9842932,3258.659686,897.921466,557.5445026,191,24.09905439,10.60403332,0.897988636,0.876146789,0.62012987,-0.374868575
+2447,39389.68561,872.6060606,536.0757576,1109.25,34233.875,711.2992424,599.4659091,1684.670455,18791.87121,517.5984848,962.5681818,1745.602273,26242.29924,1271.276515,6617.825758,4264.674242,9352.977273,1307.026515,345.8219697,2750.458333,18349.39773,534.9848485,1025.125,944.9090909,21881.10227,454.6477273,134.0871212,4115.875,17734.79167,1739.583333,603.1818182,2819.276515,14577.45833,610.6022727,283.4356061,4283.083333,10917.54924,1222.469697,420.4090909,1330.193182,7226.791667,928.2689394,167.0833333,3683.761364,6411.526515,1277.666667,226.6136364,3234.045455,965.3825758,554.6704545,264,19.80762426,17.10758602,0.504028672,0.949640288,0.739495798,1.291161707
+2448,40229.06618,886.2426471,546.3382353,1119.176471,33800.61397,718.4448529,795.9301471,1744.154412,14374.24265,491.1286765,2056.433824,1796.503676,23091.89706,1234.588235,10126.19118,4516.102941,8407.871324,1287.161765,339.8198529,3081.161765,16095.47794,440.8713235,2812.617647,1542.047794,19367.59926,1357.408088,146.4264706,5672.227941,14945.84559,2330.845588,432.7757353,2812.422794,11763.23529,651.5404412,262.5698529,1560.029412,7829.459559,1693.772059,391.6948529,1340.106618,3823.746324,1282.727941,156.4742647,3569.599265,4386.25,1169.106618,772.4558824,3216.636029,1115.676471,557.4117647,272,20.96916958,16.94004744,0.589381353,0.934707904,0.647619048,-0.573801798
+2449,26275.7381,821.9047619,587.0952381,1124.52381,27072.97619,653.6666667,828.5,1740.47619,11751.21429,518.6428571,827.1904762,1816.738095,15824.35714,1233.071429,10364.85714,8935.119048,6677.809524,1309.428571,344.3809524,2571.452381,14305.04762,439.4047619,150.1666667,498.9285714,15766.42857,750.047619,127.0238095,5831.214286,10539.57143,1462.952381,644,2821.690476,9319.095238,630.2142857,287.0714286,10703.40476,6702.5,860.7857143,411.5238095,1347.952381,5532.142857,633.0714286,165,4167.880952,3757.642857,1252.97619,514.3571429,3362.261905,191.3571429,551.9047619,42,9.028741716,6.211408558,0.725749088,0.954545455,0.666666667,-0.308123329
+2450,45428.1,911.4083333,677.525,1136.341667,43191.975,744.675,646.8583333,1765.041667,23811.70833,583.1833333,629.1166667,1805.133333,31247.76667,1361.008333,8623.291667,7535.716667,11301.36667,1416.358333,375.3833333,2712.841667,23787.31667,470.0416667,154.4916667,597.3,28878.79167,442.325,133.275,5136.65,21619.23333,1673.85,1120.891667,2849.108333,19244.36667,644.025,320.8916667,3113.241667,14217.29167,963.175,469.5333333,1319.833333,10849.78333,658.3416667,188.7583333,3430.033333,9326.183333,1443.733333,257.8,3409.616667,252.175,554.1166667,120,15.28915107,10.92096219,0.699844866,0.895522388,0.542986425,-1.503690061
+2451,31237.53714,1092.828571,591.52,1150.405714,26705.28571,771.7142857,979.9085714,1635,15802.06286,611.8571429,1254.857143,1797.971429,21352.6,1378.88,4699.76,3890.765714,7315.457143,1354.822857,355.44,2421.182857,15466.34286,566.6457143,239.64,1481.085714,17611.63429,628.48,128.2457143,2242.725714,13683.25714,1472.102857,742.8171429,2815.228571,12019.57143,627.2171429,284.7885714,1781.651429,9517.982857,1548.234286,436.6914286,1325.931429,7357.994286,690.0514286,168.5314286,2855.485714,6472.137143,1337.034286,204.6457143,3526.097143,536.2171429,558.8857143,175,23.62698897,10.0274906,0.905470917,0.857843137,0.662878788,0.141795963
+2452,17264.97661,837.0760234,509.6666667,1076.842105,14925.1345,691.1578947,585.5964912,1487.175439,8714.578947,500.6725146,480.6140351,1715.046784,12430.07602,1318.695906,1104.97076,1226.567251,4542.795322,1199.45614,326.2163743,2351.450292,8977.222222,457.1695906,105.8830409,564.7426901,10893.5731,517.005848,123.0526316,909.2807018,8434.555556,1357.315789,649.5263158,2805.824561,7617.789474,607.122807,261.0818713,2221.842105,6330.608187,914.251462,405.4853801,1325.461988,4841.853801,753.3508772,162.9707602,2313.467836,4451.368421,1423.725146,2410.842105,3148.859649,650.3508772,555.0526316,171,17.49398824,13.62720086,0.627067666,0.868020305,0.670588235,-0.159076491
+2453,18885.11818,798.1272727,622.8,1079.736364,16225.26364,643.2090909,851.9363636,1517.136364,9486.981818,683.7727273,1281.154545,2053.209091,13419.65455,1214.990909,3740.845455,3470.409091,4926.481818,1219.763636,340.6272727,2872.5,9716.109091,449.2636364,755.6636364,605.8,11761.89091,391.5636364,119.0363636,1657.381818,8901.145455,1994.645455,623.0818182,2787.481818,7979.309091,718.1727273,247.0727273,2101.181818,6682.745455,1282.945455,399.0909091,1388.809091,5035.963636,832.5090909,161.5818182,3649.990909,4528.772727,1315.036364,345.7727273,3156.254545,694.8818182,552.9363636,110,14.16218749,10.35455979,0.682226091,0.93220339,0.666666667,-1.478613117
+2454,48209.95062,912.9506173,632.5185185,1137.765432,36452.35802,658.0617284,622.2839506,1612.925926,21122.82716,498.9135802,388.4814815,1717.469136,29281.81481,1246.08642,6481.790123,4451.975309,10501.25926,1245.592593,344.308642,2342.975309,20274.95062,454.3950617,1134.222222,449.0864198,24942.32099,407.5308642,129.345679,5216.740741,20130.85185,1394.135802,594.6296296,2784.395062,16734.90123,582.691358,274.6049383,4000.691358,12967.37037,897.7283951,416.2592593,1320.703704,8285,906.6049383,164.8518519,2325.592593,7551.802469,1267.518519,203.7160494,3219.197531,949.0864198,553.5308642,81,11.92688464,9.134650939,0.642974693,0.9,0.566433566,-0.582037518
+2455,48395.54622,899.6386555,558.1428571,1147.12605,40123.30252,727.4285714,989.2605042,1765.352941,21380,496.3697479,839.8739496,1780.436975,30270.41176,1293.87395,7277.865546,3588.697479,11304.98319,1308.92437,351.6134454,2709.302521,21058.07563,14733.28571,206,574.1596639,26326.46218,772.4201681,131.2689076,5049.394958,20803.16807,1960.865546,495.5966387,2838.756303,16945.28571,638.2268908,285.1260504,2503.722689,12033.84034,1059.218487,414.7647059,1322.336134,6513.621849,685.8655462,157.4957983,2646.470588,6581.739496,1255.983193,254.6470588,3285.084034,1061.781513,554.6722689,119,15.22299289,10.57013514,0.719634292,0.881481481,0.572115385,0.549355547
+2456,34005.76522,1055.278261,574.1565217,1149.521739,31985.25217,813.8347826,775.8086957,1677.565217,17732.97391,629.4521739,945.8869565,1796.530435,24370.81739,1472.13913,4642.191304,4155.643478,8295.104348,1443.93913,385.5043478,2430.765217,16842.1913,469.7130435,305.4434783,729.5217391,19759.31304,525.3391304,175.6086957,4750.008696,14625.14783,1744.278261,740.0173913,2808.817391,13134.86087,646.6956522,317.2347826,2044.756522,10357.28696,1065.721739,473.1565217,1333.982609,8110.93913,706.2869565,187.7478261,3830.66087,7087.478261,1474.330435,650.2086957,3428.113043,445.7043478,555.6173913,115,14.62474206,10.41623083,0.701942647,0.93495935,0.598958333,0.391189199
+2457,36642.23899,923.7987421,505.4402516,1106.345912,33662.96855,764.672956,724.327044,1603.691824,19372.86792,602.3207547,900.4716981,1761.377358,26887.57862,1423.496855,4198.622642,4135.226415,9131.025157,1424.874214,376.6855346,2443.188679,18731.74214,454.4528302,733.1194969,755.7735849,21544.50314,759.509434,150.7169811,2539.779874,16372.1195,1721.597484,763.1509434,2799.691824,14495.30189,633.2641509,303.3710692,1620.861635,11740.55975,1092.943396,465.4591195,1363.591195,9003.572327,814.5597484,183.1761006,3751.672956,8026.767296,1483.515723,1214.811321,3344.559748,458.1069182,556.0503145,159,15.56768414,13.11161194,0.539114233,0.940828402,0.757142857,-0.309119952
+2458,38418.98684,1095.447368,649.75,1836.407895,32454.39474,757.8026316,851.0394737,3031.960526,18898.30263,615.6052632,830.6447368,1922.710526,25762.93421,1408.184211,2187.355263,3373.644737,8791.394737,1458.039474,388.9605263,2481.315789,17904.76316,482.5394737,324.0394737,919.3815789,19606.01316,475.2236842,133.2368421,2785.052632,14982.68421,1596.671053,780.3684211,2834.578947,13179.63158,649.2236842,294.7894737,1676.421053,10377.23684,1184.868421,457.4736842,1332.460526,7979.197368,655.3552632,179.3947368,2359.618421,7215.394737,1398.105263,252.9078947,3481.842105,496.4078947,554.8421053,76,11.89984519,9.035957735,0.650700998,0.904761905,0.531468531,0.297832644
+2459,30641.85149,934.1089109,533.1485149,1112.029703,26812.9604,729.6237624,1195.524752,1606.70297,15401.06931,585.0891089,657.6633663,1765.415842,21585.55446,1419.386139,4005.623762,3565.138614,7273.564356,1373.346535,357.1683168,2413.049505,16401.19802,3903.19802,2397.138614,5719.970297,18475.44554,519.3366337,135.7425743,1915.564356,13787.10891,1540.950495,715.1386139,2803.564356,12209.62376,695.4257426,300.5247525,1600.346535,9695.386139,1515.227723,454.3069307,1324.207921,7779.544554,1578.574257,174.8712871,2850.108911,6712.485149,1392.267327,196.6732673,3833.752475,526.9405941,556.6534653,101,13.96715817,10.46304453,0.662436989,0.90990991,0.526041667,0.347240114
+2460,34427.11688,855.4155844,506.4675325,1082.701299,29433.25974,728.1168831,692.5324675,1573.376623,17708.20779,575.6883117,1093.233766,1808.285714,23925.77922,1315.12987,4077.077922,4168.61039,8559.701299,1382.38961,386.2467532,2444.246753,17206.96104,480.9090909,478.1168831,1215.064935,20322.11688,546.038961,139.012987,2729.064935,15907.11688,1832.116883,753.1948052,2805.818182,13902.66234,645.6103896,293.8701299,2045.454545,11071.64935,1266.142857,450.8051948,1326.207792,8419.779221,735.5974026,175.4545455,4454.701299,7599.545455,1393.246753,224.6363636,3341.194805,544.8051948,553.5584416,77,12.07187824,8.451396686,0.714054984,0.9625,0.641666667,-0.56447363
+2461,23021.60396,870.1287129,560.2772277,1071.168317,20681.40594,696.4950495,553.009901,1522.287129,11414.42574,525.6237624,394.1881188,1716.871287,16567.86139,1369.108911,1076.544554,1034.821782,5703.069307,1297.673267,336.9108911,2392.841584,11675.77228,486.4851485,103.8712871,473.5940594,13653,440.3564356,117.1188119,1042.811881,10354.89109,1399,616.8217822,2794.168317,9229.049505,595.5247525,272.970297,1942.237624,7455.277228,867.3465347,408.3465347,1316.455446,6170.574257,622.3465347,158.9306931,1059.584158,5258.267327,1470.722772,2784.752475,3214.544554,617.1287129,553.4653465,101,14.55610216,9.886181982,0.73397375,0.89380531,0.561111111,1.555596172
+2462,35330.49383,920.4074074,445.0246914,1065.777778,31196.60494,747.2222222,569.9135802,1499.481481,18293.96296,582.6419753,1663.320988,1727.049383,25093.19753,1489,1502.604938,1711.333333,8802.148148,1364.185185,361.345679,2484.074074,17601.74074,509.4567901,177.4074074,1393.901235,20781.71605,433.0740741,139.9382716,970.9012346,15663.77778,1646.432099,606.2716049,2803.703704,14099.2963,649.8271605,284.0864198,1505.012346,11714.16049,1747.962963,426.037037,1310.185185,9137.061728,658.8271605,183.4320988,1863.740741,7856.802469,1606.851852,3988.049383,3097.296296,674.6790123,555.4197531,81,12.50570171,8.727935042,0.71617918,0.931034483,0.578571429,0.004712253
+2463,42777.77612,814.7910448,483.880597,1069.477612,35885,665.2537313,917.0447761,1540.656716,22629.53731,533.4477612,1686.701493,1784.880597,30154.23881,1262.80597,4842.238806,3741.791045,10719.76119,1276.119403,350.9701493,2706.626866,22079.16418,559.9552239,503.8358209,2096.19403,25896.47761,471.8507463,244.7313433,1720.134328,20353.20896,2387,522.1940299,2811.507463,17874.31343,634.0746269,284.3432836,1572.462687,14692.32836,1400.567164,420.9701493,1318.925373,9940.149254,748.238806,163.5223881,2952.492537,8972.164179,1307.462687,237.1343284,3204.089552,821.6268657,553.5522388,67,12.23065719,7.408506149,0.795668385,0.930555556,0.676767677,-0.62520128
+2464,34412.35484,1052.370968,560.3548387,1083.370968,32580.14516,763.2903226,540.1129032,1614.435484,17069.75806,607.6774194,516.9677419,1747.854839,22373.25806,1343.129032,7797.967742,3059.274194,8015.177419,1371.887097,353,2352.274194,17459.96774,442.0322581,235.483871,448.7419355,19720.24194,630.6451613,131.9193548,4105.451613,14989.64516,1455.403226,625.5645161,2815.467742,13186.06452,626.3064516,293.6129032,2642.33871,9768.419355,845.8709677,445.3709677,1299.096774,7701.016129,670.483871,175.1774194,3389.193548,6343.548387,1335.822581,394.6612903,3492.403226,292.8225806,554.3064516,62,11.57486321,7.654864029,0.750090531,0.873239437,0.563636364,0.737173686
+2465,37584.71429,864.0612245,613.877551,1123.877551,35726.22449,715.7755102,676.4285714,1706.836735,19190.44898,541.2857143,547.3469388,1765.836735,25912.97959,1307.571429,8938.367347,6092.632653,9040.387755,1432.755102,358.6734694,2432.77551,19844.22449,458.3061224,1170.204082,461.2857143,23923.4898,431.9795918,131.5714286,6156.285714,18451.04082,1514.346939,659.5714286,2800.918367,16227.77551,637.6938776,303.0612245,2765.591837,12172.73469,872.3673469,451.2857143,1291.77551,9189.816327,935.0408163,175.5510204,7397.22449,8557.714286,1396.857143,335.4489796,3383.571429,301.122449,553.7346939,49,8.170000804,7.801575562,0.296911132,0.960784314,0.680555556,0.410319988
+2466,41559.74803,914.984252,550.2834646,1109.133858,37747.95276,753.4645669,598.984252,1643.244094,21118.88976,573.7086614,594.8425197,1756.173228,29013.85039,1368.952756,8184.787402,4700.283465,10279.00787,1445.834646,375.3228346,2411.866142,19063.94488,514.5905512,381.4488189,574.7795276,23127.06299,440.4409449,173.4724409,5152.015748,18367.62992,1686.023622,807.4251969,2804.708661,16181.24409,653.503937,309.6929134,2273.23622,12001.26772,894.8503937,458.1574803,1322.598425,8921.527559,737.2204724,181.2440945,5689.952756,8415.251969,1416.291339,315.2047244,3351.503937,315.9133858,558.3228346,127,17.59902828,10.04783843,0.820997746,0.835526316,0.62254902,0.404517219
+2467,23498.29457,935.6899225,548.0232558,1092.75969,22054.06977,723.1550388,624.6356589,1538.48062,12155.47287,569.1705426,1073.48062,1800.627907,16379.89922,1332.790698,2529.705426,3866.093023,6065.147287,1573.023256,358.2248062,2505.953488,12487.53488,477.6589147,447.7364341,1109.356589,14450.04651,490.6124031,128.9767442,2500.604651,11284.82946,1921.023256,836.6511628,2810.627907,9935.697674,812.0542636,284.2790698,1874.852713,7921.914729,1262.054264,457.0930233,1388.449612,6332.682171,725.1550388,176.5736434,4303.697674,5489.379845,1367.100775,155,3380.550388,394.4341085,556.4728682,129,16.97725283,10.3039925,0.794755813,0.895833333,0.583710407,1.373956519
+2468,20902,861.4244604,733.6906475,1084.42446,18758.03597,697.7913669,530.5611511,1535.647482,10311.79856,510.5611511,498.6330935,1722.230216,15223.07194,1368.928058,1628.633094,2054.115108,5254.316547,1317.611511,337.4964029,2555.769784,10514.23741,473.2805755,100.7266187,485.4172662,12909.34532,419.0863309,119.9208633,1119.798561,9524.100719,1414.618705,636.1942446,2794.410072,8447.913669,591.5683453,262.1079137,1994.115108,7035.928058,1025.834532,409.8201439,1293.366906,5680.453237,629.6402878,163.6690647,2323.359712,4996,1451.71223,1914.661871,3134.57554,630.7338129,558.1654676,139,17.45110886,11.18397437,0.767645493,0.852760736,0.643518519,0.018041924
+2469,13985.08257,829.4311927,440.6788991,1056.559633,12378.07339,765.4678899,657.7798165,1426.275229,7053.779817,500.0733945,1161.376147,1725,10193.65138,1430.522936,1527.431193,1378.458716,3698.284404,1184.844037,315.3486239,2441.862385,7681.110092,1675.651376,118.4678899,1535.477064,9201.568807,673.4036697,802.6238532,851.6513761,6949.944954,1486.743119,586.3302752,2799.623853,6311.614679,717.1651376,256.8348624,1990.504587,5391.06422,1115.33945,393.3119266,1315.46789,4183.53211,633.7155963,168.3027523,3862.110092,3802.504587,1538.825688,9774.229358,3119.981651,664.0917431,555.3119266,109,12.86847736,10.87944055,0.534080863,0.956140351,0.756944444,-0.859769831
+2470,37900.06522,860.8586957,500.2391304,1108.923913,33811.13043,711.9456522,575.4782609,1589.923913,19726.22826,532.0869565,913.2826087,1749.326087,27259.96739,1275.5,4051.304348,3401.326087,9748.065217,1276.478261,359.1304348,2421.608696,19688.15217,458.5108696,442.8369565,1086.141304,23378.31522,632.7608696,127.1847826,2524.217391,17417.82609,1661.467391,554.7282609,2789.434783,15323.73913,790.5978261,275.5108696,2073.5,12927.45652,996.8043478,415.2608696,1312.108696,9078.815217,763.0108696,170.25,4661.597826,7903.576087,1341.043478,552.0869565,3218.684783,786.7826087,555.4347826,92,14.86780693,9.033403637,0.79425738,0.8,0.597402597,-0.189457732
+2471,15124.41379,1077.206897,565.3678161,1043.229885,15709.64368,700.7586207,611.2758621,1391.137931,6220.45977,578.4137931,1324.241379,1731.91954,10404.68966,1193.356322,5885.528736,2934.057471,3198.149425,1117.83908,307.1494253,2683.068966,7048.275862,753.3908046,1416.988506,1204.781609,8476.390805,523.3103448,126.9770115,1969.643678,5593.816092,2021.287356,484.4597701,2772.586207,4734.885057,667.1494253,214.5287356,1452.471264,4043.804598,1177.195402,356.6781609,1346.724138,3395.931034,908.9885057,146.0229885,3252.735632,2527.149425,1081.034483,249.4942529,3487.804598,811.2643678,554.1724138,87,12.46965999,9.075350456,0.685795237,0.925531915,0.743589744,1.271495692
+2472,29467.22024,767.4404762,552.1428571,1080.702381,24961.31548,622.25,540.8333333,1533.589286,14386.23214,489.8392857,680.9940476,1760.565476,20736.8631,1270.011905,5640.625,3974.470238,7439.238095,1225.892857,322.8392857,2466.065476,15388.03571,798.0892857,418.0059524,558.5059524,18107.3869,452.8452381,129.5833333,3326.220238,13611.97619,1605.97619,713.922619,2795.089286,12028.6369,1065.589286,254.7916667,2053.053571,9925.892857,969.9642857,397.6309524,1304.404762,7030.482143,688.0595238,159.4702381,4737.458333,6101.190476,1221.922619,364.1071429,3229.39881,829.6071429,559.1130952,168,16.09661762,13.8576473,0.508766929,0.943820225,0.658823529,-0.233526767
+2473,23331.2619,751,426.9761905,1051.702381,19495.77381,603.547619,429.3809524,1452.559524,11317.44048,466.4404762,410.702381,1681.559524,15872.36905,1167.047619,1857.869048,1139.511905,5800.607143,1189.988095,319.0595238,2387.452381,11739.72619,407.6904762,164.8809524,501.8571429,13928.29762,394.0595238,116.4880952,1185.952381,10664.35714,1346.785714,472.4285714,2893.952381,9406.595238,775.2142857,258.6428571,1494.547619,7663.095238,784.1904762,384.6309524,1284.785714,5529.321429,620.8452381,154.3571429,2371.345238,4795.964286,1206.440476,1248.821429,3088.083333,854.1785714,554.4642857,84,13.78472837,7.947637208,0.817059204,0.913043478,0.646153846,1.191560344
+2474,48586.90055,924.8121547,534.4917127,1136.132597,46419.1547,816.378453,863.4309392,1805.477901,24057.01657,544.4502762,1529.019337,1820.643646,34930.12155,1326.458564,6984.546961,4157.980663,12500.40331,1399.654696,375.2651934,2667.864641,24428.27072,511.4033149,764.7154696,1414.950276,30015.98343,553.6629834,365.8259669,4352.477901,22928.20442,2118.624309,537.6546961,2851.425414,18744.30387,621.4143646,298.6491713,2747.729282,13494.59669,1123.262431,430.3618785,1325.30663,8227.453039,826.3812155,165.5303867,3273.961326,7474.828729,1300.544199,211.4475138,3322.743094,1022.254144,562.4088398,362,23.29942818,21.79546014,0.353457904,0.868105516,0.629565217,-0.055910318
+2475,50590.91971,997.1824818,639.2408759,1215.364964,44113.94891,793.1459854,926.9051095,2033.759124,22871.58394,605.7372263,1310.291971,1808.430657,31467.0292,1401.20438,10986.82482,7077.394161,11824.21898,1544.569343,393.9343066,4507.693431,23498.18248,641.2116788,165.7810219,833.5474453,27924.86861,465.1605839,136.6423358,11365.31387,20797.88321,2568.80292,629.4014599,2843.963504,17132.59854,626.7445255,320.2408759,5775.153285,9621.963504,1036.905109,452.2919708,1307.919708,7177.072993,656.4160584,174.0291971,3487.715328,6426.759124,1318.978102,243.2919708,3329.912409,143.6058394,557.3576642,137,16.75882617,10.55173407,0.776901219,0.938356164,0.619909502,-1.146379011
+2476,24926.97619,860.5357143,439.452381,1058,20603.20238,675.3214286,494.1071429,1378.52381,12429.65476,516.6309524,1139.488095,1690.904762,17217.65476,1385.369048,1250.666667,1420.392857,6170.440476,1276.678571,335.9404762,2320.297619,10863.11905,423.7142857,92.76190476,990.25,12701.25,403.9047619,114.7380952,798.1428571,9894.416667,1443.119048,607.5595238,2792.238095,8910.511905,579.9166667,249.4642857,1439.5,7385.107143,1070.309524,405.0119048,1283.845238,5831.464286,619.452381,154.1785714,1680.892857,5187.130952,1518.678571,10579.2381,3094.190476,640.7857143,557.0357143,84,13.47919586,8.108430998,0.798833992,0.943820225,0.717948718,-0.121713774
+2477,24402.18056,809.125,470.9583333,1034.361111,22807.86111,700.3194444,737.0972222,1464.027778,18134.54167,594.3888889,1868.027778,1959.472222,25687.95833,1382.055556,7564.833333,5925.347222,8931.625,1316.625,357.5972222,2633.055556,18045.97222,713.8888889,120.25,1281.388889,21903.34722,548.8888889,182.4722222,5408.25,15807.55556,2040.736111,578.3055556,2804.722222,13808.20833,649.1805556,296.7361111,2724.263889,11385.18056,1677.847222,442.5833333,1312.402778,8411.333333,678.6388889,175.5555556,6213.513889,7122.347222,1433.597222,203.2777778,4366.986111,764.6111111,557.2916667,72,12.50526715,8.114026702,0.760917424,0.86746988,0.545454545,-0.586602396
+2478,44336.02974,877.4312268,489.5687732,1100.360595,38837.44981,717.063197,873.2416357,1600.962825,22937.18587,561.6171004,1678.115242,1812.349442,31785.9368,1307.078067,5048.576208,4061.449814,11185.98885,1325.171004,365.4423792,2520.490706,22799.54275,470.9851301,511.7211896,1708.695167,27225.88104,974.4498141,318.7137546,1673.888476,20577.0855,1963.289963,528.9516729,2804.263941,18168.29368,651.2342007,283.8959108,1642.866171,15111.80669,1340.780669,432.0743494,1316.914498,10552.08922,800.8215613,166.5910781,3169.193309,9316.802974,1382.63197,271.7026022,3282.947955,797.1003717,561.7657993,269,22.32444998,16.16550759,0.689677439,0.930795848,0.584782609,-0.673057907
+2479,24201.08511,772.4361702,475.2659574,1058.202128,19838.14894,636.0744681,470.7978723,1485.074468,11469.53191,481.7978723,694.2234043,1792.223404,16548.98936,1171.042553,4225.87234,2682.521277,5992.085106,1212.765957,436.8297872,2425.680851,12052.3617,414.4787234,1594.351064,648.106383,14044.87234,452.8829787,128.5638298,1762.255319,10670.37234,2080.93617,537.3085106,2781.744681,9385.617021,734.3404255,248.0957447,1666.43617,7652.606383,1481.893617,397.7446809,1338.393617,5434.478723,1002.021277,152.106383,2549.191489,4809.425532,1225.914894,276.6808511,3211.468085,842.6170213,557.5106383,94,12.62645599,9.525474974,0.65640802,0.959183673,0.723076923,-0.406680668
+2480,50352.06767,939.3157895,564.1428571,1148.834586,37159.71429,802.2406015,653.2030075,1777.030075,18973.49624,498.8571429,908.6616541,1836.586466,27726.05263,1266.766917,8570.421053,3764.338346,10424.13534,1322.225564,350.1428571,2420.496241,19484.63158,1173.729323,124.9172932,1289.984962,23703.6391,431.0827068,154.6466165,5095.473684,19027.7218,2060.556391,515.7142857,2818.293233,15339.21053,610.7593985,281.4736842,1991.165414,10811.69173,871.9699248,410.6616541,1304.661654,5632.285714,609.4586466,157.0977444,2735.398496,5844.015038,1231.879699,237.3082707,3215.112782,1074.488722,557.1052632,133,14.54238191,12.13371443,0.551206103,0.93006993,0.738888889,-1.428769198
+2481,35537.72826,821.5543478,486.3804348,1095.152174,32951.38043,680.0543478,774.3478261,1745.51087,14764.55435,479.423913,1361.206522,1774,23440.6087,1219.98913,11175.6087,3217.173913,8642.380435,1273.684783,341.5543478,2763.086957,16794.23913,6675.076087,142.8152174,1464.206522,20527.80435,503.8804348,134.4891304,4621.967391,15799.34783,2337.913043,442.4565217,2816.934783,12469.43478,715.673913,266.4456522,2021.586957,8667.73913,998.5978261,397.6413043,1295.163043,4412.271739,601.7608696,150.4891304,2586.586957,4804.543478,1162.880435,250.826087,3270.880435,1102.032609,555.6956522,92,11.20471562,10.68516188,0.30097891,0.978723404,0.696969697,-0.688639938
+2482,45972.71774,919.6854839,631.8709677,1182.725806,41521.68548,726.6048387,619.2741935,1847.330645,20701.81452,556.4516129,541.6209677,1780.362903,27959.3871,1302.604839,10492.62097,7513.596774,10751.55645,1403.862903,390.0725806,2416.596774,21586.49194,452.6209677,552.4677419,460.6451613,26318.85484,458.7741935,135.7580645,9097.258065,19100.72581,1569.096774,631.5403226,2811.145161,16118.80645,617.1048387,320.4274194,5952.564516,9957.798387,860.8145161,433.483871,1313.290323,7546.91129,726.4596774,170.8145161,3226.435484,6427.758065,1313.290323,190.4354839,3324.693548,157.7096774,558.483871,124,19.62763486,8.507110805,0.901189564,0.905109489,0.459259259,-0.903744505
+2483,59651.59868,971.3881579,620.7828947,1187.217105,52016.27632,728.8552632,605.0131579,1794.052632,27432.09211,562.7368421,521.5328947,1742.144737,36519.92105,1327.098684,6718.855263,5415.388158,13827.75,1433.085526,388.6776316,2406.401316,28172.46053,464.5789474,152.3157895,435.7960526,34605.33553,440.4605263,136.2039474,6098.269737,25617.61842,1576.618421,586.5197368,2825.802632,21594.78947,624.9802632,334.7302632,6617.657895,14155.01974,851.6644737,463.6907895,1312.013158,10717.03947,649.0263158,180.2894737,2578.881579,9018.815789,1360.671053,242.4210526,3320.263158,170.9013158,558.1184211,152,18.91427123,10.79359666,0.821187222,0.853932584,0.533333333,-0.985673149
+2484,58298.5873,949.3333333,566.6507937,1144.206349,52413.8254,753.3492063,648.7301587,1774.539683,29333.92063,597.6349206,526.3333333,1790.587302,38319.4127,1371.746032,7856.285714,5868.984127,14285.52381,1481.285714,402.7142857,2341.126984,28505.66667,475.0634921,445,425.4126984,34940.57143,448.3809524,140.8730159,5738.603175,27109.71429,1584.52381,614.7460317,2807.698413,22766.63492,655.6190476,335.1428571,4104.063492,16029.87302,907.0793651,479.4444444,1314.746032,11470.60317,737.4285714,182.5079365,2777.460317,10102.33333,1434.68254,207.9206349,3318.380952,198.8730159,555.5714286,63,10.26279083,8.337271461,0.58313038,0.940298507,0.63,-1.027139104
+2485,52824.19118,928.5735294,607.0294118,1129.264706,50803.67647,744.1176471,721.1176471,1799.735294,26917.79412,616.2352941,613.4264706,1797.911765,35556.89706,1363.867647,7617.823529,6018.838235,13570.55882,1473.132353,394.4411765,2863.911765,27205.23529,482.1176471,1298.926471,528.8235294,32878.97059,459.8970588,139.7058824,6241.132353,25323.94118,1779.073529,743.2794118,2803.058824,21386.63235,635.8529412,321.5294118,4082.382353,15369.63235,946.8235294,469.3529412,1317.926471,11316.32353,946.9411765,185.6764706,3481.808824,9730.088235,1446.382353,190.7941176,3307.676471,206.6470588,557.9852941,68,11.1098039,9.022153114,0.583533147,0.819277108,0.515151515,-1.126220979
+2486,14133.95238,1032.142857,608.9142857,1045.504762,15139.89524,708.247619,450.2952381,1419.514286,7001.219048,551.847619,521.8190476,1774.780952,9034,1180.07619,6031,5011.761905,3675.990476,1229.133333,311.3238095,2358.390476,7549.485714,380.647619,1145.590476,429.5619048,8330.285714,427.1428571,113.1142857,4268.219048,6172.4,1429.380952,653.2952381,2778.761905,5635.657143,589.7142857,235.6761905,2324.580952,4262.571429,741.7047619,378.1619048,1312.295238,3461.209524,857.2,157.9238095,5303.466667,2804.971429,1130.942857,340.6380952,3440.095238,305.2285714,561.6285714,105,21.11879506,6.76270526,0.947342491,0.826771654,0.403846154,-0.433955447
+2487,39421.27273,1313.436364,611.1272727,1121.363636,37409.23636,895.4363636,888.0909091,1666.090909,19299.07273,696.1454545,1582.254545,1790.218182,26594.4,1502.290909,3735.054545,4219.8,8846.763636,1468.290909,373.7818182,2568.272727,19175.21818,724.5818182,184.6,746.7272727,22267.54545,1170.927273,207.4909091,3163.818182,16680.21818,1711.981818,761.6363636,2831.418182,14822.05455,649.2,317.3636364,1554.290909,10901.85455,1034.254545,456.7818182,1341.127273,9014,651.1272727,180,3502.490909,7781.454545,1409.963636,205.6181818,3469,369.2181818,556.2181818,55,12.24949586,6.125149341,0.866006483,0.901639344,0.509259259,-0.908126888
+2488,45447.83077,1000.446154,527.6,1129.338462,41180.75385,830.2307692,785.2461538,1659.815385,23072.70769,622.0615385,647.9846154,1789.692308,31370.38462,1500.061538,2651.276923,3654.861538,11366.89231,1558.830769,401.1230769,2448.307692,20012.35385,551.3692308,594,506.5384615,24911.70769,534,137.4,3692.753846,19504.70769,1754.907692,919.8153846,2813.415385,17228.04615,801.4307692,326.4615385,2079.107692,13630.66154,1031.369231,496.4615385,1404.107692,10376.27692,819.6,193.0615385,7575.8,9329.476923,1510.138462,156.1076923,3365.892308,378.2615385,557.1384615,65,9.690724575,8.746659842,0.430520952,0.942028986,0.65,-0.791055015
+2489,32742.0101,1050.691919,545.479798,1103.005051,28393.77273,745.020202,1003.116162,1598.363636,16027.17677,609.2222222,1014.454545,1815.717172,21991.65152,1357.035354,4277.025253,3796.944444,7626.853535,1386.313131,356.6313131,2431.444444,15552.57576,459.3232323,461.1767677,2285.383838,18067.38384,427.2373737,129.3535354,2767.171717,13625.07576,1831.141414,714.5,2805.873737,12180.06061,600.9090909,281.5707071,1491.984848,9590.308081,1631.414141,445.8333333,1304.767677,7520.070707,913.7727273,171.6313131,2812.929293,6674.767677,1355.050505,183.1212121,3496.863636,505.9747475,561.2878788,198,20.25379867,12.57554846,0.783891156,0.965853659,0.647058824,-0.648454955
+2490,35515.18103,959.8706897,535.5387931,1096.465517,30845.99138,754.8146552,793.9612069,1576.099138,18200.72414,684.6896552,989.3146552,1779.75,24601.62069,1374.318966,4125.426724,3653.801724,8397.474138,1415.327586,361.3405172,2495.948276,17857.02586,474.387931,367.0086207,793.7586207,21107.72414,818.2025862,129.4482759,3237.75431,16351.48276,1622.107759,739.7327586,2812.193966,14227.07759,678.4396552,296.25,1904.099138,11429.89224,1207.560345,461.3965517,1343.715517,8820.905172,724.8965517,177.4439655,5054.150862,7758.012931,1404.215517,339.4008621,3330.008621,549.8017241,565.1508621,232,19.81073786,16.34931568,0.564730401,0.856088561,0.555023923,-0.302458775
+2491,42387.98065,880.8258065,539.3548387,1115.16129,38795.8,718.5935484,849.116129,1729.490323,20691.39355,524.0645161,2231.032258,1782.387097,29813.90968,1276.729032,7171.116129,5526.219355,10639.45161,1319.522581,362.2129032,3463.851613,20563.63871,746.2774194,269.116129,1876.664516,25562.95484,477.8645161,411.8645161,3233.948387,19788.44516,2356.283871,577.0451613,2956.877419,16491.25806,945.6387097,287.1483871,3446.870968,12157.92258,1568.883871,430.0580645,1322.006452,7914.225806,703.9870968,166.2645161,2970.477419,7112.406452,1290.316129,250.9806452,3254.8,989.8580645,561.6322581,155,17.8828889,11.25367672,0.777163617,0.93373494,0.679824561,-0.186014607
+2492,58888.21569,1004.823529,594.6078431,1164.156863,56392.21569,787.9215686,656.7843137,1821.823529,29813,561.0588235,512.4509804,1708.764706,43775.62745,1413.019608,6858.764706,4573.078431,15736.88235,1534.039216,408.3137255,2398.627451,30812.4902,505.1176471,156.8039216,522.1568627,38473.35294,475.3137255,148.3137255,4303.588235,29288.90196,1588.941176,506.8627451,2853.627451,23968.96078,652.3137255,325.9215686,3256.784314,17844.88235,908.2941176,457.4117647,1322.921569,10380.88235,666.0196078,173.6666667,1675.490196,9818.27451,1399.941176,134.9607843,3363.058824,1032.882353,557.9607843,51,10.50244817,6.327776746,0.798115164,0.927272727,0.579545455,0.422556867
+2493,34530.75694,858.5555556,598.3055556,1111.631944,32055.86806,700.6388889,652.5347222,1641.75,17864.27778,547.9027778,537.9027778,1779.576389,23688.65972,1276.319444,8311.284722,6416.791667,8844.270833,1348.381944,355.2013889,2385.173611,17834.125,452.4722222,276.1736111,447.9375,21737.39583,441.1736111,132.25,6016.25,16290.0625,1487.784722,1090.861111,2833.784722,14203.6875,680.0902778,304.9097222,4196.993056,10553.75694,875.7222222,446.2013889,1318.409722,8189.076389,695.4097222,178.6944444,6082.222222,7078.222222,1368.986111,314.3194444,3333.006944,265.0208333,560.9722222,144,18.4254151,10.91056112,0.805829691,0.872727273,0.533333333,-0.983867969
+2494,52818.95327,1028.056075,569.4672897,1135.934579,49016.1028,812.1401869,746.1588785,1753.28972,26987.16822,630.8411215,513.364486,1811.17757,35596.50467,1439.018692,7292.242991,4366.738318,13028.57009,1525.28972,395.7196262,2387.925234,26881.85981,508.411215,164.1028037,467.3925234,32986.17757,488.1495327,140.0934579,4685.542056,25094.63551,1624.121495,691.1775701,2830.308411,21789.04673,658.3738318,335.2616822,1864.728972,16294.95327,943.0560748,489.5327103,1317.560748,12536.80374,696.411215,195.4485981,3458.607477,10950.41121,1532.495327,141.3084112,3405.065421,283.364486,559.0654206,107,16.22603084,9.301711943,0.819374494,0.8359375,0.572192513,-1.46203812
+2495,43686.21138,1082.617886,601.2601626,1415.170732,38441.42276,794.1626016,755.5853659,2264.878049,21996.91057,671.3414634,878.4552846,1832.04878,29468.99187,1427.439024,4106.813008,3151.300813,10359.73984,1482.203252,381.0162602,2535.674797,21581.45528,468.398374,215.3739837,538.2682927,25219.68293,494.2845528,136.0081301,3216.544715,19208.18699,1773.300813,692.9186992,2815.788618,16921.28455,637.3577236,314.804878,1460.195122,13404.18699,1122.178862,463.4878049,1318.414634,10273.01626,675.5284553,171.1788618,2957.902439,9194.308943,1422.707317,200.5772358,3450.666667,485.7723577,561.1707317,123,18.66805616,9.418716417,0.863390342,0.836734694,0.525641026,-1.203560883
+2496,36837.06667,987.0888889,504.2444444,1101.044444,33531.28889,797.0888889,554.7666667,1595.577778,19682.14444,602.5666667,993.6333333,1758.211111,26869.34444,1536.922222,2675.411111,2259.055556,9102.444444,1368.377778,374.5666667,2383.2,17708.88889,505.3888889,169.6333333,608.2333333,21514.08889,431.4888889,165,1848.388889,16135.04444,1755.466667,604.3111111,2819.9,14629.34444,658.7111111,292.3666667,1889.744444,12211.34444,1490.511111,438.7111111,1312.055556,9396.322222,667.7666667,174.4888889,2045.544444,8007.133333,1599.5,2445.044444,3135.2,681.0555556,560.4333333,90,17.17091342,7.13483744,0.909584588,0.891089109,0.461538462,-0.670935971
+2497,49776.5625,945.96875,556.984375,1149.15625,45375,758.578125,829.96875,1804.171875,25364.59375,538.953125,577.3125,1765.21875,34878.15625,1345.65625,5925.859375,5210.046875,12511.60938,1385.71875,381.921875,2496.375,24374.35938,477.203125,331.671875,1209.09375,29784.15625,453.953125,138.953125,4611.734375,23417.59375,1763.4375,656.4375,2805.9375,19461.79688,658.875,297.578125,2683.46875,15091.10938,1019.65625,466.34375,1317.078125,10024.23438,692.6875,165.0625,2446.921875,8699.78125,1397.15625,189.96875,3315.6875,940.890625,557.765625,64,11.66433435,7.339822326,0.777200185,0.927536232,0.581818182,0.780454889
+2498,44723.55238,894.1714286,584.4190476,1138.409524,40944.97143,741.0857143,644.7619048,1750.438095,19467.02857,501.4571429,1864.161905,1834.533333,29800.44762,1292.133333,10448.53333,3634.552381,10916.53333,1358.019048,355.6380952,2563.52381,20979.74286,591.1333333,133.4190476,1960.095238,25924.6381,453.8190476,908.4952381,4355.095238,19987.88571,2153.485714,472.7047619,2801.580952,16006.01905,626.6,284.4761905,2455.104762,11295.8,975.4095238,404.7333333,1297.171429,5793.790476,601.2190476,157.5142857,3137.171429,6117.257143,1229.038095,666.4190476,3334.342857,1089.019048,559.6666667,105,13.59341193,10.62375362,0.623858963,0.913043478,0.625,-1.167580143
+2499,47848.85246,890.3934426,536.0655738,1140.081967,45424.55738,772.147541,829.2704918,1706.704918,25354.15574,589.0163934,1383.393443,1896.131148,33119.77869,1353.254098,7348.139344,5750.942623,12377.2377,1440.516393,379.5245902,2647.090164,25112.31967,501.9918033,153.8770492,1364.540984,30588.01639,449.4344262,668.5,3355.360656,22909.97541,1988.614754,741.8278689,2830.57377,20182.93443,645.442623,324.5491803,1873.893443,14694.45902,1032.696721,479.1311475,1314.868852,11238.05738,657.5,182.5409836,3038.47541,9672.254098,1426.778689,247.2377049,3258.778689,243.704918,561.9098361,122,15.17802741,11.75038087,0.632977138,0.897058824,0.580952381,-1.247076352
+2500,28045.40476,886.3452381,473.4880952,1052.892857,23543.46429,709.3690476,391.0833333,1468.130952,14099.92857,528.5952381,460.25,1713.630952,19151.02381,1410.261905,1032.285714,1206.857143,6647.27381,1335.011905,338.9047619,2404.083333,13089.41667,464.2738095,102.9285714,517.047619,15203.35714,518.4880952,125.5833333,928.452381,12051.72619,1398.904762,616.3333333,2813.428571,10799.25,627.0714286,266.5,1777.47619,8546.464286,947.6904762,412.3809524,1310.02381,6922.059524,618.047619,163.3333333,1113.964286,6009.107143,1502.678571,3892.964286,3110.797619,622.1666667,562.1309524,84,12.71115412,9.471417008,0.666923226,0.913043478,0.587412587,-0.133667047
+2501,37160.97297,817.8648649,453.1891892,1069.148649,32097.2027,684.027027,694.7702703,1548.486486,19145.63514,536.5,1739.635135,1811.581081,26281.40541,1305.945946,4512.040541,3735.77027,9335.148649,1292.675676,345.9459459,2360.378378,19131.24324,460.1081081,346.6756757,955.6756757,23377.59459,947.3108108,122.7972973,1956.824324,17453.09459,1410.405405,583.1081081,2807.486486,15731.17568,633.5540541,281.5810811,1817.72973,12796.95946,1576.486486,419.4864865,1310.702703,9323.094595,721.6486486,163.7432432,3524.608108,8255.797297,1384.621622,583.3783784,3244.662162,723.1351351,559.527027,74,10.92472429,9.242705709,0.533126399,0.913580247,0.560606061,1.107424347
+2502,22880.8,833.1363636,710.5090909,1094.036364,22425.25455,663.4181818,609.9363636,1611.8,11715.30909,497.6272727,520.2363636,1731.736364,17326.6,1196.390909,3409.745455,2099.081818,5927.536364,1212.327273,329.7727273,2395.245455,11539.9,8910,942.7,680.1909091,13876.75455,499.1909091,127.7272727,3694.109091,10412.3,1532.436364,490.0454545,2849.345455,8936.545455,1284.290909,245.3181818,1656.754545,6970.518182,967.1,392.2545455,1318.963636,5081.190909,847.9363636,155.7454545,4116.263636,4170.736364,1171.845455,378.4636364,3279.772727,887.2454545,563.1363636,110,16.10489176,10.03394562,0.782192258,0.814814815,0.539215686,-0.35272512
+2503,48672.13714,941.6971429,569.12,1166.062857,45184.93143,742.2057143,639.2342857,1809.36,23695.85143,525.5885714,509.1314286,1758.177143,34675.85714,1334.554286,6053.948571,3814.268571,12602.12571,1389.125714,372.7142857,2472.8,24355,925.4514286,206.3371429,486.04,30111.64571,477.1314286,135.9542857,4576.308571,23175.11429,1605.84,543.2228571,2815.32,18942.91429,652.4571429,298.2285714,3839.742857,13691.56571,862.4685714,426.7942857,1307.685714,7621.834286,754.12,166.1428571,3489.577143,7440.062857,1305.44,175.5942857,3300.097143,1050.537143,562.48,175,17.41883534,14.62859194,0.542873342,0.841346154,0.571895425,0.688595599
+2504,35136.06849,1066.041096,508.7534247,1103.534247,31719.5274,774.4726027,613.7465753,1552.10274,17903.06164,611.4041096,743.1164384,1745.445205,23914.69863,1453.59589,2554.575342,2417.643836,8568.130137,1484.958904,378.4452055,2436.267123,18730.29452,1353.178082,209.6712329,628.7260274,20078.41096,765.3561644,216.9931507,2296.452055,15638.06164,1660.075342,654.2808219,2855.671233,14099.69178,685.7534247,322.5616438,1343.568493,10767.12329,1018.547945,473.7671233,1315.267123,8021.561644,665.0616438,179.390411,3339.027397,7217.945205,1453.30137,212.6986301,3383.205479,358.0273973,565.4452055,146,20.79207831,9.497619355,0.889574413,0.85380117,0.463492063,-0.477295649
+2505,40744.38462,922.2417582,575.967033,1129.076923,30289.25275,657.8571429,638.9010989,1551.10989,17114.40659,496.1648352,433.1648352,1692.483516,23986.79121,1212.901099,4945.626374,3042.857143,8372.131868,1256,329.021978,2384.384615,17066.27473,771.9340659,368.1318681,479.1318681,20105.48352,439.5934066,124.8131868,6725.582418,15692.57143,1392.659341,687.3736264,2816.692308,13823.59341,617.2857143,259.4285714,2156.593407,10614.52747,860.8021978,409.7252747,1301.681319,7510.021978,683.4725275,162.7802198,4489.813187,6325.417582,1207.67033,227.0879121,3286.274725,878.4725275,560.1318681,91,12.61968812,9.683586622,0.641240919,0.947916667,0.636363636,-0.907794466
+2506,45658.62021,973.3240418,638.28223,1160.212544,39386.64808,757.9442509,639.4041812,1785.735192,21812.61672,540.3972125,484.6864111,1742.672474,30807.17073,1350.696864,5659.947735,3981.195122,10602.93728,1365.15331,372.8675958,2427.909408,21278.87456,485.2961672,1212.275261,571.0522648,25808.29965,455.6689895,136.7700348,4631.456446,20184.30314,1600.885017,637.7142857,2814.916376,16830.85017,649.0418118,299.9721254,3865.149826,12762.71777,921.0034843,448.4843206,1329.484321,8522.662021,952.912892,173.5958188,3296.940767,7484.557491,1360.163763,410.7665505,3299.756098,951.8954704,567.6585366,287,21.17877815,17.78493728,0.542968979,0.891304348,0.621212121,-0.564618257
+2507,47221.93785,910.6723164,554.6440678,1126.474576,39707.9887,729.3107345,731.5819209,1752.836158,22084.85311,531.0225989,1088.282486,1734.519774,31292.30508,1298.310734,6837.491525,5183.898305,11074.9774,1335.468927,352.7118644,2999.344633,22010.12994,469.0960452,194.8022599,787.5423729,26838.29944,454.6384181,139.5028249,4515.553672,21281.82486,1904.129944,599.519774,2810.717514,17750.76271,639.9435028,293.3728814,3545.734463,13197.43503,1017.485876,433.8361582,1312.757062,8603.338983,708.8870056,167.7175141,2860.435028,7804.039548,1311.271186,225.6214689,3234.423729,978.8757062,565.1412429,177,20.11657606,11.97360267,0.803569625,0.842857143,0.680769231,-0.125465227
+2508,51667.98718,915.7435897,571.1153846,1160.282051,47214.62821,706.6410256,563.0384615,1673.192308,24193.19231,559.3589744,495.6794872,1786.102564,31837.94872,1326.846154,6787.089744,4666.5,12154.61538,1406.115385,376.9871795,2356.628205,24770.0641,443.6153846,150.5897436,425.5128205,30344.80769,447.8589744,137.1923077,6932.012821,23004.82051,1531.538462,667.3333333,2812.320513,19685.02564,646.6923077,315.6025641,4753.410256,13587.5641,845.7692308,459.8333333,1301.166667,10026.85897,650.474359,174.525641,2897.666667,8559.512821,1382.128205,275.9102564,3298.051282,191.3974359,561.0641026,78,11.69100966,8.677059682,0.670179182,0.928571429,0.65,1.239654792
+2509,50057.41633,913.4612245,572.1387755,1154.093878,49352.30612,773.9142857,729.1387755,1801.485714,26898.25714,599.7020408,594.0163265,1812.583673,34982.23673,1381.489796,7749.346939,7415.379592,13094.00408,1470.065306,387.3591837,2392.616327,26537.40408,496.1755102,153.0530612,653.555102,31970.40408,452.1183673,167.0734694,4906.6,23986.52245,1614.583673,685.477551,2832.608163,20795.4449,650.2571429,335.3265306,2725.710204,15220.91429,932.1306122,481.4367347,1315.885714,11216.46122,672.3755102,182.9755102,3387.069388,9648.020408,1456.677551,181.7714286,3304.432653,228.1755102,565.7346939,245,21.97617635,14.6936069,0.74360852,0.924528302,0.68627451,-1.084918034
+2510,34748.77204,943,540.8723404,1099.987842,32352.07599,774.1793313,758.5075988,1613.349544,18535.22188,594.1489362,1368.778116,1815.848024,24819.90274,1399.966565,3561.300912,3643.534954,8814.75076,1422.100304,374.8966565,2421.361702,17180.99392,455.5045593,340.6869301,929.6291793,20200.96657,437.1975684,356.2340426,3179.990881,15450.9848,1740.881459,749.7112462,2816.49848,13973.59271,754.7021277,305.3890578,1659.680851,10757.78723,1278.556231,473.9179331,1332.462006,8477.577508,711.3981763,184.2583587,3834.164134,7589.638298,1466.176292,1168.796353,3342.87538,433.3920973,565.5896657,329,26.43869423,17.77501159,0.740269275,0.847938144,0.553872054,-1.239598278
+2511,16093.47525,810.4950495,461.6237624,1092.178218,14264.69307,638.3564356,425.6534653,1449.455446,8003.50495,493.0594059,482.8712871,1720.891089,11557.17822,1233.683168,1501.069307,1029.80198,4257.148515,1180.346535,330.2277228,2355.920792,8310.762376,416.039604,114.8019802,488.0891089,10276.9505,416.5742574,114.4554455,929.2277228,7516.415842,1293.316832,516.8910891,2801.663366,6814.613861,601,244,1515.782178,5812.138614,828.5445545,385.4851485,1304.247525,4216.19802,613.1782178,152.3564356,1604.910891,3824.950495,1305.673267,2246.277228,3165.960396,732.6039604,563.1188119,101,12.60195911,10.45687801,0.558087754,0.935185185,0.647435897,-0.41997819
+2512,55403.65217,947.6086957,533.9130435,1144.23913,49612.08696,782.9347826,641.3913043,1730.521739,28327.5,627.3913043,538.7173913,1763.956522,37694.47826,1405.086957,5144,3712.173913,13080.17391,1528.434783,393.2608696,2381.456522,27686.67391,502.1956522,229.4347826,435.0869565,33476.93478,462,140.3043478,3661.434783,26847.71739,1612.543478,685.4130435,2821,23507.34783,669.173913,344.7608696,1969.608696,17236.6087,917.1086957,498.5217391,1318.021739,12921.1087,708.2173913,187.7608696,3168.956522,12088.23913,1531.456522,295.3043478,3469.065217,297.7173913,561.7173913,46,9.653089001,6.093576319,0.775574034,0.978723404,0.638888889,-0.860143313
+2513,22732.79798,850.2020202,600.8787879,1084.080808,19848.26263,679.969697,454.2626263,1489.333333,11741.25253,516.8181818,415.010101,1699.767677,15885.78788,1326.606061,2472.777778,1745.707071,5684.363636,1234.606061,327.969697,2375.131313,11853.9899,461.0606061,201.8888889,481.5555556,14127.94949,409.6464646,120.3636364,1683.090909,10752.33333,1343.484848,574.9494949,2805.030303,9677.282828,635.1919192,275.4040404,2052.323232,7964.959596,910.3333333,409.3939394,1313.464646,5930.525253,656.1818182,161.6161616,1925.010101,5281.878788,1397.535354,803.989899,3114.878788,693.1515152,563.3030303,99,12.07815902,11.37775217,0.335583503,0.925233645,0.634615385,0.239823122
+2514,33172.19753,863.2222222,460.1728395,1085.098765,29408.49383,706.7901235,728.8888889,1563.493827,17126.81481,539.382716,1261.493827,1742.654321,22688.66667,1311.407407,3731.111111,2785.234568,8184.54321,1300.444444,341.7283951,2604.308642,16989.59259,2297.580247,361.3703704,614.9382716,20706.38272,434.9876543,129.7407407,2010.160494,15522.83951,1545.148148,625.3333333,2789.395062,13713.16049,641.617284,285.0617284,1865.185185,11193.41975,1543.679012,419.3950617,1343.037037,8303.345679,703.4444444,165.5925926,4619.938272,7075.197531,1409.382716,514.0617284,3775.185185,755.5679012,564.4938272,81,11.74386244,9.042145898,0.638108433,0.931034483,0.623076923,0.188325934
+2515,40414.245,938.475,599.2,1123.325,35875.955,744.94,777.06,1709.855,19692.415,531.66,1053.53,1844.765,27218.725,1344.475,4712.45,4173.06,9596.96,1345.39,376.135,2495.24,19038.205,492.255,1351.165,992.1,23069.89,586.905,138.25,2892.135,17679.585,1968.675,634.395,2839.465,14865.265,730.945,289.87,4063.925,11343.61,1067.56,439.77,1361.615,7809.525,997.175,172.985,3646,6730.455,1369.955,715.97,3325.33,935.065,568.02,200,20.72239306,12.59954071,0.793924988,0.961538462,0.699300699,-0.048032023
+2516,38658.51438,862.6741214,572.3290735,1122.642173,31895.54952,693.7316294,539.9872204,1702.019169,14930.11821,474.3546326,890.2076677,1776.389776,23076.92332,1191.447284,11555.55591,4601.348243,8439.536741,1246.367412,328.9680511,2396.089457,16177.48562,545.1214058,149.7507987,994.7060703,19342.89776,421.3610224,144.5782748,9757.051118,15330.08946,1704.750799,635.9488818,2799.316294,12225.95208,611.14377,262.1405751,2828.140575,8371.460064,902.3578275,382.4888179,1289.709265,4156.428115,584.2460064,153.2811502,5055.964856,4516.837061,1143.5623,344.3099042,3212.699681,1096.600639,570.6070288,313,24.17597562,17.12632635,0.705808485,0.889204545,0.59168242,-0.927254025
+2517,57901.02419,951.0887097,567.1048387,1181.33871,56663.14516,808.3225806,735.1774194,1884.153226,30934.71774,629.4596774,528.4758065,1778.725806,40797.8629,1457.217742,7332.475806,5428.16129,15994.1371,1572.145161,418.0080645,2373.096774,30868.56452,513.2016129,164.5,441.4032258,38875.41129,481.1532258,143.3467742,5381.91129,29202.75806,1666.475806,691.8709677,2824.233871,24533.81452,672.5725806,353.8387097,3799.346774,16366.77419,903.8709677,491.6129032,1312.451613,12082.95968,682.8064516,189.6532258,2526.935484,10340.17742,1491.580645,198.5483871,3344.629032,177.5483871,565.0483871,124,17.93200687,8.888946438,0.868492205,0.946564885,0.561085973,-1.09045466
+2518,54652.85714,962.6122449,530.1428571,1145.22449,50872.97959,795.3469388,901.4081633,1736.204082,28215.55102,603.5714286,510.4489796,1772.979592,37562.95918,1426.102041,6318.22449,3086.979592,13459.93878,1506.77551,401.0408163,2381.836735,28709.04082,503.4081633,372.4489796,435.877551,35572.44898,461.5714286,138.7142857,4202.77551,27226.34694,1638.163265,755.4081633,2872.714286,23519.97959,663.9795918,339.755102,1675.428571,17841.42857,944.1632653,506.7755102,1308.571429,13483.22449,739.6530612,191.3469388,2240.306122,11699.28571,1506.102041,158.9591837,3419.244898,273.8367347,563.4489796,49,8.711974053,7.414870774,0.524983204,0.960784314,0.604938272,-0.88415842
+2519,29049.4,936.5545455,523.8060606,1077.584848,26508.26364,833.530303,869.5939394,1574.506061,14985.72424,569.3878788,1393.445455,1841.884848,19926.57273,1338.451515,4747.090909,2919.172727,7129.027273,1452.193939,380.7,2490.484848,14583.41515,1705.790909,1750,622.2333333,16691.68182,443.6181818,480.430303,2677.975758,12824.11212,1979.633333,675.2363636,2828.030303,11443.26667,778.1969697,292.6333333,1453.275758,8704.472727,1039.715152,449.0909091,1365.872727,6717.306061,1110.742424,175.5636364,3893.542424,6122.469697,1398.172727,209.6090909,3300.039394,338.2060606,572.2424242,330,28.64247768,16.01214491,0.829144119,0.870712401,0.589285714,-0.497978614
+2520,55247.28,1103.626667,564.7333333,1177.293333,50078.13333,871.1333333,805.0266667,1771.44,29339.92,682.32,711.2266667,1753.506667,39927.37333,1584.8,3764.933333,4472.706667,14354.08,1626.333333,429.3333333,2419.36,26715.89333,905.3733333,297.3333333,560.9466667,31728.30667,549.24,228.7066667,3888.826667,25390.42667,1896.786667,921.52,2816.2,22574.73333,700.2933333,369.2933333,1924.4,17645.37333,1064.746667,520.52,1337.28,13121.81333,735.72,204.9733333,4018.653333,12017.61333,1653.24,160.1466667,3477.693333,371.3333333,563.8533333,75,11.53771286,8.66636562,0.660150042,0.925925926,0.524475524,-1.365253681
+2521,29722.66463,879.2012195,507.4512195,1085.579268,25850.09756,702.2439024,745.1890244,1511.902439,14778.14024,574.4634146,1341.554878,1757.304878,19774.48171,1359.841463,2779.567073,4149.689024,7292.670732,1344.969512,357.8353659,2548.231707,14796.17073,498.054878,573.195122,898.0731707,17607.75,462.6646341,142.2865854,1660.987805,13356.33537,1956.969512,756.7378049,2819.25,11714.40244,662.3597561,295.4329268,2086.963415,9327.164634,1476.628049,445.0609756,1325.847561,7380.420732,937.0060976,175.3414634,2856.554878,6357.719512,1581.865854,14374.06098,3296.262195,577.1402439,565.5304878,164,15.25559932,13.90246694,0.411737317,0.942528736,0.728888889,-0.107654915
+2522,36525.68345,830.1223022,517.7841727,1088.834532,32280.39568,693.3597122,722.3669065,1565.230216,18684.26619,539.9928058,1517.395683,1771.546763,26375.07194,1262.086331,6351.553957,4549.28777,9125.956835,1292.330935,336.7266187,2746.179856,18819.1223,455.8273381,657.0935252,1141.669065,22401.81295,886.1007194,179.4172662,3152.52518,16847.30216,1949.863309,539.6330935,2801.064748,14799.2446,626.0719424,268.4964029,2098.359712,12127.10072,1306.467626,405.3884892,1309.654676,8531.618705,829.2589928,162.5611511,4594.877698,7477.223022,1308.158273,344.5251799,3246.733813,812.2230216,564.7625899,139,19.12905259,9.752718875,0.860270401,0.896774194,0.594017094,-1.092262758
+2523,30310.59036,846.5421687,607.1204819,1092.493976,26112.19277,694.1445783,833.6385542,1553.807229,14789.26506,522.7951807,1335.831325,1796.493976,21389.50602,1269.674699,4287.626506,2927.722892,7447.86747,1268.746988,343.1807229,2458.975904,15429.87952,449.4578313,836.2409639,1577.313253,18292.22892,455.4578313,127.4457831,1683.325301,13823.16867,2023.301205,516.0843373,2878.783133,12164.06024,850.0481928,270.2650602,1626.144578,9851.024096,1117.325301,406.9036145,1319.686747,7082.108434,810.3975904,159.626506,2571.421687,6119.445783,1321.156627,1945.168675,3239.433735,852.9759036,562.5903614,83,14.01472965,7.769368204,0.83226926,0.902173913,0.614814815,1.445975942
+2524,33477.19444,899.8402778,522.6666667,1080.611111,29812.86111,699.1388889,631.0486111,1590.875,16051.17361,520.6736111,695.7986111,1758.465278,22310.41667,1242.958333,5759.854167,2576.229167,7770.131944,1257.555556,359.0347222,2419.923611,15208.86111,889.5972222,1378.979167,572.9444444,18062.36806,464.2847222,127.4930556,3081.979167,13965.29861,1587.694444,507.4930556,2781.736111,11614.25694,592.0486111,267.7152778,1877.180556,8812.6875,1175.958333,400.2708333,1339.409722,6299.277778,1002.194444,159.2638889,4655.638889,5253.388889,1231.645833,260.4652778,3324.555556,908.1111111,564.7708333,144,16.30972728,11.79262899,0.690803357,0.941176471,0.65158371,-1.34786884
+2525,28772.46552,840.7456897,535.3146552,1094.185345,25342.57328,692.3318966,723.1939655,1684.969828,10247.59052,482.2586207,1745.892241,1756.547414,17480.98707,1190.331897,7310.956897,3262.551724,6376.206897,1242.715517,348.625,2604.232759,12009.3319,398.2931034,3520.418103,841.7586207,14339.78448,599.7198276,137.3965517,3430.698276,11084.56897,2335.818966,397.1163793,2839.603448,8596.125,666.9310345,249.6163793,1247.107759,5401.573276,899.9741379,375.7413793,1318.771552,2562.431034,1492.456897,148.25,3534.530172,3033.737069,1097.24569,1350.362069,3189.336207,1133.827586,566.7112069,232,25.33564926,13.00205559,0.85827376,0.84981685,0.593350384,1.302335971
+2526,55212.40845,922.2394366,578.5492958,1154.15493,54116.26761,793.8591549,749.0704225,1813.183099,31112.05634,614.3098592,594.4366197,1811.323944,40049.50704,1402.126761,6601.859155,6311.197183,15261.76056,1528.943662,393.8732394,2592.098592,29418.46479,485.3521127,170.971831,521.943662,37135.33803,452.6760563,137.5774648,5966.15493,28673.40845,1696.71831,824.7887324,2848.267606,24376.33803,670.084507,340.1971831,4235.619718,17493.43662,989.2394366,493.3239437,1309.676056,12197.42254,693.3098592,181.5211268,3272.422535,11079.50704,1464.239437,202.7183099,3383.760563,212.4647887,564.7605634,71,10.27019153,8.963627263,0.488112135,0.946666667,0.71,-1.084128533
+2527,40234.90909,933.2272727,587.5795455,1124.420455,37057.57955,748.1590909,925.9090909,1704.147727,20471.21591,585.2727273,606.1363636,1798.045455,27095.82955,1371.659091,7418.272727,5047.056818,9716.397727,1429.920455,376.7613636,2393.102273,20488.77273,561.9431818,230.3977273,511.8181818,24567.32955,543.625,136.0227273,5773.556818,19470.79545,1569.931818,662.3636364,2811.022727,16745.64773,690.8181818,309.1363636,2951.215909,12366.85227,945.4318182,466.7386364,1313.556818,9342.693182,689.6363636,184.125,4946.295455,8457.954545,1453.465909,314.9659091,3404.465909,287.0340909,568.2272727,88,18.29818143,7.196253219,0.919420051,0.846153846,0.407407407,-0.503250991
+2528,42511.05825,992.1359223,547.7572816,1116.951456,39071.60194,801.1165049,612.0776699,1641.718447,22252.17476,615.2718447,611.961165,1781.23301,30168.28155,1480.68932,3111.786408,4205.436893,10855.99029,1503.84466,395.223301,2437.330097,20808.28155,524.592233,461.3495146,561.631068,25369.39806,488.3203883,142.1747573,3769.631068,19638.27184,1721.776699,901.2135922,2822.941748,17296.12621,707.7961165,337.592233,1873.495146,13783.99029,1051.087379,483.9126214,1355.902913,10556.4466,793.038835,198.1067961,7416.019417,9253.524272,1522.165049,227.3106796,3464.504854,382.9514563,565.5048544,103,14.95591495,8.870754999,0.80510901,0.927927928,0.572222222,-0.994471251
+2529,33191.69512,986.5,575.4634146,1084.731707,29675.90244,747.3414634,745.4146341,1565.134146,17222.42683,587,1050.853659,1824.378049,22794.28049,1381.414634,3191.536585,3764.536585,8181.512195,1413.585366,367.4390244,2479.621951,16911.40244,499.4634146,365.5243902,924.5243902,19835.09756,470.7926829,138.5121951,4477.04878,15752.02439,1884.378049,771.5365854,2822.280488,13935.13415,625.4878049,296.6463415,2011.02439,10600.91463,1547.365854,468.5121951,1334.280488,8408,720.9878049,174.195122,4188.853659,7490.54878,1388.865854,140.7682927,3437.243902,399.9390244,564.2317073,82,14.7213727,7.958535972,0.841272696,0.845360825,0.546666667,-1.469813596
+2530,34589.56329,920.3227848,538.056962,1103.139241,31318.22152,720.9177215,715.6518987,1583.253165,18109.17089,561.5316456,616.2341772,1796.113924,23987.82911,1347.367089,4290.879747,3160.126582,8819.829114,1460.21519,365.6772152,2422.43038,18508.70886,480.5696203,384.4746835,636.2341772,21132.65823,442.3291139,137.7151899,4094.670886,16291.48734,1824.810127,799.7278481,2849.493671,14741.87975,679.3227848,312.9810127,1641.778481,11312.41139,1327.196203,471.056962,1347.512658,8855.632911,734.4113924,186.3860759,4933.93038,7808.993671,1426.227848,193.664557,3385.310127,410.4936709,567.221519,158,19.73800966,10.67612446,0.841092285,0.887640449,0.580882353,-0.7261495
+2531,32375.15663,972.5301205,643.686747,1541.53012,27582.74699,746.0843373,737.060241,2455.168675,16386.81928,591.7831325,503.7228916,1836.108434,22588.72289,1404.650602,3682.108434,3633.337349,7546.626506,1415.301205,364.1445783,2426.879518,18013.56627,649.8433735,675.1686747,1863.072289,18416.36145,459.4457831,133.5903614,2718.566265,14348.06024,1585.228916,838.3614458,2820.927711,12590.9759,652.0843373,304.1686747,2018.204819,9975.108434,1162.036145,463.0722892,1333.891566,7504.939759,804.5060241,172.0843373,4173.240964,6915.650602,1459.373494,532.5421687,3536.987952,523.9036145,565.2409639,83,13.20168087,8.264418478,0.779812947,0.943181818,0.532051282,0.880597573
+2532,24674.42276,879.5772358,442.3739837,1077.829268,21487.39837,699.9837398,565.1463415,1458.081301,12619.6748,536.2926829,1170.821138,1721.552846,17423.1626,1383.162602,1412.756098,1765.642276,6231.439024,1289.203252,340.804878,2346.325203,13410.82114,484.4146341,168.9430894,1150.447154,16303.03252,1027.02439,125.2682927,792.2276423,12561.57724,1401.658537,597.8780488,2820.943089,11258.78049,646.9349593,279.3333333,1873.365854,9289.520325,1512.276423,421.4390244,1314.707317,7041.138211,670.7886179,166.8617886,2005.227642,6202.691057,1579.333333,6308.804878,3131.804878,666.3658537,566.495935,123,14.99225214,10.87629445,0.688263261,0.904411765,0.732142857,-0.589724018
+2533,22033.30769,914.2,454.6307692,1028.892308,19386.83077,695.8,407.1692308,1394.292308,11237.64615,531.9538462,412.3384615,1663.6,16570.21538,1364.769231,1708.753846,1347.953846,5827.276923,1239.723077,337.4769231,2351.523077,11807.86154,456.8461538,161.2923077,509.2923077,14329.95385,419.3384615,119.8307692,1346.6,10565.58462,1380.384615,604.2923077,2785.4,9398.815385,669.0461538,266.4461538,1866.907692,7962.184615,897.7692308,404.2461538,1307.769231,6141.861538,636.9230769,158.8615385,1648.707692,5629.846154,1452.907692,2375.8,3064.738462,684.7692308,566.7846154,65,11.81798869,7.607843676,0.765234913,0.915492958,0.601851852,-0.346894851
+2534,31122.95238,821.797619,548.0714286,1093.904762,27523.09524,684.452381,694.4404762,1596.75,16727.63095,530.1785714,861.9285714,1748.619048,22099.63095,1277.916667,5059.72619,3434.119048,7966.392857,1271.25,337.797619,2432.559524,16553.78571,463.8809524,842.3095238,625.8452381,20025.80952,580.8333333,123.0833333,2721.166667,15047.35714,1596.821429,615.4404762,2795.785714,13697.89286,722.452381,276.3214286,2129.654762,11149.57143,1068.25,418.75,1323.892857,8121.761905,885.8214286,162.202381,3382.142857,7284.52381,1368.666667,200.0952381,3269.583333,716.547619,565.8452381,84,10.63451317,10.36532727,0.223571553,0.943820225,0.583333333,-0.41156608
+2535,36670.46392,853.8350515,459.8350515,1086.597938,33097.4433,697.443299,582.7319588,1599.525773,18922.82474,542.4226804,1271.876289,1769.71134,26571.20619,1287.515464,4206.597938,3733.56701,9472.237113,1290.154639,343.2989691,2403.85567,19351.52577,471.5670103,148.5257732,525.3402062,23225.45361,538.1649485,126.6804124,2709.474227,17179.01031,1402.876289,566.3298969,2796.639175,14969.36082,616.1649485,287.8659794,2027.793814,12555.51546,1659.670103,425.5154639,1293.226804,9193.350515,662.185567,172.1134021,6015.278351,7843,1375.381443,415.0515464,3341.639175,777.4948454,566.4123711,97,14.40017938,8.959024768,0.782900648,0.941747573,0.573964497,-0.877239581
+2536,30800.13793,902.7471264,682.9885057,1133.195402,25936.64368,705,604.908046,1727,13136.22989,498.3218391,691.3678161,1732.241379,20420.09195,1278.574713,8291.965517,5052.333333,7497.195402,1275.218391,352.7126437,2548.505747,13774.5977,721.5747126,1432.563218,592.4022989,17386.54023,798.5172414,130.0344828,6432.931034,13212.97701,1686.287356,614.5977011,2820.275862,10786.97701,604.5747126,274.6091954,5237.264368,7852.218391,1030.528736,391.5977011,1317.367816,4264.747126,1050.229885,159.137931,4521.816092,4339.609195,1226.367816,505.4367816,3216.793103,1061.057471,566.7126437,87,11.88013289,9.676070892,0.580198691,0.896907216,0.725,0.279191186
+2537,54735.19048,979.3095238,618.202381,1202.869048,52549.45238,827.0833333,815.0357143,2013.821429,27544.25,628.5119048,548.4880952,1828.404762,37988.35714,1465.357143,9116.02381,8461.285714,14163.78571,1544.72619,418.3452381,2423.25,27391.11905,562.8095238,175.5714286,473.9880952,33919.19048,520.202381,143.5714286,8908.535714,25197.92857,1667,597.9761905,2835.642857,20659.10714,669.0238095,351.8571429,7053.77381,12329.15476,903.452381,484.0714286,1327.75,8814.952381,683.6785714,187.1666667,2720.97619,8136.095238,1453.095238,249.797619,3439.035714,149.5833333,568.1428571,84,13.65141527,8.191824046,0.799946436,0.903225806,0.587412587,0.624622099
+2538,51792.38824,930.2705882,609.5411765,1212.6,56198.95294,807.4117647,640.6352941,2030.658824,28601.43529,609.8,542.2588235,1783.152941,36758.71765,1407.105882,6828.152941,6510.658824,13549.31765,1484.682353,384.5176471,2369.776471,28179.51765,807.6941176,157.1294118,449.5411765,34846.07059,478.7529412,143.8,6354.388235,25312.8,1590.929412,650.2470588,2850.929412,20742.18824,647.2941176,337.1647059,11555.14118,13283.24706,868.2235294,463.4588235,1329.517647,9790.835294,667.1411765,183.8117647,3835.952941,8251.305882,1404.741176,334.2705882,3351.294118,160.1294118,568.1647059,85,12.86436326,8.743079837,0.733549854,0.923913043,0.544871795,-0.685256767
+2539,62286.13953,1003.116279,605.6744186,1184.674419,53909.45349,758.4302326,685.1976744,1795.348837,29860.5,574.2906977,498.9302326,1778.860465,39087.74419,1378.27907,7021.488372,5509.337209,15094.46512,1499.418605,403.3372093,2376.848837,30801.25581,477.4418605,156.244186,422.3953488,37319.0814,451.127907,142.5813953,6393.848837,28232.80233,1602.965116,680.7325581,2826.197674,24085.88372,645.8953488,349.744186,2630.069767,17243.33721,909.0813953,499.6976744,1313.813953,12967.22093,681.4418605,185.0465116,2246.837209,10787.5814,1466.72093,155.1395349,3386.069767,200.7674419,566.5697674,86,12.74158789,8.816574234,0.721942982,0.886597938,0.661538462,-1.214711196
+2540,26076.06383,791.1489362,436.3333333,1055.865248,23489.19858,653.6170213,664.822695,1462.822695,13442.40426,520.4468085,1451.87234,1721.078014,19266.56028,1230.035461,3192.148936,3360.87234,6829.503546,1212.87234,330.929078,2405.609929,13740.99291,2501.93617,425.7588652,593.2340426,17039.2766,514.4680851,121.0567376,1721.198582,12286.99291,1383.751773,554.6099291,2803.212766,10709.66667,646.1843972,255.4042553,1916.723404,8860.085106,1743.567376,396.035461,1290.822695,6699.326241,708.212766,161.5673759,4914.368794,5784.751773,1318.276596,1230.900709,4035.652482,765.3546099,570.0425532,141,14.18770448,13.26281043,0.355147781,0.909677419,0.626666667,0.191818939
+2541,41132.99441,905.4972067,602.7988827,1112.636872,40295.21788,746.1731844,662.1284916,1773.905028,20101.80447,528.2011173,735.9217877,1753.815642,30319.03352,1309.396648,9401.156425,4895.865922,10864.93855,1363.547486,373.027933,2452.351955,20905.36872,490.547486,1181.782123,778.3072626,26307.78771,480.4860335,171.0558659,7543.899441,19474.32402,1817.715084,594.4860335,2808.558659,15698.74302,631.7765363,285.1340782,4031.106145,11312.4581,888.5363128,421.877095,1329.106145,6719.653631,998.8547486,162.575419,4773.519553,6206.938547,1269.96648,244.3798883,3374.541899,1039.195531,569.9273743,179,16.65299594,14.1553057,0.526757576,0.957219251,0.658088235,-1.16461851
+2542,45102.29231,962.5794872,660.4461538,1226.435897,37709.58974,742.2871795,1068.85641,2014.594872,17823.68205,574.8461538,1573.051282,1870.8,24720.44103,1316.969231,10476.06154,6607.517949,9526.271795,1380.317949,370.1897436,5360.517949,18567,1367.974359,167.0102564,982.8564103,21527.17949,523.025641,132.5487179,11178.98974,15478.2,2652.271795,597.5384615,2847.6,12750.07179,602.6974359,307.8871795,7683.005128,7018.994872,982.8666667,430.774359,1326.005128,5315.584615,643.9282051,169.5179487,3626.851282,4620.389744,1249.189744,332.3794872,3310.061538,138.5179487,571.4512821,195,16.93699956,14.93601888,0.471516146,0.942028986,0.601851852,0.745731502
+2543,37540.4023,886.9885057,507.137931,1125.16092,35668.32184,719.2758621,460.4252874,1666.91954,19012.78161,572.9655172,524.9195402,1821.37931,25923.56322,1315.402299,5617.517241,3667.678161,8797.597701,1389.206897,370.137931,2376.666667,19890.48276,514.1609195,690.7586207,456.0574713,22536.27586,437.2298851,133.0689655,3178.666667,17835.36782,1544.114943,687.6666667,2807.91954,15790.50575,658.2528736,315.1149425,1865.068966,11773.65517,850.4597701,453.7011494,1307.448276,8961.413793,818.7586207,179.5862069,3571.068966,8152.298851,1405.252874,188.908046,3315.126437,310.3563218,568.4367816,87,14.09493216,8.261294854,0.810225631,0.925531915,0.517857143,-0.885157648
+2544,33958.47368,890.6491228,511.1403509,1095.491228,31394.4386,712.2280702,687.2105263,1544.929825,18299.24561,568.2105263,601.0526316,1781.175439,24439.75439,1350.052632,3255.122807,3087.894737,8294.929825,1376.912281,357.6315789,2528.140351,18502.92982,445.4736842,312.2982456,522.6666667,20952.92982,462.7192982,129.1052632,2958.403509,16090.24561,1552.175439,739.9298246,2806.578947,14191.38596,622.7192982,290.1578947,1946.473684,11180.84211,933.7192982,446.8596491,1331.964912,8624.368421,730.1578947,177.1929825,4229.807018,7874.087719,1413.368421,304.122807,3318.596491,474.2982456,567.0877193,57,9.468211217,8.089390172,0.519659183,0.95,0.518181818,0.92259204
+2545,36610.96875,870.1979167,469.8541667,1085.885417,31407.21875,708.9270833,564.6354167,1545.020833,19021.59375,549.4375,662.4270833,1750.229167,25135.73958,1340.322917,3081.604167,3114.40625,9182.03125,1308.604167,356.5520833,2511.479167,18680.19792,451.28125,243.5,649.1770833,23107.79167,415.8645833,127.2083333,2859.8125,17378.65625,1606.1875,761.21875,2798.03125,15643.04167,610.71875,290.875,1800.791667,12660.4375,958.15625,430.4375,1301.510417,9120.6875,680.59375,167.2083333,2832.645833,8055.020833,1441.635417,1084.114583,3199.65625,741.21875,569.0520833,96,11.49935733,10.96763815,0.300566168,0.941176471,0.568047337,0.096959202
+2546,48974.38514,939.7905405,643.5608108,1160.648649,46004.74324,779.6756757,773.6081081,1889.236486,22946.06081,533.3581081,557.3648649,1750.175676,33999.60811,1348.033784,7948.75,4938.398649,12241.5,1422.283784,369.5945946,2364.52027,23497.40541,496.5878378,220.722973,525.8243243,29416.18243,543.8783784,141.6621622,7826.689189,22458.5473,1540.662162,715.8716216,2809.905405,18133.91216,646.8310811,298.4256757,4208.371622,12683.97973,863.0878378,429.5,1300.412162,6673.939189,682.7702703,162.4189189,4052.256757,6629.060811,1285.486486,301.3851351,3362.993243,1073.797297,568.8175676,148,15.95865471,12.36479587,0.632204103,0.961038961,0.657777778,0.904322996
+2547,49506.92308,924.9692308,574.2307692,1176.538462,46866.06154,769.4153846,625.6615385,1788.415385,26542.66154,599.0307692,662.8153846,1775,34157.41538,1399.615385,5573.430769,5998.815385,12972.69231,1506.584615,399.7076923,2584.661538,25803.69231,498.2307692,144.7384615,623.2307692,31595.18462,481.6153846,152.7846154,3294.707692,23868.93846,1761.138462,683.2923077,2825.523077,20758.29231,672.9692308,342.6153846,2401.061538,15313.46154,1012.507692,493.2153846,1337.215385,11687.70769,674.5076923,185.7846154,2109.230769,10112.75385,1491.476923,235.7538462,3340.753846,249.8,568.5230769,65,10.66685691,8.395994275,0.61681211,0.928571429,0.590909091,-1.193750008
+2548,32875.17986,880.0215827,576.057554,1109.906475,28775,769.6978417,908.9352518,1590.57554,16811.38849,722.3309353,817.294964,1789,22815.19424,1366.402878,4020.755396,3088.035971,7950.784173,1449.431655,367.8489209,2493.489209,16395.92806,499.2805755,493.1870504,557.5539568,19596.95683,456.8417266,249.2086331,2250.107914,15318.02158,1673.201439,727.4100719,2823.115108,13251.38129,734.3165468,305.6330935,1994.23741,10615.10072,921.8201439,464.6546763,1340.546763,8011.014388,815.5467626,178.971223,4679.956835,7189.899281,1422.431655,399.9280576,3293.194245,563.3741007,570.4964029,139,15.78543986,11.38744857,0.69252969,0.945578231,0.712820513,-1.059912333
+2549,32367.48387,885.4516129,493.4032258,1067.483871,29888.58871,704.0080645,771.7822581,1529.314516,16493.02419,534.9274194,972.1048387,1788.467742,23069.87097,1293.943548,3835.233871,3702.258065,8182,1277.637097,346.9435484,2380.209677,16527.70968,448.9677419,312.7016129,950.9193548,20075.37903,432.4919355,356.1612903,2323.903226,14706.22581,1839.516129,568.0080645,2804.5,12681.79032,618.6129032,270,1926.112903,10725.14516,1087.637097,413.1370968,1309.16129,7765.830645,704.5967742,162.6693548,4945.306452,6594.266129,1332.604839,647.2258065,3250.903226,783.4919355,572.9112903,124,16.87959858,9.98631034,0.806216856,0.946564885,0.607843137,-0.450505817
+2550,41689.44025,896.3584906,567.7106918,1126.893082,32699.96226,666.9622642,883.5471698,1688.603774,17446.48428,501.8993711,1456.496855,1756.062893,25509.25786,1228.748428,7236.358491,4311.641509,8829.616352,1289.943396,335.6603774,4498.09434,17696.57862,602.3081761,1655.176101,705.3333333,21385.93082,426.3962264,127.7484277,4077.226415,16614.40881,2235.949686,560.6918239,2808.754717,13887.55346,633.1698113,267.1383648,2452.132075,10287.01887,1340.025157,408.2327044,1337.176101,7111.509434,1048.710692,162.3584906,4183.345912,6155.075472,1228.660377,269.9433962,3238.36478,966.4716981,570.9874214,159,16.46713617,13.10578022,0.60546111,0.898305085,0.757142857,-0.755845656
+2551,52450.86957,927.7267081,584,1165.304348,50945.3913,763.4037267,623.8695652,1844.590062,26021.75155,594.3975155,524.2919255,1789.434783,34445.50932,1380.608696,6312.956522,8007.416149,13320.25466,1485.037267,384.552795,2370.453416,26760.80745,477.3229814,154.9192547,431.8385093,33180.01863,458.9565217,145.447205,6858.111801,24149.91925,1583.57764,679.7453416,2826.602484,20576.53416,647.6086957,329.8944099,2604.987578,14167.15528,872.9378882,476.2111801,1308.645963,10364.29193,674.6459627,186.5279503,3841.919255,8604.242236,1419.335404,155.4782609,3332.534161,183.8198758,571.9130435,161,23.00073796,9.598938431,0.908754204,0.829896907,0.479166667,-1.100252728
+2552,51913.73333,943.0833333,539.0333333,1151.7,47313.58333,770.2833333,632.6,1819,26888.8,621.0833333,514.6333333,1796,34709.06667,1408.066667,5341.25,5328.566667,12750.76667,1500.083333,382.2,2357.083333,25870.26667,493.7166667,134.75,448.4,31493.4,455.5666667,141.85,3711.65,24238.23333,1589.866667,814.1333333,2854.066667,20854.8,647.8833333,340.5166667,2376.366667,15371.36667,913.1333333,493.9166667,1320.85,11446.26667,681.1,182.1333333,2306.383333,10239.78333,1501.316667,212.8833333,3300.566667,257.9333333,570.3333333,60,10.63980297,7.59905941,0.69993093,0.909090909,0.555555556,-0.075617899
+2553,26335.625,1107.052083,608.71875,1069.53125,25145.1875,735.2083333,543.0625,1534.822917,13301.11458,588.6666667,504.3333333,1750.53125,17580.125,1282.947917,7356.927083,4618.458333,6554.822917,1297.5,332.3958333,2345.989583,13780.84375,427.3229167,139.1458333,430.2916667,16256.5625,411.375,128.75,6684.28125,12445.8125,1444.052083,660.3125,2806.927083,10858.32292,617.40625,270.9791667,1615.53125,8051.34375,786,404.4583333,1292.302083,6174.489583,611.4895833,162.59375,3435.083333,5347.854167,1244.833333,118.25,3391.239583,277.1770833,571.4479167,96,15.84394244,8.401845977,0.847817832,0.857142857,0.527472527,-0.565085624
+2554,36440.42208,863.7142857,546.2727273,1082.909091,34873.52597,693.7272727,673.987013,1606.746753,18695.98701,554.2987013,539.1363636,1761.935065,25390.88961,1288.324675,7356.311688,4276.922078,8922.409091,1342.103896,352.7207792,2392.376623,18956,1073.590909,289.3246753,456.4415584,22501.58442,527.3116883,133.7012987,4457.883117,17589.2987,1490.941558,711.1623377,2824.642857,15354.52597,620.7012987,305.6493506,1831.987013,11413.33117,852.5909091,455.9285714,1301.62987,8667.941558,687.3246753,177.012987,4760.62987,7757.142857,1367.733766,238.0844156,3286.324675,295.9415584,573.1233766,154,15.85497384,12.68026584,0.60031214,0.933333333,0.6015625,0.860118213
+2555,33811.87963,901.8518519,513.4351852,1107.814815,30148.37037,723.1296296,511.6851852,1584.111111,16730.87963,557.25,494.5555556,1734.138889,22551.56481,1339,4221.231481,3983.351852,7927.157407,1391.666667,366.6481481,2382.240741,13481.66667,509.212963,509.7222222,486.6203704,15106.68519,391.9444444,137.2314815,2692.018519,11736.94444,1431.166667,779.6388889,2802.101852,10369.64815,652.962963,292.5555556,1695.416667,7916.953704,877.7407407,441.7314815,1336.546296,6086.75,710.8148148,174.2222222,7281.768519,5689.592593,1370.981481,564.9259259,3240.638889,324.4166667,571.6851852,108,14.21984008,9.727169252,0.729429342,0.947368421,0.771428571,-0.046656868
+2556,17934.72727,876.0123967,472.6322314,1067.946281,17337.54545,719.5867769,553.0743802,1475.615702,9452.363636,560.1859504,476.8471074,1773.809917,13262.52479,1325.714876,2585.966942,1762.173554,4487.764463,1314.359504,358.2107438,2448.896694,9609.095041,434.9545455,701.177686,499.0123967,10797.69835,419.1280992,125.8595041,2018.020661,8162.731405,1571.491736,658.6322314,2839.297521,7352.619835,766.2438017,278.2479339,1465.657025,5929.607438,826.946281,433.9132231,1379.628099,4786.863636,816.9834711,174.677686,3134.735537,4295.77686,1452.657025,2934.380165,3232.466942,463.1280992,573.3181818,242,19.05534186,16.90332232,0.461645,0.952755906,0.636842105,-0.802715328
+2557,28763.21849,1046.663866,899.1596639,1271.411765,24111.41176,796.907563,833,1908.042017,13624.81513,603.3277311,596.3361345,1912.705882,18729.4958,1468.201681,2046.87395,1623.10084,6107.882353,1528.470588,374.5630252,2459.210084,12508.88235,534.8991597,246.9495798,488.2857143,13076.90756,441.1176471,126.8487395,1635.453782,9489.941176,1529.344538,670.1008403,2812.571429,8571.201681,643.8403361,290.7983193,1684.159664,6801.134454,967.8067227,448.0672269,1326.260504,5537.823529,653.2352941,169.1008403,1734.546218,4891.638655,1424.638655,2929.495798,3308.168067,516.8655462,571.4201681,119,13.93839934,11.1935783,0.595878131,0.975409836,0.566666667,0.882345306
+2558,20821.01515,953.844697,481.1704545,1055.659091,18335.3447,694.4318182,527.1856061,1439.681818,10689.70455,535.4280303,569.5378788,1720.291667,14707.10985,1376.488636,1275.757576,1198.969697,5018.106061,1313.560606,336.0151515,2526.640152,10569.6553,464.5075758,141.0606061,626.7121212,12258.30303,405.7689394,120.9280303,989.4318182,9645.564394,1447.518939,650.1742424,2832.753788,8556.628788,716.6060606,274.8787879,1895.636364,6743.655303,919.1174242,419.3674242,1309.299242,5202.352273,636.2159091,159.4734848,1508.424242,4745.996212,1736.151515,29084.01136,3371.200758,594.530303,571.3219697,264,25.42428588,13.51964675,0.846894392,0.949640288,0.785714286,1.387643935
+2559,20421.98723,820.7744681,434.5787234,1060.425532,17966.26809,637.787234,498.412766,1517.178723,10556.20851,486.612766,495.506383,1784.459574,14746.46809,1280.391489,1450.970213,1269.085106,5213.510638,1239.774468,315.3829787,2371.102128,11014.84681,442.9957447,125.7021277,528.0468085,12759.0766,518.6680851,124.9957447,1154.017021,9952.812766,1376.825532,654.1574468,2824.782979,8850.92766,1251.72766,256.3234043,2338.480851,7046.33617,853.4808511,394.6382979,1295.961702,5483.340426,624.5446809,151.9531915,1504.187234,4987.029787,1625.114894,19345.31489,3231.723404,616.7191489,572.8978723,235,21.8592755,14.46443059,0.749762729,0.867158672,0.593434343,1.253245072
+2560,19017.65385,893.6282051,409.5897436,1048.384615,16528.76923,681.2820513,447.6538462,1383.974359,9765.679487,528.8333333,415.3205128,1709.435897,13570.25641,1312.730769,1192.769231,1275.153846,4984.128205,1248.410256,333.1923077,2298.294872,10275.60256,450.5641026,532.2179487,501.2820513,12219.17949,435.4487179,117.6153846,783.9871795,9510.717949,1401.692308,692.4871795,2805.217949,8413.653846,605.1282051,265.4230769,1768.987179,7088.474359,877.5,401.2307692,1318.141026,5391.448718,731.8589744,161.7948718,1204.5,4885.910256,1445.025641,5636.935897,3126.179487,675.0897436,571.2051282,78,10.67715797,9.957153801,0.360999691,0.939759036,0.590909091,0.880225165
+2561,19058.38889,729.4888889,513.2333333,1013.522222,16253.3,617.3444444,418.8555556,1412.477778,10023.24444,471.6444444,485.9111111,1712.455556,13614.87778,1180.844444,2570.733333,1638.977778,5052.444444,1161.433333,306.1666667,2359.4,10281.04444,417.4444444,1134.455556,535.4,12444.62222,415.4444444,117.9333333,1828.211111,9567.177778,1469.811111,638.7333333,2783.144444,8630.866667,830.8222222,257.6444444,2178.955556,7209.966667,826.4555556,384.7555556,1336.966667,5347.522222,956.9555556,159.5111111,2378.044444,4971.044444,1301.5,1349.366667,3132.077778,699.6,570.3,90,13.34189459,9.2300514,0.72207992,0.9,0.629370629,-1.257186815
+2562,38701.15789,834.2344498,489.923445,1077.650718,33334.95215,691.4976077,720.4736842,1576.119617,19799.41627,527.8277512,1244.019139,1785.425837,27854.25837,1250.660287,5043.229665,3622.665072,9660.511962,1264.23445,345.6842105,2552.732057,19914.17703,441.8564593,745.0669856,1391.641148,24143.08612,481.5454545,316.4210526,2900.047847,18500.99043,1864.607656,532.9282297,2803.842105,16084.48804,725.3110048,274.3588517,1985.397129,13116.44976,1243.516746,414.6411483,1333.186603,9088.535885,824.3253589,162.2966507,4270.110048,7979.894737,1312.368421,331.2344498,3260.406699,817.7655502,574.5502392,209,18.11280371,16.66046471,0.392347669,0.856557377,0.578947368,-0.699934683
+2563,38612.35294,915.5294118,1029.482353,1177.141176,32663.37647,736.0352941,1068.082353,1785.917647,18442.74118,552.3176471,788.6117647,1841.211765,25778.94118,1334.564706,2061.411765,2403.235294,9091.776471,1326.341176,356.7764706,2472.235294,18329.71765,542.1647059,663.5294118,694.8823529,22035.10588,523.4235294,133.2470588,1977.564706,17112.54118,1735.458824,550.3529412,2870.035294,14946.24706,737.2235294,288.5176471,1903.058824,11670.94118,1152.705882,433.4941176,1348.8,8109.541176,788.2117647,163.6235294,3368.376471,7106.176471,1346.152941,505.5647059,3340.176471,861.2352941,570.9647059,85,12.93457866,8.735478122,0.737489557,0.904255319,0.551948052,-0.544964843
+2564,37813.30841,1089.82243,535.3831776,1089.018692,30825.14953,757.682243,831.4859813,1550.093458,17730.96262,579.1308411,1016.373832,1747.607477,24778.1028,1315.457944,4163.158879,2984.158879,8659.299065,1279.738318,343.8785047,2391.485981,16754.62617,488.6915888,312.2149533,1084.252336,20087.48598,586.1682243,126.9626168,2621.046729,16242.6729,2036.775701,459.635514,2819.869159,13548.8785,601.5046729,267.9439252,1546.056075,10241.14953,1391.196262,403.4485981,1309.850467,7080.392523,665.2897196,159.7196262,2086.186916,6181.560748,1210.635514,170.7943925,3391.850467,918.1682243,570.9345794,107,13.13050046,10.65006242,0.584916641,0.922413793,0.594444444,-1.563641095
+2565,21387.41667,1153.65,573.3,1044.483333,20484.18333,745.7333333,662.0166667,1451.533333,10427.03333,614.3666667,876.6,1730.033333,13794.01667,1293.266667,3373.066667,3624.666667,5148.566667,1254.9,320.2666667,2569.7,11275.5,526.75,275.2333333,1317.633333,9352.35,371.7666667,172.05,3114.083333,6839.95,1569.966667,736.55,2794.233333,6326.5,534.35,253.1,1471.716667,4962.716667,791.3833333,387.55,1299.033333,4076.916667,571.4666667,154.9833333,3250.833333,3214.933333,1133.483333,142.8166667,3518.7,363.9833333,570.5333333,60,12.88780241,6.871365235,0.846009319,0.895522388,0.5,-0.995730736
+2566,40053.23438,1074.679688,550.8828125,1101.046875,34786.25781,845.171875,797.6640625,1564.203125,20111.15625,639.6953125,913.390625,1796.984375,26875.125,1443.679688,3254.398438,3298.828125,9465.984375,1425.78125,371.78125,2383.484375,18553.0625,453.9453125,281.1015625,651.546875,21324.50781,439.7421875,197.546875,2415.109375,16896.78906,1857.976563,738.1640625,2803.679688,14896.46094,634.8046875,298.8984375,1719.53125,11587.91406,1080.382813,449.0234375,1325.367188,8888.09375,705.5234375,175.0078125,3152.632813,7837.117188,1378.890625,140.6875,3451.398438,394.3828125,571.9296875,128,16.14127575,10.35786604,0.766955255,0.955223881,0.615384615,1.22342882
+2567,16084.2619,764.2619048,580.4761905,1054.880952,15425.85714,629.5952381,672.547619,1419.02381,7749.071429,480.5714286,2032.404762,1772.904762,12410.54762,1200.880952,3576.285714,4527.309524,4472.547619,1154.214286,322.5714286,2479.261905,8672.619048,401.4047619,111.6904762,1065.380952,10925.38095,1042.309524,129.3095238,1857.952381,7538.095238,1560.785714,551.7619048,2779.119048,6836.285714,584.6904762,249.2857143,1824.02381,5716.166667,1838.357143,380.7142857,1321.809524,4566.047619,588.5,159.3095238,3198.97619,3814.547619,1279.333333,1138.333333,3091.809524,724.2380952,569.2857143,42,10.30637864,5.768855448,0.828670709,0.857142857,0.545454545,-1.184252404
+2568,24022.0073,857.8686131,860.4525547,1132.861314,21985.15328,706.1605839,769.7883212,1648.29927,11511.18978,528.5766423,841.3649635,1782.051095,17311.23358,1252.080292,4556.883212,3046.985401,6102.335766,1375.525547,347.7445255,2474.525547,12452.08759,473.9343066,1765.912409,813.7737226,14663.27737,561.4671533,124.7737226,2432.948905,11056.48175,1779.50365,543.6569343,2810.583942,9700.394161,771.8540146,277.1970803,1982.167883,7704.248175,978.0145985,413.2116788,1362.927007,5859.328467,1067.693431,161.2554745,3216.766423,4923.656934,1306.240876,257.5839416,3228.364964,848.459854,571.3211679,137,15.75165964,12.1471032,0.636637283,0.88961039,0.585470085,-1.32630534
+2569,50510.45679,896.3333333,558.7283951,1113.024691,47836.38272,753.6419753,566.0123457,1685.382716,26288.17284,584.7407407,486.345679,1770.08642,34585.95062,1344.049383,6971.604938,4745.012346,12534.2963,1468.37037,377.9876543,2380.111111,26763.55556,473.1604938,171.5308642,463.2839506,32672.7037,431.5802469,140.7777778,5729.160494,24856.2716,1574.901235,921.1975309,2860.987654,21503.67901,642.0864198,318.0864198,1843.333333,16105.49383,927.3333333,476.617284,1308.012346,12253.37037,671.4074074,185.037037,2638.197531,10758.11111,1441.617284,147.0740741,3267.777778,266.1111111,572.4074074,81,15.77098343,6.775274139,0.903017491,0.852631579,0.482142857,-0.877686582
+2570,28061.04237,951.6101695,551.9661017,1087.20339,25021.33051,724.7881356,657.1525424,1562.067797,14331.4322,759.3220339,538.0508475,1773.898305,19504.59322,1318.90678,5182.923729,3004.449153,6858.271186,1447.59322,363.5254237,2431.474576,15227.4661,431.5169492,454.0423729,461.8220339,16892.57627,470.6016949,124.7542373,3868.050847,12913.38983,1576.652542,711.9915254,2802.211864,11527.38136,642.4237288,288.7881356,1899.720339,9099.466102,893.2033898,446.2542373,1346.474576,7040.152542,723.8644068,171.6101695,5234.59322,6275.40678,1349.042373,257.6355932,3390.279661,483.4661017,571.7033898,118,15.95658765,9.785596239,0.789878228,0.951612903,0.655555556,-0.982862164
+2571,26239.2268,1126.742268,623.6597938,1352.453608,22312.86598,751.2680412,654.3917526,2162.402062,13502.43299,571.742268,493.7731959,1825.010309,18434.92784,1414.958763,1648.886598,2361.041237,6301.814433,1382.701031,368.4845361,2453.154639,12162.84536,479.1649485,120.9072165,505.9896907,14723.20619,516.8865979,136.0618557,1495.608247,11196.51546,1482.71134,741.9896907,2816.340206,9898.494845,640.5773196,293.0515464,1940.350515,7915.742268,858.2989691,450.3814433,1314.340206,5979.14433,640.0824742,176.1649485,2059.721649,5614.701031,1464.216495,4583.340206,3391.536082,532.6804124,573.1546392,97,12.91018214,10.04172185,0.628494398,0.873873874,0.621794872,1.386797729
+2572,20316.61074,819.5838926,423.9798658,1023.651007,17671.54362,708.8791946,454.7114094,1361.107383,10556.89933,511.6577181,1142.026846,1732.348993,14582.3557,1357.919463,1624.194631,2231.711409,5185.288591,1236.174497,339.5167785,2362.033557,9973.865772,456.5167785,102.1744966,1176.583893,12106.26846,435.3825503,418.3288591,927.7852349,9295.33557,1504.14094,635.4630872,2805,8338.590604,642.6510067,263.0738255,1496.228188,6751.013423,1145.469799,400.5838926,1302.328859,5343.691275,610.5637584,158.3020134,2321.409396,4801.241611,1459.604027,4806.550336,3084.006711,634.114094,573.5503356,149,16.79160942,11.60512566,0.722733844,0.93125,0.665178571,-0.97440011
+2573,31982.53957,849.4388489,491.5107914,1084.503597,27795.92086,699.9568345,479.9568345,1530.517986,15868.79137,533.8776978,663.8201439,1758.834532,22087.85612,1304.776978,4371.589928,2663.81295,7927.395683,1274.352518,343.7841727,2414.820144,16040.05755,531.8561151,505.7122302,605.9280576,19804,414.1510791,127.2230216,2427.47482,14595.32374,1582.302158,830.0719424,2806.661871,13028.54676,594.2302158,282.352518,1927.985612,10621.46043,1019.28777,413.7266187,1325.215827,7770.395683,739.7482014,166.6978417,3598.410072,6738.057554,1393.007194,906.8848921,3371.244604,751.2230216,574.7553957,139,15.16496251,12.60285463,0.556196478,0.891025641,0.620535714,-1.420640583
+2574,23280.93458,751.4672897,519.8691589,1071.336449,19263.33645,610.9813084,523.7850467,1484.411215,11398.13084,485.588785,613.4672897,1731.672897,16581.59813,1230.35514,6601.794393,3127.728972,5978.925234,1193.607477,335.6915888,2432.009346,11813.92523,615.5046729,623.1962617,521.953271,14248.36449,437.4018692,119.9719626,2804.149533,10725.49533,1428.056075,552.7757009,2793.317757,9435.028037,1255.485981,244.2616822,1815.570093,7754.906542,880.1028037,378.9158879,1297.28972,5493.168224,757.5981308,156.9252336,5037.102804,4864.766355,1209.82243,542.317757,3184.084112,829.6915888,573.1775701,107,12.84722182,10.73500213,0.549354518,0.938596491,0.748251748,-0.021441495
+2575,26052.06122,790.0306122,510.5153061,1047.362245,22101.36735,633.8520408,535.4183673,1499.382653,12373.70408,502.6326531,582.3061224,1720.454082,17975.06122,1190.02551,4588.178571,3278.908163,6236.846939,1201.653061,315.0357143,2430.688776,12500.32653,479.9846939,1344.520408,619.7040816,14884.68367,442.4336735,121.8622449,3398.882653,11599.82653,1604.127551,616.744898,2776.096939,10046.57143,619.2653061,251.4081633,1980.147959,7972.066327,965.1326531,392.8367347,1345.556122,5584.984694,1009.765306,153.9234694,5833.954082,4970.336735,1215.352041,545.0102041,3490.102041,871.5867347,575.0663265,196,18.7297107,13.7628248,0.678270335,0.928909953,0.687719298,-1.040475699
+2576,60165.92857,966.1071429,530.9821429,1178.642857,59153.94643,838.875,635.75,1897.214286,32228.98214,644.4464286,743.5178571,1756.803571,43198.33929,1486.321429,4551.875,4805.339286,16278.51786,1588.357143,423.2321429,2436.642857,33039.69643,550.9821429,173.9107143,498.4642857,40079.32143,473.4642857,145.9285714,3107.428571,30346.83929,1746.214286,586.3392857,2837.892857,24909.66071,682.4821429,364.625,2814.767857,16441.67857,949.0714286,497.3035714,1319.821429,12086.66071,678.7857143,189.8214286,2491.767857,10184.41071,1525.517857,184,3304.821429,167.4107143,572.125,56,9.978414944,7.505957532,0.658912695,1,0.636363636,-1.431014243
+2577,29356.88043,801.9021739,503.0869565,1071.326087,26987.33696,666.048913,529.8804348,1524.98913,14566.50543,525.7391304,501.2663043,1764.61413,19824.54891,1224.521739,6084.581522,4290.26087,6914.375,1295.282609,335.0054348,2397.771739,14707.14674,2303.380435,962.3478261,439.4782609,17209.96739,422.6467391,124.7065217,4328.782609,13488.68478,1429.130435,752.2663043,2795.440217,11843.73913,617.9293478,277.1413043,1774.293478,8824.179348,837.0108696,420.9347826,1316.798913,6625.11413,836.9021739,170.0652174,5719.929348,6085.777174,1318.695652,433.8532609,3242.005435,313.1521739,578.6793478,184,19.63609674,12.66179896,0.764332267,0.897560976,0.584126984,-0.530895333
+2578,57187.37209,1074.744186,575.9767442,1192.837209,52576.30233,883.4883721,614.0232558,1825.627907,29547.16279,665.3488372,594.4186047,1782.232558,40029.86047,1587.837209,2528.744186,4231.069767,13703.23256,1632.44186,434.3023256,2453.325581,27466.95349,555.4418605,242.8604651,543.2325581,32842.23256,514.9302326,157.255814,4261.790698,25617.65116,1772.465116,851.255814,2804.55814,22823.23256,708.5116279,373.5813953,1876.581395,18110.32558,1065.418605,519.744186,1340.744186,13669.34884,752.2790698,211.5813953,4841.209302,12075.32558,1619.27907,166.9302326,3499.651163,372.627907,572.0930233,43,10.32907397,5.555493043,0.843040518,0.934782609,0.530864198,-0.742206946
+2579,37204.72924,832.4043321,517.9025271,1102.631769,19717.95307,586.3537906,607.9855596,1492.725632,8604.314079,415.0288809,1464.974729,1713.935018,13876.06859,1041.039711,7397.924188,3155.122744,5141.906137,1091.610108,292.5415162,2428.783394,9518.696751,342.9097473,754.801444,916.3357401,11829.87726,601.5956679,112.2527076,4626.66787,8888.375451,2105.772563,403.1588448,2801.252708,6985.33574,556.6137184,222.7148014,1850.920578,4788.714801,1108.129964,350.7942238,1288.783394,2313.072202,726.6245487,139.1552347,2749.364621,2649.212996,1000.205776,331.8483755,3044.555957,1114.66065,579.0072202,277,26.9242689,14.33175559,0.846556557,0.865625,0.54743083,-0.859838691
+2580,50785.04167,941.03125,629.03125,1156.270833,51530.97917,788.9895833,757.25,1840.4375,27758.97917,613.625,549.75,1803.479167,36468.83333,1415.8125,9283.666667,7938.5,13889.91667,1494.09375,395.90625,2365.614583,28060.75,490.1875,158.0520833,446.7604167,34493.84375,473.8229167,144.40625,5921.1875,25518.04167,1591.354167,859.7291667,2831.729167,22041.8125,675.8229167,340.1041667,4691.583333,15802.16667,911.6770833,485.5625,1315.520833,11344.875,688.9270833,190.2291667,3425.78125,9684.645833,1474,189.2916667,3408.947917,205.8333333,573.3229167,96,18.59898034,7.150646805,0.923139797,0.864864865,0.505263158,-1.240359194
+2581,47624.27933,890.9273743,538.6592179,1135.860335,47564,754.8659218,671.0893855,1695.592179,25383.47486,576.1564246,663.3128492,1790.184358,33179.75419,1353.078212,5799.396648,5327.396648,12401.13408,1446.24581,380.8938547,2385.100559,25463.48603,483.6256983,152.2513966,571.2905028,30916.12291,442.3072626,153.2346369,4029.346369,22826.37989,1625.564246,631.5865922,2816.374302,20178.13408,638.3240223,327.9664804,2762.089385,14665.65363,899.1173184,467.6368715,1311.441341,10990.44693,673.8100559,184.4636872,3814.195531,9396.810056,1435.391061,230.7486034,3338.430168,237.2122905,576.4748603,179,21.82259728,10.80779454,0.868746501,0.895,0.559375,-0.979399062
+2582,42109.1,900.7727273,506.3545455,1107.772727,37005.01818,750.9818182,665.9181818,1590.536364,21928.26364,575.7090909,601.0363636,1781.809091,29555.69091,1383.436364,3137.809091,2748.972727,10418.56364,1498.672727,372.2272727,2429.663636,21348.76364,654.6545455,263.3727273,511.7090909,25551.16364,437.5363636,136.2818182,2687.372727,19931.13636,1642.181818,753.0181818,2850.663636,18007.91818,713.9454545,322.6181818,1609.927273,13689.3,1132.727273,480.9818182,1371.063636,10416.06364,709.2181818,182.2545455,4583.936364,9516.636364,1485.590909,318.3181818,3360.918182,417.6727273,574.2818182,110,13.70077576,10.55525328,0.637545362,0.916666667,0.714285714,-1.275944232
+2583,41007.64732,846.9151786,474.8839286,1096.513393,36169.11607,706.65625,729.3616071,1596.977679,21458.19196,548.8035714,1422.308036,1763.776786,29123.30357,1316.191964,3969.227679,4205.267857,10528.01339,1313.522321,349.8794643,2501.392857,21690.39732,457.5491071,399.0446429,872.5580357,27202.01339,1087.589286,307.25,2541.40625,19803.46875,1605.857143,626.2366071,2795.763393,17760.25,627.28125,286.4866071,1951.513393,14464.55804,1278.696429,424.7276786,1308.700893,10565.10268,754.5223214,168.4330357,3566.964286,9353.1875,1404.0625,220.4866071,3226.84375,718.2723214,578.9553571,224,21.9619405,14.84531272,0.736941679,0.759322034,0.533333333,0.961756913
+2584,41973.07246,850.0724638,533.8695652,1080.768116,34693.88406,727.3768116,928.1449275,1631.434783,20448.84058,513.1594203,1267.246377,1749.217391,28837.81159,1277,4486.652174,2689.217391,10184.05797,1297.463768,348.2028986,2484.101449,19428.98551,485.3478261,1479.405797,1864.884058,23537.56522,472.4637681,313.3043478,3117.57971,18642.97101,1916.376812,525.173913,2820.086957,15918.6087,632.6521739,271.2753623,1781.724638,12162.43478,968.5507246,421.9855072,1314.753623,8134.188406,1035.043478,175.4927536,4723.492754,7299.869565,1282.884058,699.1884058,3300.710145,895.3188406,573.2318841,69,10.46914688,8.702653507,0.555873746,0.932432432,0.69,-0.670369887
+2585,37238.49206,810.6507937,459.0793651,1062.587302,31784.69841,675.0952381,628.3174603,1521.714286,19170.66667,545.5873016,1601,1754.634921,25923.30159,1257.857143,3499.444444,3362.507937,9373.571429,1289.698413,336.1111111,2544.412698,18889.28571,423.8412698,266.7301587,1105.904762,23554.61905,663.1428571,171.4444444,2690.936508,17141.31746,1740.571429,593.0952381,2790.111111,15391,616.7619048,269.8253968,1865.904762,12580.22222,1281.888889,405.0793651,1298.253968,8842.222222,683.9047619,158.3968254,3738.349206,7939.920635,1348.111111,477.031746,3237.603175,731.3650794,573.9365079,63,11.16750163,7.394402076,0.749383912,0.9,0.583333333,-1.394792915
+2586,31863.00654,836.4705882,550.5228758,1086.882353,29503.15033,686.3529412,952.9934641,1605.836601,15421.98693,523.1045752,1644.522876,1798.470588,22624.05229,1236.496732,5692.48366,4587.869281,7712.562092,1258.732026,329.5294118,2803.888889,15460.73856,584.0653595,1291.385621,1244.816993,18692.46405,1402.856209,152.3529412,3528.633987,14019.72549,1827.464052,522.9084967,2813.601307,12102.22222,691.5424837,272.620915,1689.72549,9340.418301,1431.705882,412.3398693,1334.686275,6845.052288,951.9542484,155.3464052,4902.738562,5713.660131,1250.908497,639.4901961,3272.588235,885.751634,577.6993464,153,15.94618473,12.67047127,0.607163426,0.927272727,0.728571429,0.373581818
+2587,39805.09187,852.5371025,575.8551237,1110.784452,32295.77032,645.1766784,685.6219081,1604.929329,16774.36042,481.1519435,638.3427562,1718.646643,23989.68198,1176.335689,9568.812721,4585.427562,8584.042403,1230.844523,327.5229682,2908.897527,16640.5371,570.4911661,1198.462898,509.0212014,21337.02473,412.04947,123.8268551,5760.09894,15616.60424,1646.342756,614.9187279,2795.893993,12979.5265,613.4946996,264.7102473,4452.766784,9474.070671,825.7067138,398.3392226,1330.342756,5802.699647,941.3745583,152.0070671,3313.770318,5450.64311,1177.964664,423.9858657,3242.946996,1011.724382,582.8409894,283,25.28196077,15.03239103,0.804029355,0.86809816,0.640271493,-0.014834488
+2588,62379.24359,982.2051282,559.7692308,1172.615385,60472.01282,820.0641026,549.474359,1892.153846,32612.96154,621.1794872,530.1410256,1782.884615,42513.61538,1478.730769,5901.217949,6111.641026,16542.33333,1582.74359,420.4615385,2353.564103,31793,503.7692308,163.2948718,432.5384615,40591.51282,476.9102564,155.3974359,5375.448718,29879.12821,1639.487179,626.5769231,2857.923077,25678.4359,671.7435897,350.2179487,1858.923077,17896.80769,931.7692308,498.8846154,1296.910256,12611.26923,678.3333333,185.025641,2124.641026,10917.5,1519.192308,136.6410256,3341.153846,192.9102564,576.5897436,78,12.61440657,8.823252861,0.714673297,0.906976744,0.545454545,-1.040514148
+2589,55940.37795,943.6141732,591.4173228,1168.84252,56332.7874,796.5511811,752.0314961,1852.425197,30032.22835,615.4488189,546.2598425,1784.425197,39560.40945,1436.598425,6802.818898,6384.023622,14830.64567,1534.582677,396.6850394,2350.551181,30269.85039,511.9527559,155.8740157,439.4330709,37621,458.9685039,146.7795276,4900.094488,28070.3937,1626.385827,761.3937008,2892.748031,24171.44094,683.0314961,348.488189,3741.76378,17467.16535,942.8110236,488.976378,1318.307087,12548.46457,687.1338583,192.2519685,2815.362205,10802.85827,1500.417323,164.7165354,3421.614173,211.1181102,579.2677165,127,20.76680744,8.628810359,0.909588738,0.846666667,0.439446367,-0.812304448
+2590,20958.6875,1265.3125,699.8928571,1045.660714,18021.92857,713.3303571,533.3035714,1455.830357,10258.64286,579.8660714,625.2053571,1741.883929,13575.08929,1286.821429,5968.428571,2220.375,4905.857143,1322.946429,326.7053571,2624.732143,9986.741071,421.6785714,581.9107143,453.7946429,11616.32143,375.3571429,126.5714286,3519.303571,8950.142857,1611.294643,586.4553571,2799.964286,7988.3125,610.5892857,258.4285714,1326.258929,6203.794643,885.5357143,407.5535714,1306.732143,4879.669643,1121.607143,162.25,3379.285714,4377.526786,1300.107143,167.3303571,3383.428571,349.2410714,577.1964286,112,12.37747744,11.782287,0.306367135,0.98245614,0.662721893,-0.76956214
+2591,22060.12903,1153.637097,536.4193548,1043.677419,19712.99194,732.3951613,495.1048387,1387.427419,10507.3871,603.9596774,638.4919355,1731.395161,14337.99194,1283.072581,2904.217742,2235.685484,5487.314516,1272.169355,330.3870968,2380.467742,12011.27419,478.2016129,406.0645161,524.3790323,13027.19355,448.2096774,133.6532258,3378.177419,9895.758065,1530.403226,689.6532258,2814.395161,8875.129032,625.4516129,258.2983871,1445.193548,7011.75,826.75,412.5725806,1312.354839,5499.475806,672.8548387,160.1935484,3496.580645,4794.258065,1219.733871,169.2177419,3515.532258,378.483871,576.7419355,124,20.45518966,8.06421886,0.919008257,0.843537415,0.502024291,-1.095383245
+2592,29719.61111,866.5694444,482.0902778,1087.680556,27317.42361,728.0208333,782.75,1519.78125,15556.26736,556.1770833,1351.434028,1757.40625,21046.40625,1354.826389,3800.756944,3448.944444,7295,1358.413194,361.9930556,2413.982639,15100.76042,437.0416667,672.9861111,840.03125,16968.08333,981.3715278,136.6493056,3032.034722,13169.51389,1514.215278,684.7326389,2815.673611,11644.33681,624.5972222,288.8020833,1823.871528,9061.579861,1556.666667,453.75,1350.809028,6993.861111,800.0069444,184.2256944,6003.152778,6301.371528,1437.527778,1147.541667,3234.770833,435.1979167,581.4097222,288,25.29566981,15.40868285,0.793060324,0.929032258,0.623376623,-0.558168817
+2593,28211.3617,1093.808511,907.1843972,1187.588652,23948.2766,767.7730496,941.7163121,1714.546099,14333.97163,597.3120567,734.177305,1842.695035,19896.57447,1420.638298,1795.48227,1359.87234,6782.425532,1496.319149,368.0992908,2470.510638,14169.65248,641.6382979,180.0070922,520.5460993,16669.78723,467.893617,138.5319149,1172.304965,12588.5461,1665.971631,643.0638298,2846.921986,11183.39007,682.3829787,308.9858156,1646.673759,8729.843972,1098.453901,471.4184397,1333.794326,6736.964539,717.035461,177.1134752,1453.858156,6202.900709,1529.950355,4659.106383,3420.368794,509.2978723,578.7659574,141,15.89723151,11.70635325,0.676571605,0.959183673,0.626666667,0.652500947
+2594,36247.3,812.8666667,501.2111111,1079.744444,31264.82222,663.6333333,621.5777778,1516.688889,18248.35556,530.4222222,808.2444444,1811.944444,25600.16667,1242.511111,4242.455556,4338.666667,9076.955556,1267.255556,345.9111111,2452.877778,18494.08889,441.7666667,531.2111111,796.7,22452.12222,445.8111111,136.7,3092.322222,16813.17778,1693.133333,674.5,2800.588889,14687.28889,602.1666667,272.6111111,2153.366667,12205.36667,1032.4,414,1307.333333,8645.522222,879.3555556,155.2333333,5133.033333,7490.122222,1308.922222,251.7666667,3255.122222,795.8111111,576.0777778,90,13.52235842,8.740096079,0.763046101,0.947368421,0.629370629,-1.068582052
+2595,37258.4797,824.1143911,556.8597786,1103.114391,30229.38376,704.2250923,627.3357934,1642.523985,14975.73063,462.9298893,1834.767528,1779.808118,21849.71218,1156.900369,9541.132841,4093.02952,8020.099631,1208.937269,320.6273063,2703.472325,15470.14022,435.7933579,412.9630996,1210.188192,19046.30627,413.0295203,400.697417,4814.738007,14419.19557,2264.110701,531.701107,2862.464945,11696.98524,580.7564576,260.1512915,3446.173432,8233.461255,956.8302583,380.4132841,1296.830258,4398.538745,711.804428,149.7712177,3345.357934,4386.487085,1132.103321,509.4169742,3162.785978,1064.464945,580.5276753,271,23.91483231,15.47873749,0.762282685,0.891447368,0.570526316,-1.290268648
+2596,46454.08861,910.0379747,554.1202532,1150.708861,25775.72785,599.8860759,646.9050633,1510.487342,10655.68354,429.3227848,865.835443,1702.626582,17723.10759,1072.202532,7620.405063,3331.708861,6542.132911,1144.424051,303.7594937,2466.78481,12122.27215,349.3860759,1014.493671,798.8227848,14875.44937,512.164557,129.835443,4944.626582,11195.76582,2075.158228,416.7151899,2780.78481,8651.14557,543.721519,231.7025316,1137.468354,5507.14557,925.1835443,355.556962,1285.35443,2591.487342,805.9873418,143.7088608,2920.037975,3059.765823,1037.835443,832.8291139,3137.670886,1133.373418,577.7531646,158,17.66658308,11.63266337,0.752619435,0.929411765,0.663865546,-1.264129512
+2597,16028.72532,820.4849785,434.6866953,1051.536481,14558.8412,660.6266094,560.9270386,1441.935622,8478.171674,518.111588,449.4549356,1724.957082,11500.103,1280.527897,1165.386266,876.5064378,4009.523605,1268.532189,334.3905579,2390.012876,8376.107296,401.6137339,164.0472103,466.5021459,9264.158798,435.5622318,122.3476395,1027.618026,7208.103004,1365.296137,640.2961373,2847.798283,6373.875536,843.639485,271.8497854,1559.742489,5109.261803,799.6824034,425.3261803,1334.515021,3989.390558,656.1716738,170.7982833,2414.343348,3777.330472,1398.832618,3379.304721,3275.991416,451.2746781,583.6309013,233,22.89861868,13.33845645,0.812830355,0.939516129,0.675362319,0.218731569
+2598,32527.05464,989.7103825,674.3005464,1142.071038,28399.79235,739.3551913,767.8087432,1659.245902,16425.86339,661.136612,745.1693989,1831.459016,22624.42077,1363.393443,3511.016393,2734.63388,7965.114754,1458.136612,364.4863388,2449.797814,16084.02732,463.6612022,284.1912568,739.0655738,18517.60656,498.9945355,131.1256831,2623.961749,13996.96721,1503.978142,701.7377049,2825.322404,12483.16393,643.4262295,299.0546448,1759.202186,9896.349727,1083.846995,453.8961749,1330.10929,7619.770492,713.4918033,174.852459,3190.098361,6758.027322,1400.688525,249.8360656,3355.857923,494.2349727,578.147541,183,19.21424627,12.83892063,0.743983504,0.897058824,0.653571429,1.46577677
+2599,32309.90361,1356.433735,680.3012048,1150.493976,27996.06024,807.2048193,748.4457831,1618.939759,16604.48193,618.2409639,614.8915663,1854.722892,22376.85542,1455.939759,1349.662651,1690.698795,7450.192771,1457.325301,377.3855422,2455.46988,16547.0241,516.5301205,143.1807229,531.7349398,19474.07229,669.2771084,130.5783133,1285.277108,15092.84337,1561.542169,654.2409639,2837.903614,13217.61446,684.6385542,313.1084337,2013.759036,10456.18072,974.6626506,479.060241,1349.168675,8009.891566,657.939759,183.5180723,2352.759036,7235.506024,1549.927711,5484.277108,3444.204819,543.9156627,577.5060241,83,11.73524477,10.45246298,0.454611543,0.838383838,0.532051282,0.106059604
+2600,23670.41667,874.7685185,460.0462963,1078.814815,21425.41667,706.5925926,494.8240741,1515.740741,12468.76852,521.3425926,374.1851852,1698.851852,17135.85185,1313.037037,1575.25,1852.018519,6216.027778,1218.759259,320.8518519,2329.333333,12780.69444,434.5185185,157.1851852,478.2222222,15910.10185,424.3888889,122.787037,1264.027778,12053.56481,1330.712963,688.8333333,2787.962963,10815.5,664.9814815,271.6018519,1894.740741,9099.064815,847.0462963,399.4351852,1293.398148,6856.546296,637.5185185,158.2314815,1335.231481,6253.222222,1425.305556,2379.324074,3152.953704,687.4537037,577.9166667,108,13.22834177,10.55386601,0.60289268,0.972972973,0.701298701,-0.046456565
+2601,44848.18824,906.8470588,607.8117647,1190.258824,23995.31765,559.5411765,446.4470588,1682.588235,11433.76471,440.9529412,764.8705882,1743.764706,15651.70588,1036.341176,5691.670588,3222.411765,6048.352941,1086.835294,294.9176471,2776.847059,11869.63529,682.0705882,154.6352941,475.5058824,12953.25882,761.4117647,111.7764706,12630.43529,9674.6,1505.411765,476.1529412,2832.2,8033.376471,507.6823529,238.6588235,6108.317647,4133.976471,776.0352941,358.7411765,1282.152941,3175.811765,573.1647059,144.8705882,2933.976471,2776.258824,1023.752941,211.4470588,3120.352941,131.5411765,579.5764706,85,15.49801432,7.205980448,0.885330885,0.988372093,0.505952381,0.734494032
+2602,49014.06452,902.3709677,569.0967742,1129.419355,49732.16129,754.2258065,846.4193548,1722.83871,26503.91935,601.0322581,545.3387097,1760.983871,34752.96774,1379.725806,9179.66129,3854.483871,12976.19355,1429,386.0483871,2396.306452,26537.51613,489.7741935,151.5,442.983871,31901.37097,464.6451613,145.2419355,5272.790323,24035.04839,1591.532258,687.4354839,2823.370968,20805.75806,652.3225806,335.0967742,3460.354839,15309.17742,902.7419355,476.7258065,1308.83871,11098.41935,671.516129,191.3548387,4832.790323,9539.677419,1468.564516,232.8064516,3368.274194,225.3709677,578.6612903,62,13.61836943,6.959744026,0.859547654,0.794871795,0.52991453,-0.038099378
+2603,26964.11111,1194.766667,721.5444444,1127.333333,26860.81111,826.8666667,535.8444444,1623.366667,12863.28889,632.1888889,513.9222222,1753.922222,16362.2,1408.044444,7448.322222,4339.322222,5844.477778,1372.155556,358.2666667,2381.633333,13311.11111,452.4111111,128.7,418.9333333,14914.2,415.8444444,133.0444444,5654.311111,10423.47778,1518.644444,548.5444444,2816.755556,9295.144444,623.2,294.2111111,2448.777778,6879.066667,843.9444444,426.4333333,1316.9,5556.1,623.2111111,175.0666667,3105.222222,4355.833333,1313.288889,246.6888889,3589.588889,251.7888889,578,90,14.6447374,8.182414885,0.829351422,0.909090909,0.5625,-1.529775602
+2604,37062.52857,921.7,524.5857143,1120.8,31908.6,741,670.6857143,1568.014286,19049.98571,557.7142857,1110.642857,1765.614286,25195.72857,1352.728571,3785.942857,3257.4,9153.557143,1326.571429,364.8857143,2417.857143,18856.77143,459.4571429,1050.657143,896.7571429,22979.34286,425.1428571,256.5142857,2564.557143,17499.57143,1817.785714,820.1714286,2811.642857,15756.72857,704.6285714,287.1,1691.814286,12663.72857,1101.614286,435.7142857,1348.714286,9261.157143,1035.442857,160.2,2816.657143,8278.485714,1447.728571,354.6428571,3241.042857,705.5285714,578.6714286,70,13.95008772,6.511336392,0.884384272,0.945945946,0.673076923,-0.397841653
+2605,37597.91083,877.0318471,459.7261146,1082.509554,33023.30573,725.0509554,865.8853503,1607.082803,18613.42675,522.6751592,672.5031847,1727.515924,25888.59236,1303.070064,3308.522293,1726.751592,9300.66242,1315.974522,357.3757962,2357.11465,17918.47134,456.6942675,637.7388535,1026.401274,22001.27389,469.5796178,323.4713376,1714.802548,17398.66242,1675.707006,478.7515924,2831.66242,14614.05732,1163.318471,288.6496815,1598.904459,11358.96178,1025.834395,420.4394904,1300.216561,7709.484076,777.2484076,161.0573248,2185.834395,6821.203822,1323.917197,766.9681529,3309.184713,908.6624204,579.4904459,157,16.50873582,12.67350436,0.640827714,0.88700565,0.697777778,0.410686082
+2606,46354.14141,894.8535354,615.489899,1148.823232,47282.52525,783.6717172,827.9949495,1944.050505,23711.05051,605.010101,685.2777778,1825.424242,32825.90909,1418.646465,9808.813131,7129.030303,12865.0101,1510.777778,400.3383838,2515.237374,25102.05556,586.4949495,1229.358586,561.3333333,29972.14646,504.9343434,146.6818182,8452.20202,21569.4798,1703.671717,628.3787879,2831.419192,18051.0404,648.6969697,331,7390.065657,11134.9596,901.4444444,463.4646465,1317.222222,8095.348485,965.3030303,178.0656566,3919.89899,6768.944444,1373.545455,302.8636364,3356.641414,153.2020202,583.0252525,198,19.12394995,13.95212693,0.683913577,0.9,0.611111111,0.592916306
+2607,34758.23529,841.4411765,575.8627451,1082.411765,33465.20588,696.5490196,712.3039216,1619.519608,17801.7549,547.3529412,620.9705882,1775.323529,23339.59804,1270.813725,6448.578431,4823.95098,8782.176471,1356.862745,347.8333333,2428.686275,18137.31373,545.8235294,216.7058824,485.7058824,22318.97059,454.0588235,130.1372549,6017.529412,17021.26471,1560.607843,708.8333333,2805.460784,14767.19608,801.8039216,302.1078431,2667.892157,10857.96078,897.1372549,439.7647059,1298.039216,8235.078431,684.7156863,176.9705882,7406.27451,7380.22549,1380.470588,265.7352941,3316.294118,280.0588235,581.4607843,102,16.90239165,8.380285624,0.868434037,0.894736842,0.485714286,-0.789148985
+2608,42401.97826,1079.108696,605.3043478,1114.73913,39476.43478,819.0217391,1044.282609,1655.217391,22663.26087,665.8913043,1864.413043,1813.152174,29661.56522,1471.173913,4014.23913,3883.956522,10646.84783,1486.608696,397.3695652,3083.978261,23678.3913,607.5217391,325.2826087,2067.391304,26553.67391,482.3478261,743.173913,4306.478261,20764.78261,2443.543478,699.8478261,2873.891304,18478.52174,667.5434783,343.326087,1596.130435,14164.26087,1158.891304,491.173913,1328.869565,10993.26087,712.3695652,185.4347826,3741.326087,10106.67391,1511.304348,274.3913043,3432.391304,364.6956522,576.8478261,46,10.39333802,5.988748057,0.817301493,0.92,0.547619048,-1.340355029
+2609,36835.15354,860.8582677,517.6377953,1083.204724,32766.01181,718.7480315,796.3740157,1534.46063,19479.37795,613.9173228,1176.862205,1783.354331,26128.90157,1352.476378,4209.523622,3777.807087,9063.610236,1400.933071,360.0826772,2714.692913,18577.29528,481.5,280.523622,865.0551181,22763.18504,638.5590551,130.1732283,2737.279528,17314.75197,1846.275591,750.7795276,2837.291339,15107.14567,699.1732283,305.1181102,1973.795276,12099.63386,1097.901575,464.519685,1329.80315,9170.602362,737.476378,176.011811,4560.248031,8347.287402,1437.972441,1189.594488,3303.519685,568.2519685,583.523622,254,20.85868808,17.8995623,0.513424755,0.783950617,0.524793388,-0.401154138
+2610,15175.89381,1151.548673,489.0088496,1047.619469,13370.9469,735.4070796,409.4247788,1380.238938,7509.106195,587.840708,415.6283186,1684.672566,10163.23894,1332.734513,1017.185841,830.8584071,3737.017699,1219.522124,308.6548673,2308.40708,7502.495575,405.1415929,137.5663717,458.7876106,8870.097345,402.0530973,113.3362832,877.7168142,6977.39823,1318.477876,531.4070796,2821.734513,6113.955752,593.6460177,241.6371681,1346.699115,4875.840708,827.8230088,384.8141593,1296.628319,3749.185841,639.6017699,149.2389381,1102.530973,3045.823009,1278.495575,1463.115044,3246.00885,666.7610619,579.8053097,113,12.39544235,11.7383487,0.321265713,0.974137931,0.856060606,-0.175519623
+2611,40125.1875,848.8375,638.325,1094.9125,34442.0375,689.175,685.3375,1599.5,19400.3875,529.725,634.3,1736.7375,27926,1294.9625,5598.075,3205.725,9740.725,1317.275,354.6375,2466.1875,20095.2625,465.9875,533.75,649.2375,24386.8375,744.775,128.1625,3117.725,18816.0375,1501.9375,615.8375,2822.325,16328.5875,660.0625,273.175,2049.5625,13001.4125,971.5625,418.9,1317.9625,9204.9125,768.35,165.6125,4152.0125,8080.875,1326.0375,571.45,3260.9875,855.525,579.6875,80,11.86616335,9.045533005,0.647228148,0.963855422,0.606060606,1.128279321
+2612,49440.12037,934.287037,513.787037,1116.259259,43806.59259,766.4722222,471.3425926,1785.675926,25542.43519,568.5740741,417.5925926,1742.592593,34442.16667,1350.138889,4261.314815,3041.435185,12404.78704,1399.444444,385.75,2366.425926,24313.62963,481.2222222,1257.916667,476.9351852,29539.32407,447.2962963,137.6944444,3190.796296,22867.26852,1581.027778,534.3981481,2797.583333,19364.23148,641.4166667,297.2222222,2211.037037,14925.66667,855.3148148,442.0185185,1335.361111,9568.138889,969.2592593,171.3611111,3237.388889,8598.268519,1380.462963,385.0833333,3324.388889,941.2222222,580.5,108,13.25408761,11.08812182,0.547842798,0.947368421,0.553846154,-0.205213052
+2613,59538.27027,971.8378378,558.1013514,1179.466216,59729.91892,856.5472973,698.7162162,1952.763514,31930.68919,626.5067568,988.5608108,1791.945946,42637.92568,1464.878378,4389.594595,6203.594595,15952.97297,1566.337838,416.8108108,2468.22973,32100.22973,511.5945946,171.9594595,819.5405405,39413.87162,493.75,163.8851351,4211.797297,29209.54054,1782.864865,831.9324324,2837.337838,24244.35811,664.7702703,352.6891892,3201.391892,15858.13514,964.1756757,494.6081081,1311.702703,11402.93243,691.75,188.2432432,3296.527027,9583.432432,1471.378378,209.6756757,3339.222973,165.9121622,580.527027,148,16.67083308,12.75982187,0.643557255,0.845714286,0.621848739,1.50310521
+2614,31751.78409,944.5113636,601.3068182,1070.272727,29335.46591,761.625,644.6136364,1577.227273,16110.15909,600.3068182,697.5568182,1770.977273,22168.78409,1415.715909,5323.795455,3508.931818,8060.159091,1431.295455,374.5454545,2389.761364,16355.43182,462.6590909,547.3295455,558.7159091,19538.42045,484.4431818,142.6363636,3888.477273,15105.81818,1788.545455,756.3636364,2810.022727,13450.73864,751.6022727,310.7045455,1902.284091,10698.88636,1006.125,465.2613636,1383.75,8119.375,877.1818182,183.0113636,6923.181818,7114.965909,1435.909091,171.5454545,3333.068182,388.4545455,581.3977273,88,11.613584,9.991663743,0.509715815,0.916666667,0.564102564,-0.562038963
+2615,26713.50526,852.2,513.8736842,1046.705263,23797.34737,670.0526316,701.0210526,1429.168421,14100.49474,531.2842105,724.8947368,1734.031579,18950.78947,1265.684211,3365.621053,2459.957895,6706.642105,1273.526316,327.6526316,2597.052632,13726.17895,462.9157895,181.8105263,677.6631579,16801.76842,446.2526316,121.6947368,2368.894737,12655.50526,1559.705263,714.4105263,2799.042105,11114.82105,674.3157895,274.2105263,1771.084211,8840.505263,930.2210526,420.7578947,1313.473684,6941.557895,646.7789474,158.4210526,2799.747368,6269.915789,1361.168421,5300.852632,3359.589474,581.1684211,581.1684211,95,13.50885988,9.313987999,0.724311818,0.904761905,0.730769231,0.019893129
+2616,24706.95876,995.257732,554.8969072,1120.463918,20909.90722,745.7525773,598.0309278,1548.556701,12573.42268,602.8350515,442.1443299,1716.814433,17185.94845,1437.381443,1759.216495,2027.484536,6360.670103,1359.659794,368.257732,2380.474227,10712.84536,521.1752577,779.5670103,483.1958763,13405.91753,452.1958763,120.8762887,826.0824742,10288.56701,1444.43299,575.8453608,2801.360825,9278.268041,638.2886598,270.9690722,1779.42268,7670.020619,1123.835052,411.7113402,1315.670103,5778.969072,1737.948454,163.8350515,958.814433,5360.484536,1615.969072,275.4948454,3315.690722,655.7319588,581.0515464,97,12.70486403,10.00786023,0.616034978,0.96039604,0.62987013,0.420292628
+2617,24110,928.7222222,505.8333333,1125.347222,20955.30556,683.875,398.0416667,1529.569444,11795.86111,530.1527778,640.4027778,1743.402778,16559.34722,1327.888889,1941.583333,1723.625,5687.569444,1278.027778,335.3333333,2367.958333,12189.61111,456.0833333,454.3194444,618.8611111,14657.73611,413.9444444,126.1111111,1425.083333,10723.94444,1469.486111,591.9305556,2804.333333,9459.097222,636.6666667,269.0972222,1611.861111,7839.069444,1076.777778,409.875,1307.583333,6308.166667,732.4583333,166.5555556,1942.736111,5430.708333,1444.847222,636.4722222,3108.708333,697.5138889,579.6527778,72,10.75719779,8.914129685,0.559742614,0.911392405,0.727272727,-0.050054564
+2618,40313.42208,860.8961039,472.1948052,1072.285714,35946.78571,715.8766234,851.7207792,1534.928571,20355.38961,554.3441558,2217.12987,1799.142857,28622.92208,1330.538961,3670.772727,4470.168831,10119.44805,1304.519481,358.6688312,3023.779221,21026.72078,460.4350649,255.6883117,1395.201299,26316.15584,808.474026,132.9090909,2403.285714,18809.55195,1808.422078,586.0324675,2809.051948,16966.5974,623.8896104,279.7597403,1849.207792,13783.01299,2104.422078,424.8766234,1303.227273,10197.59091,691.6168831,168.4545455,4694.844156,8853.266234,1412.857143,537.6883117,3232.532468,735.6493506,581.6428571,154,19.39640362,10.7161731,0.833524513,0.885057471,0.611111111,-1.221877769
+2619,36883.63978,849.188172,495.8172043,1098.446237,33008.54301,690.6451613,751.6774194,1569.155914,18565.33871,533.6612903,1675.134409,1773.344086,26323.27957,1257.284946,5372.155914,4323.419355,9081.349462,1298.123656,344.6827957,2996.123656,19087.50538,516.655914,302.7849462,1301.903226,23065.51075,563.5806452,196.9623656,2653.053763,17356.19892,1910.247312,656.1935484,2800.591398,15015.65591,660.9462366,278.0806452,1865.548387,12183.94086,1382.521505,416.0698925,1305.155914,8869.451613,738.4354839,165.9462366,3725.758065,7499.935484,1336.94086,473.6935484,3244.854839,803.1827957,583.1021505,186,18.78756206,13.16737223,0.713302964,0.939393939,0.547058824,-1.030987065
+2620,42411.36979,896.3489583,602.46875,1117.552083,36208.97396,716.75,616.25,1706.208333,19848.13021,518.109375,511.1770833,1693.932292,28234.39063,1278.416667,5735.135417,3451.494792,9946.364583,1322.494792,355.1875,2467.552083,19698.13021,442.8385417,700.5208333,492.2760417,24301.66146,431.4375,130.171875,4045.026042,18844.51563,1515.489583,519.3229167,2798.989583,15660.5625,611.4895833,287.3125,4319.1875,11661.20833,853.1822917,426.328125,1330.963542,7686.651042,883.5520833,160.921875,4294.625,6940.380208,1302.848958,239.296875,3219.729167,980.5572917,581.2916667,192,21.62267751,11.86224497,0.83608361,0.905660377,0.671328671,1.417780976
+2621,46239.72152,862.8227848,549.6962025,1141.506329,36707.3038,659.9493671,660.7594937,1609.493671,20789.64557,480.5316456,1736.367089,1747.265823,29144.44304,1210.911392,7175.341772,4334.075949,10836.91139,1259.050633,337.164557,3112.556962,20202.6962,1737.493671,176.2911392,708.2405063,25585.16456,413.3417722,132.5316456,5314.075949,19689.13924,2241.594937,613.0506329,2807.025316,16288.11392,673.8987342,274.2531646,5637.632911,11748.27848,1085.088608,409.721519,1317.303797,6830.658228,653.3037975,160.4303797,3260.417722,6672.025316,1231.708861,432.8607595,3275.075949,1022,581.1898734,79,11.76271761,8.714798899,0.671633981,0.94047619,0.607692308,0.276761255
+2622,48441.77647,898.6352941,550.9058824,1136.435294,48435.48235,746.0117647,735.9411765,1742.682353,25735.23529,580.4352941,535.4941176,1774.764706,33916.12941,1371.658824,8312.729412,4743.682353,12709.12941,1450.541176,381.6941176,2365.470588,26224.70588,473.5647059,167.6117647,436.2470588,31882.94118,456.5294118,144.1294118,5256.8,23891.42353,1570.870588,715.9411765,2862.8,20541.88235,699.6352941,336.3764706,4073.635294,15107.03529,916.6823529,480.8352941,1317.635294,10901.88235,666.1058824,184.8117647,2895.847059,9418.4,1450.047059,198.4588235,3388.682353,218.1647059,583.1058824,85,12.94506552,8.758194486,0.736381765,0.934065934,0.607142857,-0.360900607
+2623,40411,849.987013,517.8181818,1097.753247,37761.80519,715.5584416,746.5194805,1652.168831,20868.85714,555.8051948,1121.74026,1856.168831,27192.48052,1284.805195,6684.675325,4438.532468,10123.32468,1371.207792,352.8961039,2376.415584,20956.23377,453.9480519,145.1168831,898.4675325,24619.38961,445.3116883,135.3766234,4327.935065,19485.32468,1806.714286,627.8701299,2811.350649,16805.97403,612.8441558,305.7792208,1816.181818,12300.32468,1081,446.8311688,1311.766234,9083.194805,646.2987013,175.0779221,3899.87013,8230.402597,1379.181818,144.5454545,3290.454545,263.0519481,581.8571429,77,17.38781256,6.886518438,0.918227079,0.827956989,0.366666667,-0.813276019
+2624,32266.52632,972.2421053,549.6105263,1120.036842,30035.45263,757.7789474,771.9421053,1600.926316,16532.07368,592.0105263,960.3421053,1789.526316,22253.49474,1377.810526,4627.742105,4052.905263,7828.847368,1390.010526,368.7789474,2399.952632,16933.78421,472.3052632,757.1842105,836.7473684,19063.37368,452.9631579,132.4631579,2885.731579,14669.99474,1892.094737,719.2789474,2811.910526,12977.43158,698.5421053,306.3052632,1832.015789,10065,1618.226316,456.2947368,1330.163158,8124.457895,842.5052632,183.2421053,4366.157895,6854.336842,1394.268421,149.1263158,3369.463158,403.9578947,582.9263158,190,17.698714,14.59878412,0.565351651,0.87962963,0.558823529,-1.119534461
+2625,18234.05102,971.0612245,848.5,1145.081633,17037.03061,755.6326531,836.5,1628.622449,9421.77551,879.4081633,759.2857143,1837.44898,12616.46939,1326.397959,2278.234694,2807.357143,4542.153061,1482.806122,358.5918367,2464.428571,9389.265306,486.6938776,370.5510204,593.6428571,11537.13265,600.0408163,128.5306122,1804.704082,8584.44898,1578.77551,681.1836735,2817.040816,7592.255102,819.744898,282.1938776,2504.295918,6241.142857,914.5204082,438.7346939,1399.061224,4848.540816,694.4693878,173.3979592,4778.928571,4314.040816,1455.05102,6241.622449,3347.55102,551.6530612,582.6734694,98,15.78723171,8.525404111,0.841652866,0.859649123,0.576470588,-0.05290274
+2626,24983.82609,1035.469565,466.3304348,1070.33913,22344.29565,755.7217391,429.4782609,1493.982609,12862.2087,569.6173913,967.5304348,1676.66087,17492.27826,1440.556522,1425,1455.6,6124.33913,1308.713043,348.8086957,2344.973913,13046.6,555.1652174,145.973913,1048.347826,15523.67826,440.2086957,469.0086957,949.4173913,11920.03478,1508.86087,565.2782609,2802.330435,10567.91304,673.4695652,280.7043478,1641.991304,8470.052174,1185.104348,427.3826087,1303.617391,6756.826087,738.1565217,171.1391304,2869.904348,5664.06087,1630.13913,9966.947826,3211.313043,678.3130435,582.6695652,115,14.10232826,10.7639016,0.646078178,0.927419355,0.631868132,0.364881233
+2627,63691.73529,967.5196078,540.1078431,1172,62777.79412,832.1470588,699.2941176,1929.107843,35351.88235,639.9803922,535.4117647,1757.745098,46304.47059,1468.401961,4343.137255,6242.480392,17844.52941,1593.45098,417.245098,2376.352941,34409.05882,518.1666667,160.9117647,441.0098039,42704.47059,482.4607843,150.6470588,4412.166667,32150.68627,1674.696078,637.9117647,2845.480392,27160.08824,684.7254902,373.2843137,2102.058824,18515.97059,939.6372549,500.5392157,1300.470588,13172.26471,691.9411765,191.0686275,2086.107843,11230.34314,1513,146.4803922,3328.22549,179.745098,582.8529412,102,15.89305443,8.748428647,0.834864115,0.894736842,0.485714286,-0.886126847
+2628,42828.75,870.76,512.87,1112.56,40663.89,718.37,634.25,1640.09,21937.32,564.85,1337.83,1835.13,28649.91,1298.76,6093.34,4136.46,10577.71,1394.26,364.32,2371.29,22480.07,456.26,145.26,768.8,26603.39,448.17,139.32,4355.24,20684.97,1814.25,607.12,2866.44,17782.11,620.64,306.67,1671.04,13083.02,1147.54,457.2,1307.92,9897.62,675.76,173.87,4330,8820.48,1396.8,158.92,3304.37,268.78,584.79,100,18.54778476,7.328006586,0.918643292,0.884955752,0.444444444,-0.681192928
+2629,21550.74359,1265.019231,603.7051282,1075.564103,18329.48718,779.6025641,556.9615385,1461.737179,10724,623.6025641,429.75,1732.679487,14271.66667,1391.544872,849.9679487,794.3974359,4864.25,1299.865385,340.2435897,2368.24359,10273.89744,411.7435897,104.8974359,447.5961538,11984.48718,390.1538462,116.1153846,929.2564103,9078.724359,1362.5,634.9935897,2977.653846,8144.288462,632.4294872,266.5641026,1649.50641,6495.544872,778.7115385,413.1282051,1304.442308,5036.442308,610.8012821,162.9166667,1433.826923,4563.083333,1337.679487,5054.352564,3288.237179,532.6282051,583.0769231,156,19.54084848,10.42937872,0.84566006,0.923076923,0.65,1.421953284
+2630,20737.36842,761.1339713,421.4354067,1070.344498,18701.23923,622.1052632,568.6172249,1421.746411,10904.78947,474.9904306,406.8277512,1730.248804,14522.32057,1181.263158,1295.30622,955.3923445,5448.593301,1165.923445,312,2339.602871,10824.65072,406.062201,154.4449761,456.7990431,13601.29665,378.2009569,117.1913876,763.1626794,10098.34928,1292.267943,520.0143541,2868.401914,8916.177033,617.5741627,256.2296651,1585.263158,7397.789474,780.7272727,384.9808612,1302.851675,5382.755981,617.0287081,153.4880383,2534.15311,4859.784689,1304.755981,2375.267943,3116.37799,760.0526316,585.1339713,209,22.92787941,12.01553977,0.851682547,0.920704846,0.580555556,-0.799470941
+2631,26964.40708,798.0176991,526.5663717,1063.59292,23225.41593,693.380531,817.9026549,1533.681416,13390.9469,511.3274336,1741.274336,1772.575221,19074.43363,1226.265487,5491.035398,3737.707965,6833.150442,1231.451327,331.159292,2489.39823,13922.10619,432.1504425,1450.265487,1224.141593,16477.67257,933.6725664,278.7787611,2691.637168,12957.50442,1968.938053,547.4336283,2801.123894,11340.53982,846.1769912,263.9557522,1714.477876,9082.530973,1356.362832,405.8318584,1341.769912,6543.911504,993.460177,158.8141593,4693.840708,5811.60177,1258.584071,500.6106195,3190.522124,842.9380531,582.6283186,113,12.97207731,11.30441248,0.490498635,0.918699187,0.620879121,1.07015382
+2632,26996.71287,1063.722772,578.4158416,1087.950495,25141.05941,741.019802,669.019802,1572.980198,13611.0198,600.009901,813.2475248,1766.287129,17481.21782,1340.811881,5421.009901,3685.346535,6305.613861,1335,340.8910891,2506.564356,12256.71287,1920.683168,273.4158416,778.5049505,13307.34653,796.4158416,134.9405941,3923.128713,10148.49505,1561.574257,733.2475248,2828.514851,9115.108911,589.8811881,278.5049505,1616.326733,7075.891089,985.990099,430.2673267,1318.39604,5759.831683,661.3465347,163.9207921,4862.960396,4771.217822,1272.653465,215.6930693,3410.148515,360.6633663,584.2970297,101,13.8960207,10.39957088,0.66326478,0.841666667,0.601190476,-1.132980066
+2633,26565.96154,833.3205128,518.6410256,1062.666667,22926.37179,674.0897436,1134.858974,1479.487179,13986.44872,521.9102564,2014.025641,1901.692308,18358.57692,1244.487179,4608.628205,3148.846154,6760.846154,1297.74359,313.7179487,3436.012821,13950.57692,692.7820513,128.4615385,1491.474359,16441.0641,557.1025641,134.4102564,1642.769231,12646.33333,2005.397436,659.0384615,2793.076923,11092.55128,616.8205128,269.6794872,1602.923077,8750.102564,1559.384615,416.1794872,1336.884615,6791.192308,618.5641026,151.6794872,2961.166667,6097.871795,1325.371795,2039.320513,3269.423077,591.8846154,580.9871795,78,14.85808476,6.99788452,0.882143034,0.917647059,0.795918367,-1.484255675
+2634,21994.67251,862.6140351,625.8888889,1094.526316,19068.88889,670.2631579,542.9356725,1489.391813,11137.88304,507.5730994,504.9356725,1738.397661,14839.11696,1447.988304,3599.251462,1731.818713,5396.280702,1267.707602,316.4210526,2440.959064,11157.33333,1653.035088,188.9064327,518.9590643,13155.5848,467.871345,119.8362573,3615.707602,10051.12865,1434.28655,877.6608187,2791.590643,8901.976608,1410.175439,259.4327485,1564.982456,7059.660819,903.6549708,405.9064327,1306.637427,5666.251462,648.5847953,159.3567251,5082.777778,4847.766082,1325.906433,938.9122807,3290.526316,609.6783626,584.625731,171,16.07404957,13.80218872,0.512540888,0.929347826,0.670588235,-1.219129141
+2635,29761.83333,879.59375,502.2395833,1051.8125,25056.48958,654.71875,481.4895833,1494.958333,14489.97917,499.1041667,452.7708333,1694.78125,20407.86458,1217.510417,4158.21875,2555.520833,7214.895833,1210.375,315.9270833,2364.520833,13521.55208,1385.010417,803.5416667,497.1041667,16571.07292,412.5520833,123.7604167,3792.21875,13295.8125,1415.645833,500.4791667,2804.927083,11202.89583,627.875,251.25,1692.197917,8722.260417,784.5625,391.0520833,1291.916667,5786.708333,783,156.0104167,3456.84375,5365.958333,1186.979167,696.9791667,3305.28125,919.53125,582.9791667,96,12.27217488,10.05175711,0.573695122,0.96969697,0.727272727,-0.421034249
+2636,47232.97619,991.0238095,588.9880952,1145.071429,39292.41667,757.1309524,550.4166667,1814.607143,23314.15476,548.4404762,541.0357143,1762.52381,31436.89286,1348.416667,5360.22619,4050.595238,11146.03571,1341.488095,362.6071429,2357.666667,22050.04762,461.6071429,1215.547619,507,26171.02381,442.1190476,135.6428571,3832.357143,20785.52381,1545.571429,670.5,2814.809524,17642.83333,622.7857143,306.6785714,2794.52381,13212.10714,849.3214286,435.2261905,1343.142857,8526.047619,935.4047619,174.2738095,3739.964286,7658.261905,1345.595238,475.0119048,3410.702381,951.0714286,583.9047619,84,14.31123561,8.525025729,0.803216205,0.785046729,0.545454545,0.313615888
+2637,50424.52475,935.5742574,616.4950495,1176.09901,49133.59406,770.8217822,599.7029703,1809.544554,25479.83168,586.4455446,581.8118812,1776.188119,33641.94059,1382.316832,7894.683168,8955.80198,13017.48515,1495.237624,385.7425743,2415.792079,25403.0198,486.2277228,153.7623762,486.8910891,31770.50495,459.4752475,140.5346535,5304.762376,23052.51485,1614.158416,822.1287129,2818.752475,20038.60396,681.2970297,333.9207921,4047.693069,13993.23762,902.3762376,476.6633663,1318.633663,9957.752475,659.4653465,183.3366337,2996.039604,8512.257426,1443.70297,197.2772277,3385.861386,196.8613861,584.5643564,101,14.10591023,9.658326511,0.728824369,0.870689655,0.647435897,-1.007923586
+2638,49905.82353,935.2352941,598.7647059,1161.279412,46950.08824,775.6029412,725.7205882,1814.235294,25878.33824,607.6470588,597.4264706,1786.602941,33698.51471,1463.485294,6981.779412,6931.5,12351.64706,1507.117647,401.0147059,2594.235294,25020.20588,501.5441176,141.0735294,441.2941176,31472.88235,459.6911765,147.3529412,4496.558824,23289.5,1734.117647,624.7647059,2833.897059,20466.60294,692.2794118,343.9264706,2261.705882,14714.45588,1030.485294,491.5882353,1317.132353,10774.11765,678.6617647,197.8235294,2440.073529,9717.941176,1502.455882,184.2205882,3358.897059,242.9852941,584.7058824,68,10.54865732,8.570643644,0.582979745,0.894736842,0.686868687,-0.070502116
+2639,39809.41317,896.5329341,553.0419162,1094.149701,36401.32335,753.011976,927.2994012,1580.479042,21005.52695,580.6706587,1285.185629,1807.197605,28049.98802,1366.203593,4854.562874,3926.904192,10001.34731,1422.42515,365.4131737,2551.628743,20702.01796,457.1916168,1157.48503,993.497006,24669.53892,581.7784431,143.9281437,2801.203593,18993.44311,1998.550898,709.9461078,2820.281437,16912.94611,677.3652695,308.005988,1624.964072,12953.33533,1457.041916,471.7724551,1396.610778,9988.646707,943.5329341,182.4191617,5881.077844,8997.143713,1448.419162,196.7185629,3254.934132,416.8023952,586.3892216,167,21.62363683,10.23693424,0.880839999,0.912568306,0.585964912,-0.983136882
+2640,23159.20952,807.2857143,506.1333333,1044.695238,20463.97143,647.6857143,560.6666667,1461.2,12077.9619,521.2952381,620.9047619,1718.228571,16245.26667,1301.733333,3246.009524,3076.361905,5868.295238,1248.87619,313.8857143,2345.419048,11979.73333,423.3904762,609.7333333,670.6571429,13763.66667,629.2571429,132.2666667,1987.685714,10988.01905,1515.047619,725.647619,2791.704762,9796.12381,821.6857143,257.447619,1802.114286,7755.485714,950.0857143,392.552381,1293.504762,6178.695238,767.6380952,160.9047619,2770.628571,5568.72381,1357.333333,1279.266667,3087.504762,625.7333333,585.8857143,105,13.02185799,10.52066809,0.589287065,0.9375,0.625,0.419706887
+2641,15794.15504,881.627907,489.3410853,1048.976744,14253.51938,696.4883721,438.8139535,1382.51938,7969.550388,504.5348837,587.6511628,1696.317829,11645.93798,1369.372093,1218.255814,1550.379845,4051.899225,1271.426357,338.4728682,2348.922481,8279.821705,437.7751938,193.4263566,658.124031,10194.85271,462.4031008,131.751938,994.5116279,7569.635659,1416.744186,622.4186047,2802.426357,6788.356589,658.8372093,264.9147287,1816.27907,5545.581395,955.8837209,402.8449612,1305.372093,4538.27907,656.5193798,165.4186047,1905.751938,4054.03876,1488.217054,6866.658915,3115.48062,637.5426357,584.4031008,129,14.37009113,11.8290243,0.567795355,0.908450704,0.661538462,-1.227277164
+2642,24976.45556,791.6333333,509.5166667,1067.783333,23347.37222,646.9611111,664.7777778,1559.772222,12152.53333,474.4222222,660.2,1731.55,16854.02222,1155.355556,5087.316667,2733.877778,5974.822222,1201.894444,318.4611111,2457.327778,11668.05556,3605.705556,1424.044444,585.8833333,14171.48889,490.0388889,122.4,3846.538889,10862.00556,1580.322222,595.5222222,2799.6,9142.322222,900.6,248.7833333,1764.077778,6824.911111,809.5111111,392.9611111,1310.083333,4769.077778,966.2333333,155.5888889,6356.938889,4074.877778,1170.888889,258.6,3274.994444,928.2111111,589.6166667,180,23.41110118,10.81000205,0.887011755,0.789473684,0.584415584,-0.139162886
+2643,34812.52857,876.7428571,625.9142857,1087.128571,26685.97143,663.9857143,755.7,1601.9,15779.45714,479.0857143,622.8,1733.157143,21630.88571,1232.085714,5339.457143,4134,7785.214286,1203.328571,341.2,2766.685714,15454.82857,420.2714286,2322.942857,828.6714286,19110.81429,425.7285714,128.6,4625.414286,15368.55714,1785.842857,752.9571429,2793.242857,13089.12857,690,265.6857143,2866.4,10129.8,897.2,399.6571429,1388.028571,6434.3,1178.214286,165.4142857,5188.942857,6065.385714,1277.357143,264.8428571,3250.414286,959.4285714,582.8285714,70,10.39942842,8.684142879,0.55015944,0.933333333,0.777777778,-1.564810978
+2644,34544.03509,884.1461988,501.1578947,1083.076023,34406.95906,754.4327485,616.7076023,1608.362573,18906.7076,568.2631579,969.4502924,1750.701754,25647.36842,1376.666667,3624.432749,3822,9032.602339,1323.988304,355.0701754,2345.871345,18828.07602,498.4502924,363.6725146,753.1520468,23572.8538,423.251462,148.1461988,3610.865497,16906.34503,1530.181287,718.0584795,2799.51462,14782.5731,612.3567251,290.4912281,2063.345029,12453.69591,1144.894737,438.1345029,1308.444444,8877.842105,720.7192982,167.6666667,3492.403509,7545.947368,1439.567251,1446.362573,3214.730994,775.5438596,586.0584795,171,17.16517052,13.17391841,0.641073354,0.919354839,0.633333333,1.416474387
+2645,26730.93966,748.6982759,460.5,1066.146552,22113.10345,646.1810345,590.9741379,1497.094828,13488.15517,484.7327586,692.887931,1766.017241,18825.19828,1161.732759,3481.051724,2171.482759,6865.922414,1280.12931,316.387931,2391.87069,13247.02586,556.2586207,1037.491379,646.8534483,16179.97414,447.4568966,124.3189655,2042.534483,12577.56897,1587.793103,618.4310345,2800.086207,10881.32759,1197.241379,256.0517241,1697.37069,8928.698276,928.4396552,390.6034483,1304.646552,6247.491379,885.7586207,153.1034483,4452.836207,5614.517241,1213,452.4482759,3193.293103,831.5172414,585.4741379,116,14.36513698,10.65961452,0.670347262,0.913385827,0.637362637,0.858576305
+2646,31797.73958,887.375,542.3020833,1097.260417,30435.66667,684.875,1263.333333,1573.395833,15928.75,562.75,1549.75,1797.145833,21447.96875,1240.75,6492.041667,3451.489583,7431.65625,1296.59375,327.6458333,2806.354167,15603.21875,5306.333333,258.6041667,980.4895833,18565.08333,781.3333333,207.90625,4396.6875,14433.76042,1916.635417,650.8125,2841.947917,12520.30208,586.9895833,278.7083333,1425.729167,9200.5,1138.604167,427.8229167,1307.083333,7120.145833,664.2708333,161.4375,3642.604167,6266.75,1279.59375,268.3020833,3408.489583,301.9166667,586.4583333,96,11.61154562,11.27089701,0.240444288,0.872727273,0.527472527,0.909616097
+2647,33541.33962,880.3584906,471.4339623,1103.830189,30750.88679,702.490566,749.5471698,1596.433962,17729.15094,545.4528302,668.1320755,1776.207547,23694.39623,1322.660377,3585.245283,2345.226415,8545.679245,1394.867925,369.2641509,2420.09434,17291.86792,672.1886792,299.2075472,545.5471698,20749.9434,701.2075472,139.5471698,2018.018868,16256.15094,1536,683.0754717,2808.716981,14110.18868,641.7735849,304.2075472,1556.830189,11158.77358,1112.584906,476.4716981,1340.811321,8569.283019,730.2830189,186.1509434,3063.037736,7889.433962,1433.169811,210.7169811,3360.283019,379.5849057,585,53,9.888860224,7.979975287,0.590597715,0.815384615,0.588888889,-1.12438557
+2648,35087.9913,923.8347826,589.4608696,1105.904348,31091.87826,771.6695652,1061.191304,1577.930435,18051.5913,870.0434783,1927.591304,1853.26087,23983.13913,1390.434783,3031.895652,3341.66087,7814.678261,1485.782609,386.226087,2603.252174,17263.82609,489.5043478,344.3130435,819.0695652,20651.6,851.8347826,135.573913,1405.886957,15961.24348,1960.843478,676.7913043,2826.721739,13874.29565,904.2521739,310.6086957,1731.991304,11045.43478,1744.426087,469.5652174,1376.956522,8599.617391,735.5130435,178.8869565,3726.8,7709.130435,1449.391304,535.6782609,3290.652174,557.3391304,591.0173913,115,18.41841965,8.90111626,0.875469966,0.845588235,0.580808081,-0.279580301
+2649,36821.2518,835.3884892,484.6402878,1087.94964,33117.66187,698.6618705,1129.489209,1613.18705,18004.71942,515.2014388,1515.769784,1743.733813,25860.45324,1261.410072,6819.561151,3131.064748,9085.697842,1286.395683,343.6978417,2667.676259,18040.94964,447.1726619,464.2733813,1735.848921,21985.80576,471.2302158,142.028777,2755.143885,17179.30216,2049.920863,482.7553957,2788.705036,14582.55396,624.618705,273.0215827,1622.201439,11375.08633,1142.992806,424.8633094,1302.798561,7909.359712,726.8273381,167.3021583,3928.230216,6888.820144,1287.338129,342.2589928,3251.81295,897.6618705,587.1654676,139,15.87010506,11.43648771,0.693318931,0.926666667,0.661904762,-1.210210862
+2650,29134.5913,802.6956522,555.0347826,1095.93913,15283.66087,527.8217391,388.9956522,1378.304348,7161.478261,389.3217391,382.0130435,1676.721739,11082.8913,993.1391304,9337.547826,3241.5,4099.143478,1044.856522,271.5652174,2310.156522,7766.234783,332.3826087,303.0304348,472.6565217,9520.030435,331.8,109.3869565,7153.869565,7406.817391,1276.434783,447.4695652,2765.286957,5938.86087,572.3043478,220.1,2574.869565,4162.578261,670.626087,339.1173913,1276.26087,2150.108696,582.373913,137.4782609,2978.856522,2322.530435,977.3521739,557.8347826,3041.465217,1092.178261,587.1173913,230,21.16786155,14.13080576,0.74455651,0.958333333,0.821428571,-1.455281461
+2651,43724.55705,944.4832215,645.8724832,1157.711409,13104.0604,450.0604027,466.0402685,1232.832215,5524.85906,360.9731544,774.8187919,1621.872483,9033.053691,884.3892617,3490.422819,1341.872483,3312.14094,916.852349,240.7785235,2463.590604,5681.899329,360.3221477,289.8993289,681.3087248,6798.114094,289.0201342,203.6375839,1884.073826,5076.442953,1587.879195,350.0738255,2910.234899,3928,441.8389262,188.8926174,851.7516779,2331.409396,671.8456376,310.5234899,1250.020134,1094.073826,526.0536913,127.9194631,1273.583893,1278.255034,827.8993289,125.2214765,2858.651007,1140.624161,587.9261745,149,14.46503243,13.25686291,0.400088425,0.949044586,0.662222222,1.152052022
+2652,46431.94262,892.7704918,601.3032787,1156.631148,45276.83607,742.7786885,600.5655738,1823.016393,23449.79508,571.6721311,544.6393443,1776.614754,30758.77869,1339.090164,7466.754098,8417.770492,11782.65574,1448.754098,367.9180328,2343.065574,22958.2623,467.5491803,148.8114754,436.6967213,28622.51639,460.8032787,139.6967213,6708.040984,21019.43443,1557.516393,796.1803279,2815.581967,18098.7377,637.0901639,316.7868852,3798.754098,12342.31967,872.0901639,458.5901639,1301.278689,8795.918033,643.7213115,174.4918033,4178.47541,7526.262295,1384.237705,173.1393443,3315.327869,184.1803279,590.1147541,122,18.4389273,8.69121792,0.881945388,0.938461538,0.552036199,-0.691526615
+2653,29362.52174,906.826087,521.7826087,1058.282609,26349.56522,700.5652174,789.4565217,1532.413043,15202.47826,583.4782609,1490.804348,1775.673913,19839.5,1298.804348,3496.934783,5330.673913,7048.652174,1367.847826,340.5217391,2426.434783,14665.91304,610.4782609,360.7608696,924.1086957,18081.30435,1563.217391,137.9130435,3036.673913,14531.23913,1581.586957,719.5434783,2824.086957,12858.73913,629.7391304,307.6086957,1884.369565,9967.913043,1953.73913,452.0217391,1308.826087,7613.478261,708.6086957,183.0652174,5821.934783,7053.913043,1414.326087,253.3913043,3463.195652,371,586.1086957,46,9.506742464,6.791793871,0.699718536,0.821428571,0.567901235,0.976904761
+2654,15605.9802,1026.980198,601.3267327,1187.148515,14446.30693,793.3366337,477.1386139,1564.475248,7971.326733,601.5544554,419.1287129,1684.316832,11413.70297,1577.990099,1837.29703,1838.425743,4187.633663,1390.118812,389.3762376,2355.445545,8932.217822,502.3861386,160.1881188,452.7128713,10793.22772,466.1485149,129.5148515,1276.217822,8049.90099,1419.70297,589.4257426,2789.960396,7224.930693,614.039604,289,1848.079208,5946.287129,989.9009901,452.4455446,1329.158416,4911.366337,752,183.5841584,1102.891089,4365.108911,1542.148515,550.6831683,3317.217822,649.4950495,588.5841584,101,12.35402586,10.72689661,0.496054165,0.971153846,0.554945055,0.417013173
+2655,38454.39759,1045.192771,627.7349398,1133.963855,36033.03614,785.6024096,660.6626506,1689.493976,18811.56627,618.0481928,488.8433735,1770.433735,25012.20482,1415.156627,8238.686747,4383.349398,8662.445783,1422.722892,371.2048193,2367.506024,19339.78313,482.0361446,148.6144578,439.2048193,22742.72289,439.5060241,137.746988,6268.228916,17160.3012,1555.542169,558.6626506,2822.277108,14897,651.5783133,308.9518072,2043.650602,10939.73494,862.1686747,459.8915663,1302.831325,8348,657.5662651,179.8072289,3616.385542,7201.662651,1428.915663,192.5421687,3463.987952,252.5542169,587.060241,83,10.84914823,9.998700924,0.388113447,0.922222222,0.754545455,-1.540649185
+2656,39660.42667,1116.84,607.32,1157.693333,34759.81333,811.6,840.7466667,1675.16,20558.74667,689.52,738.1733333,1778.04,26927.90667,1477.8,2023.88,2307.96,9246.893333,1485.866667,389.0133333,2421.586667,20035.82667,510.8,226.76,524.1866667,22344.10667,942.2266667,140.8666667,2187.173333,17374.70667,1631.866667,664.0533333,2807.893333,15041.33333,660.8266667,332.5466667,1730.68,11608.42667,1306.946667,473.6133333,1328.013333,8935.96,725.4933333,183.0933333,2610.24,7896.546667,1486.88,235.2933333,3367.6,489.9466667,586.92,75,11.93438887,8.258073894,0.721939522,0.949367089,0.641025641,-1.497772358
+2657,28452.36567,821.880597,553.358209,1080.671642,24337.99254,699.2835821,1009.649254,1546.395522,14285.35821,530.3283582,1525.828358,1930.902985,18823.64179,1259.626866,5232.156716,2458.350746,6917.19403,1286.335821,311.7014925,3064.671642,13982.61194,4642.171642,243.0597015,1410.119403,16853.77612,794.8507463,1030.701493,1561.873134,12640.23134,2081.552239,667.7686567,2808.902985,11112.74627,646.6791045,268.7014925,1485.455224,8746.455224,1518.813433,413.880597,1336.947761,6869.619403,649.9029851,153.1940299,3236.283582,5972.791045,1316.462687,364.1567164,3310.783582,596.2014925,589.8656716,134,15.04567402,12.73037839,0.532999546,0.848101266,0.525490196,0.820683674
+2658,45967.08475,871.1186441,467.5389831,1108.749153,40956.31864,741.7152542,834.7016949,1601.474576,24048.61695,551.9016949,1962.576271,1854.891525,32822.72542,1313.549153,4399.718644,4205.461017,11539.52881,1323.088136,348.8542373,2562.125424,23432.36949,507.2881356,258.9288136,1306.501695,29028.69831,593.9322034,162.7016949,2275.155932,22254.8339,2002.427119,549.3322034,2819.450847,19146.77966,657.9322034,287.0983051,1703.491525,15574.21017,1422.420339,438.1016949,1301.505085,11065.21017,691.1491525,167.2576271,2703.240678,9536.566102,1370.216949,260.9694915,3248.589831,815.5830508,591.9050847,295,23.02714489,16.84639966,0.681746237,0.87797619,0.597165992,-1.136423287
+2659,26856.38122,798.7790055,503.5635359,1062.348066,23806.45304,654.6906077,614,1513.966851,12862.92818,541.4972376,787.441989,1753.127072,18672.1989,1194.265193,6193.552486,3220.066298,6632.198895,1233.281768,316.2430939,2652.370166,13266.56354,423.7900552,1587.78453,829.3093923,16075.81768,526.6961326,125.1823204,3332.911602,12312.96133,1742.740331,593.1933702,2794.723757,10722.62983,609.3425414,262.320442,2139.922652,8334.801105,936.5745856,400.8674033,1373.370166,6030.160221,1061.464088,159.6961326,4876.928177,5239.303867,1250.475138,895.1436464,3207.348066,882.0994475,590.2154696,181,19.54196832,12.54628621,0.766689959,0.870192308,0.67037037,1.20559015
+2660,50498.88889,920.625,552.2777778,1156.986111,51210.88889,768.0972222,680.0277778,1775.5,27688.01389,605.1805556,527.9027778,1789.805556,35696.72222,1380.555556,6099.388889,4471.611111,13079.06944,1492.847222,388.5416667,2387.25,26909.02778,496.0416667,149.5277778,443.4444444,33032.84722,455.0972222,139.6111111,4481.736111,24722.18056,1585.125,727.1111111,2825.736111,21697.13889,659.5694444,342.8611111,2876.972222,15695.09722,908.5694444,480.4444444,1312.208333,11526.16667,678.8333333,192.0833333,3311.930556,10156.40278,1480.652778,253.4305556,3379.527778,233.0972222,588.2638889,72,11.58649597,8.140359744,0.711611634,0.9,0.666666667,-1.390922124
+2661,22288.66765,854.8176471,585.3882353,1110.232353,20547.90294,663.3411765,670.4235294,1538.752941,11661.41765,538.3823529,940.8205882,1778.579412,15449.43529,1242.341176,3489.855882,3118.941176,5615.776471,1324.617647,359.7735294,2480.064706,11927.46471,427.2058824,818.7970588,547.4470588,13749.91176,745.0147059,126.0735294,1910.138235,10331.20294,1572.676471,727.8029412,2824.179412,9122.464706,751.8588235,277.0764706,1666.591176,7290.476471,1229.723529,436.0852941,1345.479412,5757.517647,1036.470588,169.0529412,2712.120588,5136.032353,1371,734.1176471,3267.585294,472.1529412,594.8058824,340,24.76455336,19.68333944,0.606846467,0.839506173,0.566666667,-0.804453362
+2662,37155.1087,890.1195652,475.4456522,1113.869565,32808.54348,759.3369565,929.4130435,1566.978261,18404.43478,551.0326087,2576.01087,1837.554348,25558.81522,1348.402174,3832.804348,3759.532609,8939.75,1301.163043,341.6630435,2793.5,19276.77174,461.5978261,463.6521739,1296.978261,23500.25,429.576087,233.3913043,1597.021739,16979.1413,2092.923913,588.0434783,2810.195652,15097.23913,657.5434783,292.8586957,1837.5,12228.67391,1407.391304,417.7391304,1329.456522,9365.130435,746.7608696,168.2826087,3866.25,8013.369565,1462.673913,436.3913043,3188.75,708.8043478,588.1956522,92,14.48452145,8.593209573,0.805004688,0.893203883,0.657142857,-1.161380411
+2663,38536.63366,848.1386139,505.0990099,1079.70297,31584.22772,690.0594059,862.9108911,1548.237624,18386.94059,522.4059406,2110.722772,1781.613861,25811.9604,1260.613861,3287.831683,4168.049505,9127.227723,1277.643564,345.1287129,2898.356436,18609.9604,472.029703,725.0990099,1856.792079,22157.25743,2222.29703,249.2772277,1898.970297,17590.82178,1676.049505,596.1287129,2818.366337,15568.74257,729.4455446,277.4554455,1945.089109,12137.69307,1608.415842,416.029703,1321.207921,8554.861386,814.970297,169.6039604,6369.158416,7605.910891,1335.247525,983.3069307,3184.455446,852.1089109,589.1584158,101,13.42523525,9.954523394,0.670976619,0.952830189,0.601190476,-0.887962608
+2664,38384.76842,836.7052632,500.7368421,1081.6,34912.93684,701.3157895,503.4210526,1603.926316,18705.93684,497.4631579,539.7578947,1734.168421,25620.92632,1240.442105,4464.326316,3259.221053,9320.421053,1281.357895,334.6105263,2459.084211,18109.71579,456.8947368,1240.210526,532.4736842,22321.06316,435.2526316,126.4526316,3006.789474,16883.13684,1550.115789,603.9473684,2831.368421,14295.24211,672.7052632,276.0526316,1990,10844.70526,864.9368421,418.6105263,1308.463158,7332.452632,927.7473684,163.0105263,5991.957895,6431.642105,1265.115789,792.0631579,3280.284211,936.3368421,591.6315789,95,15.00643686,8.291956828,0.833473119,0.940594059,0.703703704,-0.086790559
+2665,44833.92063,929.015873,590.9285714,1143.087302,40048.07937,743.9047619,546.9206349,1740.603175,23137.78571,530.7857143,472.9920635,1719.007937,31498.81746,1321.238095,4230.277778,4754.928571,11331.49206,1366,377.6746032,2385.873016,21744.75397,457.1269841,1667.166667,529.3333333,26703.87302,449.4126984,136.0555556,3057.02381,21381.31746,1592.81746,681.7777778,2803.111111,17936.96825,624.0555556,300.4285714,2462.373016,13328.87302,899.968254,435.1984127,1329.285714,8535.642857,1080.142857,168.6349206,3855.420635,7627.365079,1349.952381,283.6984127,3265.31746,972.4444444,590.3650794,126,18.22370672,10.70826711,0.809150877,0.812903226,0.5,-1.240411331
+2666,33075.63303,810.5779817,535.6330275,1076.385321,29366.30275,654.5412844,643.5412844,1633.926606,15647.44037,480.8440367,755.9449541,1775.862385,22315.53211,1192.944954,5863.688073,3414.027523,8182.633028,1246.155963,324.6880734,2475.990826,15388.52294,421.3211009,291.2110092,1023.990826,19712.14679,430.440367,124.3302752,4204.844037,14772.72477,1667.715596,622.5963303,2866.146789,12077.79817,982.7431193,272.1284404,9102.87156,8915.87156,856.8256881,395.6238532,1324.834862,5230.220183,740.8348624,154.5412844,2541.605505,5143.587156,1201.211009,1941.321101,3266,1027.972477,590.3853211,109,12.60325239,11.21351098,0.456484185,0.956140351,0.644970414,-1.291026578
+2667,53698.5,927.7669492,596.5805085,1152.436441,52716.54661,795.2161017,676.0932203,1823.224576,26285.97034,589.1822034,1413.961864,1793.834746,34625.13983,1373.622881,6099.605932,8390.114407,13199.08898,1486.360169,386.8135593,2450.309322,25983.92797,476.3305085,696.75,1038.148305,31686.38136,468.4237288,321.8008475,5433.563559,23131.72034,1694.436441,932.6525424,2829.127119,19701.55085,638.7627119,326.8177966,4483.758475,13019.41949,965.2881356,469.5762712,1322.838983,9222.635593,806.4788136,181.1271186,4262.881356,7739.317797,1388.622881,238.8432203,3313.631356,168.9957627,595.7669492,236,20.08261929,15.2055563,0.653240993,0.951612903,0.661064426,-0.498683071
+2668,23139.02,921.36,517.7266667,1083.046667,21702,695.4066667,705.26,1575.093333,11508.09333,554.2733333,537.2733333,1805.373333,15048.04,1264.326667,4883.8,2397.126667,5731.793333,1428.52,339.1866667,2366.613333,11199.75333,2491.566667,2008.573333,475.5733333,13117.94667,442.62,129.7266667,1691.306667,9657.993333,1612.6,693.8666667,2884.286667,8642.633333,679.0533333,278.7533333,1335.713333,6528.033333,879.58,416.6466667,1302.426667,5167.846667,1347.413333,167.78,2160.733333,4470.846667,1367.633333,133.6866667,3421.693333,340.1066667,591.5666667,150,15.15284437,13.13943753,0.498087446,0.925925926,0.666666667,0.798001637
+2669,21689.20354,922.2035398,617.539823,1141.637168,19358.84956,724.0353982,650.0442478,1604.690265,10694.29204,540.5044248,554.2212389,1739.752212,14687.9292,1401.707965,1433.185841,1278.654867,5159,1279.840708,342.7079646,2405.469027,10889.22124,521.1504425,163.0176991,439.3451327,13092.88496,427.699115,126.3185841,921.7610619,9832.637168,1427.159292,566.8938053,2791.831858,8742.743363,786.8141593,281.4336283,1581.867257,7163.274336,1028.79646,420.7522124,1311.053097,5566,660.619469,166.3539823,1557.955752,4751.548673,1481.336283,1768.265487,3119.079646,696,590.4336283,113,12.86775774,11.26573119,0.483216811,0.941666667,0.724358974,1.07672978
+2670,26901.78102,894.7445255,552.729927,1088.905109,25626.48175,705.6350365,498.2846715,1587.145985,13247.44526,494.6642336,487.919708,1711.350365,19034.74453,1261.810219,3975.29927,2844.262774,6791.372263,1253.532847,335.5839416,2383.218978,13201.64964,435.2773723,3092.40146,530.2627737,16046.32847,424.0218978,128.3868613,3349.291971,12006.39416,1580.824818,530.5547445,2839.335766,10146.10949,788.0583942,273.0729927,1875.773723,7849.956204,809.6277372,402.1386861,1358.335766,5341.605839,1528.233577,160,4649.051095,4699.20438,1270.985401,2195.072993,3284.532847,946.3065693,594.1824818,137,14.60610527,12.56970174,0.509317641,0.907284768,0.611607143,0.023931496
+2671,25900.81569,829.7882353,540.5254902,1063.152941,23848.72941,690.027451,560.172549,1504.945098,13218.22353,535.5803922,675.0235294,1784.023529,17130.63922,1234.545098,6028.690196,4703.882353,6302.580392,1390.262745,340.3294118,2376.568627,12253.35686,436.6470588,1310.407843,499.3568627,14828.5098,702.5019608,128,3722.101961,11445.20392,1488.066667,776.172549,2804.254902,9950.87451,654.6431373,278.3294118,1939.105882,7404.521569,879.5294118,427.4588235,1327.835294,5700.152941,925.0235294,175.854902,6343.011765,5133.596078,1333.592157,983.2862745,3349.741176,313.3803922,598.0784314,255,29.38687423,11.68231396,0.917586969,0.867346939,0.485714286,-0.590744515
+2672,26519.64773,930.3295455,592.3295455,1123.465909,23681.45455,719.1704545,924.8181818,1586.147727,13824.34091,581.3295455,1306.625,1808.920455,18641.09091,1355.704545,2628.431818,3252.659091,6728.034091,1427.215909,355.1477273,2555.306818,14084.17045,498.6477273,361.0681818,702.9204545,16687.52273,1065.670455,136.1363636,1836.75,12658.76136,1614.840909,662.9431818,2816.568182,11092.21591,670.7045455,296.8636364,1788.965909,8814.397727,1626.556818,455.9545455,1346.431818,6757.829545,851.0113636,177.625,2638.147727,6174.375,1432.215909,267.8295455,3389.852273,498.6136364,590.8863636,88,14.36924407,8.091677096,0.826371893,0.916666667,0.571428571,-0.898547172
+2673,24951.57,1028.25,836.25,1169.82,21174.01,783.41,789.75,1702.65,12924.69,594.01,554.76,1814.41,16889.15,1424.58,899.08,1016.69,5637.1,1408.11,360.49,2431.7,11912.71,539.61,143.17,478.66,14090.19,444.26,135.62,904.94,11273.51,1524.39,658.59,2829.78,9785.24,685.49,302.24,1850.28,7681.89,854.67,458.3,1345.32,5791.93,639.7,166.34,1323.82,5291.84,1458.63,2447.65,3339.28,545.66,591.94,100,12.81307414,10.26050345,0.598953379,0.909090909,0.641025641,0.693605315
+2674,44918.75532,867.5106383,464.7659574,1101.914894,39125.92553,770.9148936,927.287234,1590.202128,23001.74468,547.3404255,1814.542553,1797.276596,31142.26596,1332.351064,3664.106383,3533.734043,11293.35106,1318.946809,344.0531915,2479.680851,23458.70213,469.1276596,215.6382979,1955.553191,29536.43617,468.2234043,940.4148936,1846.5,21613.34043,1999.361702,620.1595745,2815.244681,19282.7234,622.9787234,289.0531915,1911.06383,15585.31915,1317.276596,434.3617021,1298.457447,11531.96809,684.9893617,169.1702128,4637.62766,10208.38298,1428.755319,410.7659574,3252.638298,717.7021277,592.6914894,94,12.94754152,9.576874912,0.672972567,0.930693069,0.61038961,-0.156421581
+2675,41689.27143,864.7571429,552.8285714,1103.6,36172.82857,710.4285714,657.8428571,1624.771429,21310.7,541.8714286,803.5428571,1759.571429,29410.71429,1309.128571,4719.857143,4061.214286,10623.64286,1297.228571,337.4714286,2454.028571,21334.48571,605.3428571,257.1857143,1053.728571,26702.58571,438.0571429,156.2,4257.485714,19721.48571,1644.985714,812.4285714,2795.571429,17291.88571,626.5285714,278.5,2236.414286,14615.04286,1082.885714,419.3857143,1306.028571,10098.05714,747.3285714,165.1285714,6114.8,8984.9,1382.785714,351.3428571,3327.3,785.4428571,591.4714286,70,13.00459935,7.263466581,0.829483922,0.909090909,0.578512397,-0.625365906
+2676,40902.63248,920.5726496,611.2051282,1127.239316,18819.15812,474.5512821,313.3247863,1250.777778,9553.145299,369.6410256,507.1239316,1630.260684,13640.05128,945.991453,4699.559829,2112.324786,5162.679487,993.8931624,260.4487179,2365.059829,9379.102564,305.7051282,180.3034188,547.2863248,11545.03846,293.2905983,108.1153846,2623.260684,8965.064103,1412.008547,432.7692308,2778.662393,7197.747863,477.0641026,202.5,1311.534188,5090.482906,674.7521368,329.2264957,1259.141026,2624.606838,534.7478632,129.6752137,1108.850427,2694.478632,908.2649573,110.5683761,2948.905983,1070.521368,592.6153846,234,22.10227802,13.72578553,0.783800854,0.955102041,0.795918367,-1.32107168
+2677,40018.21019,889.522293,581.6624204,1136.050955,15204.42038,503.2738854,394.0828025,1349.292994,6595.757962,381.1656051,586.0955414,1672.847134,10555.70064,940.2929936,6518.796178,2423.070064,3904.910828,985.5605096,259.5923567,2346.611465,7002.929936,298.9936306,140.522293,565.866242,8720.369427,306.910828,102.4585987,4025.675159,6477.229299,1675.375796,399.1082803,2780.643312,5190.802548,516.477707,203.044586,1496.713376,3425.165605,760.089172,325.7388535,1265.528662,1666.636943,522.3312102,131.1464968,1900.031847,1861.503185,910.7070064,198.3057325,2942.980892,1115.840764,592.1910828,157,16.029202,12.50369149,0.625708439,0.969135802,0.71040724,-1.420400176
+2678,58297.03659,943.5487805,595.8170732,1158.463415,57022.70732,813.6829268,677.6463415,1826.390244,31424.04878,613.5731707,592.5731707,1783.365854,40860.20732,1455.280488,7166.04878,6296.304878,15395.52439,1543.695122,397.6463415,2367.597561,29980.35366,506.7195122,151.9878049,435.5853659,38727.89024,471.2804878,147.9146341,4636.121951,28734.34146,1651.378049,791.6219512,2811.695122,24570.57317,678.2073171,354.3780488,3065.560976,17420.10976,939.1219512,500.597561,1316.719512,12333.70732,683.8902439,188.5731707,2279.085366,10785.70732,1500.231707,158.9146341,3379.695122,204.1707317,591.1341463,82,11.59982739,9.26082406,0.602182079,0.964705882,0.630769231,-1.127578376
+2679,39087.31579,874.1637427,567.374269,1103.690058,37554.69006,720.1871345,653.1871345,1639.590643,19858.94737,560.4152047,527.5964912,1776.345029,25796.15789,1322.859649,8258.654971,4610.339181,9442.982456,1364.80117,379.2163743,2398.333333,19848.66082,1093.94152,187.5789474,454.994152,23978.1345,449.9122807,135.4619883,5178.660819,18450.31579,1525.71345,756.4912281,2812.415205,16136.36842,704.497076,306.0292398,2911.187135,11671.83626,889.8070175,451.9298246,1312.54386,8734.690058,674.1461988,181.4795322,5951.608187,7873.444444,1401.280702,325.8596491,3354.888889,275.1812865,593.9824561,171,20.19138026,10.90574603,0.841588722,0.944751381,0.633333333,-0.982701891
+2680,37145.02688,1012.021505,543.4032258,1096.483871,32713.10753,799.6827957,917.8924731,1563.747312,19132.69355,616.1182796,1943.489247,1777.860215,24961.62366,1433.887097,2219.263441,2702.747312,8584.806452,1413.870968,364.2473118,2623.602151,16589.94624,488.9677419,162.9892473,1218.333333,20209.74194,492.8655914,381.8494624,1068.284946,15131.94624,1956.962366,648.311828,2818.258065,13549,789.983871,304.8817204,1635.543011,10720.83333,1237.978495,459.5591398,1336.569892,8182.532258,693.9408602,175.8172043,2335.935484,7306.424731,1475.284946,3677.849462,3345.66129,506,598.311828,186,22.66020544,10.9609351,0.875229135,0.902912621,0.596153846,-0.213534829
+2681,33465.38824,851.2705882,513.5764706,1069.494118,29690.89412,724.2235294,942.4,1521.188235,17468.38824,538,1775.294118,1807.082353,23492.08235,1304.211765,5703.376471,2706.988235,7940.941176,1292.576471,323.4941176,2916.105882,16970.10588,1624.647059,192.9764706,1110.023529,20155.18824,1245.576471,434.1647059,1070.117647,15602.31765,1989.870588,676.1882353,2805.423529,13844.14118,664.3647059,291.9411765,1373.858824,10831.38824,1621.505882,434.8470588,1314.941176,8215.482353,650.3529412,163.9764706,3213.411765,7670.6,1344.505882,402.8470588,3319.4,587.4588235,593.7764706,85,13.54082789,9.036299012,0.74475565,0.85,0.551948052,0.287073911
+2682,20963.73714,1020.577143,516.04,1089.594286,18577.45143,752.5257143,454.7371429,1549.165714,10543.71429,563.4057143,391.3542857,1736.017143,14417.92571,1497.931429,1108.451429,1127.862857,5178.148571,1332.028571,350.2685714,2364.685714,8151.36,462.3085714,131.4057143,439.6514286,9913.851429,428.0114286,120.6171429,869.3485714,7583.748571,1334.514286,589.9771429,2797.205714,6726.325714,629.4742857,257.9542857,1704.931429,5529.897143,1008.828571,407.7885714,1304.548571,4357.325714,1460.68,163.5657143,1280.914286,3866.748571,2963.942857,2520.862857,3291.314286,660.0914286,594.0857143,175,19.24189985,11.74445733,0.792125299,0.972222222,0.643382353,-0.841958064
+2683,21562.86093,900.8145695,488.5496689,1072.543046,18313.56954,685.3178808,440.8278146,1488.05298,10394.6755,509.0662252,438.2847682,1696.807947,14680.88742,1274.119205,2056.390728,1486.304636,5282.165563,1213.682119,336.0264901,2416.847682,10562.11258,430.1125828,206.6622517,554.8807947,12651.7351,460.6556291,129.2781457,1234.503311,10121.90066,1421.119205,461.5364238,2822.509934,8862.07947,812.3245033,262.9006623,1474.940397,6996.18543,860.1986755,410.5231788,1294.821192,4946.854305,643.9801325,164.8013245,2360.847682,4549.370861,1318.456954,1583.278146,3158.172185,863.8940397,594.3708609,151,15.79838932,12.35260862,0.623415941,0.94375,0.629166667,1.067201477
+2684,44255.25731,921.2807018,558.1988304,1133.982456,39251.47368,748.5263158,641.0701754,1729.690058,22703.64912,536.1754386,518.5438596,1748.748538,31517.4152,1368.491228,4973.304094,4404.847953,11050.96491,1354.362573,366.0350877,2457.538012,21707.4269,467.4444444,1817.912281,597.4619883,26702.05263,467.8596491,136.0292398,3204.783626,21137.53216,1646.549708,644.497076,2807.035088,18001.52632,775.8888889,302.122807,2053.087719,13730.08772,909.5497076,447.8070175,1339.339181,8902.631579,1155.409357,173.7426901,3832.339181,7966.935673,1408.169591,633.4269006,3307.391813,959.4327485,595.6725146,171,18.774234,11.99061777,0.769477317,0.914438503,0.692307692,-0.210501787
+2685,42140.125,1041.1,575.9166667,1117.4,39528.375,769.5416667,813.9583333,1635.791667,20906.775,610.6416667,1046.391667,1783.566667,27182.54167,1353.15,7166.966667,4834.783333,9585.366667,1399.625,352.9,2610.025,20233.24167,473.375,351.1916667,659.75,24475.24167,448.125,163.1833333,5193.9,18812.18333,1875.5,688.5916667,2828.591667,16328.70833,613.575,307.975,1764.766667,11827.85833,1021.108333,461.175,1320.75,9154.416667,712.0833333,177.0916667,3916.066667,8042.841667,1358.05,216.225,3474.833333,294.9416667,596.2166667,120,15.59395241,10.0344287,0.765461189,0.975609756,0.588235294,-0.246087854
+2686,37273.76074,1143.932515,586.3128834,1106.625767,33546.84049,819.6441718,738.0920245,1612.644172,18921.9816,647.4233129,1045.159509,1766.773006,24235.02454,1456.423313,5087.797546,4226.202454,8475.92638,1431.871166,367.4417178,2438.871166,19366.54601,578.5521472,270.6319018,1020.226994,19573.10429,584.196319,132.208589,3621.742331,15201.03067,1872.116564,658.607362,2827.546012,13421.03681,654.3680982,309.7177914,1599.306748,10154.47853,1143.006135,451.7484663,1317.687117,7911.625767,659.5214724,171.3496933,2535,7016.521472,1379.840491,243.3865031,3546.251534,364.3865031,593.8834356,163,21.16664653,10.23484381,0.875324261,0.890710383,0.617424242,1.549245152
+2687,26110.48,1121.6,581.32,1106.08,24547.06,794.78,1046.46,1587.89,13366.34,644.57,1314.02,1803.65,17848.23,1388.59,4898.65,5007.13,6161.28,1358.09,373.03,2534.23,14181.13,494.41,587.68,868.56,14392.41,1447.31,130.68,2955.54,11229.23,1653.19,677.14,2816.07,9889.87,632.27,286.56,2011.41,7576.54,1603.34,447.43,1340.58,6073.56,843.9,180.59,5506.67,5124.75,1327.24,222.12,3470.82,380.86,593.46,100,13.32355098,9.793048004,0.67804774,0.925925926,0.694444444,-0.87926681
+2688,30663.29545,892.7878788,722.6818182,1100.083333,27329.67424,717.9924242,726.2727273,1599.795455,16048.90152,538.5075758,1198.621212,1773.75,21139.14394,1362.598485,5279.204545,2804.613636,7564.659091,1365.5,341.5909091,2572.181818,15395.57576,528.2348485,164.8333333,995.0984848,19193.15909,506.4015152,170.0833333,1676.484848,13974.75758,1947.022727,712.8409091,2819.666667,12405.81818,928.9090909,292.3863636,1537.015152,9913.19697,1373.878788,451.5,1326.886364,7689.348485,648.2424242,169.3712121,2787.931818,6877.75,1418.348485,653.0454545,3378.810606,577.9469697,595.1363636,132,15.34804087,11.49853632,0.662359749,0.88590604,0.676923077,0.217896227
+2689,41501.76724,866.0344828,467.8189655,1113.060345,38104.05172,717.0431034,1077.956897,1564.939655,21519.5431,551.4741379,2253.224138,1876.913793,29717.2931,1327.163793,4283.336207,4357.715517,10607.81034,1332.163793,348.612069,2674.181034,22314.00862,457.7931034,155.7758621,1615.698276,27768.47414,500.5775862,401,2044.818966,20052.38793,2066.224138,611.8793103,2801.103448,17857.87931,615.3448276,289.7672414,1911.112069,14489.61207,2301.155172,438.9827586,1296.060345,10679.47414,662.0172414,167.5775862,3879.413793,9314,1411.767241,267.3189655,3268.655172,730.3965517,592.6465517,116,14.78692,10.04152049,0.734063091,0.966666667,0.828571429,-1.343235411
+2690,16327.93077,714.2615385,492.4846154,1038.015385,16165.66154,652.0923077,610.0307692,1460.107692,7732.515385,451.1,969.3076923,1750.761538,12156.33077,1135.3,4113.923077,2680.984615,4406.3,1143.138462,308.2538462,2460.353846,8384.746154,397.0076923,625.6769231,1192.230769,10509.49231,455.5307692,153.7692308,3117.230769,7850.930769,1579.592308,525.6615385,2803.076923,6693.623077,1000.515385,237.5,1969.484615,5433.446154,1000.576923,378.8923077,1294.9,3890.238462,734.7615385,158.4076923,5862.461538,3324.753846,1152.2,1113.892308,3160.953846,911.9,593.4307692,130,15.60238726,11.70757391,0.661017281,0.828025478,0.546218487,1.520261004
+2691,42801.87861,961.0751445,596.6589595,1120.150289,38415.54913,752.0809249,665.8612717,1709.479769,21384.58382,544.6184971,452.8728324,1735.473988,29639.61272,1315.364162,5185.289017,3613.606936,10684.17919,1359.416185,362.3930636,2353.317919,20744.41618,446.7745665,779.0404624,474.7976879,25668.16763,439.4508671,134.7745665,4044.699422,20215.07514,1528.583815,639.0289017,2801.959538,16942.61272,625.3179191,287.5606936,2501.277457,12600.80925,860.5722543,437.0346821,1322.630058,8026.121387,817.8265896,162.1618497,2731.693642,7450.184971,1312.236994,256.0982659,3343.618497,986.5549133,598,173,21.45778346,10.57976683,0.870000799,0.930107527,0.823809524,0.041446411
+2692,38181.49057,929.6886792,538.0660377,1088.09434,35631.34906,735.4339623,978.0849057,1602.377358,19695.51887,587.8584906,1036.273585,1752.688679,25655.04717,1320.283019,6425.415094,4161.622642,9063.339623,1373.358491,358.1037736,2412.867925,19534.93396,533.4433962,358.009434,598,23139.28302,908.0754717,132.9245283,4465.207547,18517.76415,1551.028302,669.6509434,2809.122642,16062.06604,621.4528302,297.6320755,1683.90566,11795.01887,969.7264151,464.7924528,1312.915094,9024.424528,696.4622642,179.8301887,4384.471698,8278.707547,1369.962264,248.8396226,3404.971698,304.1320755,597.4528302,106,21.83818309,6.441741824,0.955504635,0.883333333,0.392592593,-0.591629834
+2693,28414.17813,864.70625,500.228125,1069.165625,24447.20313,681.68125,693.734375,1489.528125,14400.825,553.9125,936.709375,1790.325,18723.27188,1310.146875,4203.265625,3049.8375,6727.971875,1264.05625,317.059375,2543.3875,13640.2375,495.484375,564.05,884.56875,16188.35625,703.325,153.15625,2158.034375,12537.68438,1734.603125,720.25,2785.28125,11042.475,753.346875,262.240625,1625.9375,8603.890625,1133.996875,398.996875,1322.771875,6735.821875,759.475,156.384375,3332.9625,5920.509375,1343.56875,908.640625,3263.121875,618.4,599.99375,320,23.49257831,18.19994889,0.632315999,0.938416422,0.666666667,-1.072726339
+2694,33392.59302,992.0232558,483.9651163,1101.546512,28514.74419,747.3372093,593.5581395,1577.930233,17159.84884,562.3139535,408.6511628,1713.930233,22347.23256,1438.116279,1757.895349,2041.860465,7555.023256,1323.081395,343.0813953,2336.174419,16582.13953,480.6627907,234.7674419,801.1046512,19986.45349,445.8255814,127.6976744,1532.255814,15411.23256,1453.034884,578.2209302,2808.197674,13718.48837,745.744186,287.5232558,1754.639535,10813.63953,1874.151163,431.8488372,1323.174419,8393.023256,872.3953488,169.6744186,2976.023256,7250.895349,1656.767442,8733.127907,3336.837209,681.2674419,593.4767442,86,12.67749234,9.052186791,0.700108915,0.886597938,0.601398601,-1.124106734
+2695,43334.36713,864.8286713,494.0979021,1100.437063,38451.90909,705.8741259,732.3076923,1594.22028,22310.52098,539.1573427,1171.842657,1760.520979,30157.52098,1315.744755,4259.737762,3400.611888,10732.93357,1310.437063,342.493007,2376.367133,21663.31119,2590.741259,280.7552448,652.458042,27092.96503,500.3846154,135.3216783,3065.968531,20582.17133,1613.426573,634.5314685,2795.073427,17836.28322,705.3286713,290.965035,1814.22028,14655.54895,1300.671329,433.9160839,1298.237762,10205.65385,696.6503497,169.9230769,4895.877622,8998.276224,1375.93007,413.3006993,3247.716783,798.6713287,600.7202797,286,25.55942458,14.80743051,0.815090617,0.907936508,0.635555556,0.342252052
+2696,26273.79021,812,536.8671329,1078.573427,22462.64336,660.6713287,567.2937063,1543.41958,12627.15385,492.1118881,720.0979021,1743.615385,17828.35664,1240.93007,4102.006993,3576.258741,6391.440559,1221.223776,323.3286713,2402.566434,12723.78322,1146.559441,746.6503497,706.6783217,15522.25874,516.6153846,139.9090909,2415.517483,11847.76923,1627.839161,778.3706294,2787.174825,10197.02797,1343.111888,258.006993,2017.034965,8199.573427,918.965035,395.7482517,1306.153846,5919.839161,799.5384615,166.4755245,8154.062937,5132.06993,1255.244755,604.3426573,3189.867133,841.7272727,596.0559441,143,14.52450013,12.91370483,0.457716775,0.934640523,0.595833333,0.460188375
+2697,44949.15596,947.0963303,630.1972477,1167.857798,43416.56422,770.9633028,672.1743119,1841.591743,23120.88991,548.7981651,536.7981651,1755.577982,32331.48624,1344.788991,6287.56422,5215.454128,11622.66055,1393.62844,368.853211,2476.261468,22625.34404,467.2247706,597.5137615,610.7385321,28413.27982,470.4174312,138.4174312,4773.201835,21377.65138,1644.899083,674.0229358,2814.399083,17982.03211,662.1238532,304.9495413,3752.220183,13326.83486,953.4724771,444.5917431,1324.302752,8304.477064,809.8623853,172.146789,4040.490826,7694.050459,1375.582569,322.4816514,3328.224771,996.1422018,601.559633,218,30.12667047,10.02032717,0.943065692,0.825757576,0.648809524,-0.015218313
+2698,46253.18987,897.2278481,540.6835443,1130.43038,40013.70886,695.5443038,772.3924051,1752.924051,21935.10127,514.2531646,757.3670886,1742.329114,30105.55696,1265.303797,8336.379747,4741.417722,11161.81013,1316.658228,351.2025316,2638.670886,21265.97468,442.5443038,203.1392405,804.4683544,27190.87342,452.1518987,128.0632911,5388.64557,20524.44304,1625.974684,623.2405063,2823.126582,17286.87342,602.9620253,284.2658228,2371.405063,12921.53165,1111.367089,427.7468354,1298.835443,7594.253165,670.4303797,163,3353.78481,7410.64557,1290.417722,219.5316456,3274.139241,1004.379747,595.5696203,79,11.94574789,9.260112109,0.631739681,0.929411765,0.552447552,0.107190994
+2699,40981.02,909.11,623.19,1129.96,38719.595,732.59,720.005,1712.98,21245.99,580.395,554.635,1778.48,27448.155,1332.99,6962.095,5933.45,10192.57,1402.83,364.985,2427.255,20482.515,519.57,149.055,438.14,24800.165,439.49,137.25,5381.93,18642.885,1583.56,787.35,2820.635,16528.9,644.645,314.66,2868.25,11641,910.36,465.705,1316.23,8439.48,646.86,177.545,4305.37,7560.625,1399.955,203.52,3358.185,239.885,596.74,200,20.51432905,13.14644832,0.767672612,0.884955752,0.634920635,-1.564673805
+2700,45739.64516,947.6451613,565.827957,1135.784946,42688.4086,729.3225806,463.4193548,1704.129032,22713.76344,582.0537634,480.6236559,1813.247312,29593.2043,1327.096774,7463,4309.268817,10606.69892,1402.795699,359.2688172,2353.258065,22821.12903,476.6451613,143.7204301,424.2903226,27094.60215,431.8817204,138.2473118,5775.182796,20652.19355,1530.795699,674.172043,2850.354839,18059.06452,625.827957,315.6129032,1844.462366,13139.44086,877.5376344,466.9569892,1305.903226,9874.236559,662.1935484,179.5698925,3158.376344,8586.354839,1399.322581,163.6666667,3469.88172,255.6021505,595.6129032,93,14.89710483,8.504646591,0.821024764,0.894230769,0.550295858,-0.914612027
+2701,27111.70732,940.300813,599.8699187,1100.715447,25083.86992,715.8943089,656.7642276,1601.105691,13944.14634,565.1382114,634.8455285,1756.121951,18202.52846,1313.146341,7148.666667,3808.219512,6785.01626,1428.04878,346.9918699,2371.333333,13632.31707,935.0243902,2286.073171,487.2682927,15732.55285,423.4308943,129.601626,3304.894309,12030.69919,1723.01626,688.3495935,2909.577236,10519.47154,675.2113821,291.2601626,1643.658537,7956.788618,916.5528455,439.5365854,1341.365854,6325.772358,1176.617886,170.6666667,4160.089431,5575.764228,1371.01626,175.7723577,3298.495935,329.1463415,597.1707317,123,13.84139048,11.56376619,0.549569043,0.953488372,0.585714286,-0.632343148
+2702,22452.63492,841.3492063,527.8492063,1069.238095,20853.97619,697,1044.880952,1481.31746,11398.25397,531.3492063,2329.690476,1979.619048,15153.64286,1268.071429,4778.095238,4128.293651,5510.928571,1308.388889,329.6428571,2639.968254,10212.40476,427.5793651,1630.81746,1339.968254,12379.00794,431.7698413,127.5793651,2970.412698,9378.380952,2044.261905,763.2619048,2839.087302,8317.095238,700.5079365,267.952381,1636.793651,6374.785714,2082.555556,434.984127,1489.97619,5056.944444,1053.150794,172.6031746,7088.690476,4496.277778,1346.007937,362.8571429,3179.492063,423.1746032,596.8095238,126,14.36845292,11.28996937,0.618547967,0.940298507,0.7,-0.21527356
+2703,20647.74312,985.440367,716.9908257,1146.981651,20202.15596,761.1834862,1025.330275,1662.844037,10420.11009,571.2201835,832.3394495,1806.366972,13693.3211,1405.614679,1686.972477,1894.715596,5133.009174,1500.862385,359.293578,2470.256881,11063.55046,523.6513761,206.853211,690.8990826,12262.56881,705.3577982,133.6330275,1476.284404,8976.40367,1589.66055,654.2201835,2826.880734,8091.917431,737.0091743,300.9816514,1783.211009,6494.614679,1146.862385,465.4770642,1337.027523,5175.440367,720.9357798,181.0183486,1990.036697,4332.018349,1455.293578,245.8256881,3375.12844,485.8807339,596.0825688,109,13.47447712,11.04332402,0.572974101,0.900826446,0.648809524,-1.307832446
+2704,23470.56395,1011.906977,524.9651163,1093.645349,21115.88372,760.0290698,514.0755814,1525.639535,11959.59884,591.3546512,415.1976744,1721.261628,15736.36047,1444.395349,1006.098837,869.9709302,5490.093023,1351.19186,355.4186047,2380.587209,10972.84884,473.2674419,142.2848837,480.9825581,13302.78488,417.4476744,134.5930233,849.122093,9711.854651,1457.302326,630.7093023,2845.436047,8735.22093,669.5116279,290.8430233,1960.540698,6989.267442,829.005814,443.9651163,1316.546512,5541.94186,682.6511628,175.0930233,2261.581395,4950.069767,1654.22093,14377.59302,3270.232558,528.8662791,597.4302326,172,21.05683918,11.03752411,0.851608954,0.864321608,0.565789474,-0.708692123
+2705,53590.89313,962.4580153,608.0687023,1201.045802,53426.52672,818.5954198,766.6183206,1977.442748,27035.1374,607.7175573,547.6183206,1789.610687,35812.05344,1436.633588,7359.534351,6167.763359,13283.35878,1504.51145,403.2519084,2395.740458,26002.12214,507.0305344,2505.80916,464.2061069,31458.45802,491.2137405,144.5572519,8264.29771,22619.29771,1719.465649,567.5419847,2842.19084,18779.54198,631.1984733,335.3740458,5890.244275,11233.30534,889.0839695,468.8854962,1327.068702,7973.21374,1274.587786,180.8320611,3748.931298,6876.152672,1368.633588,240.4274809,3359.221374,151.1603053,596.5572519,131,15.52939143,10.92620822,0.710613573,0.916083916,0.727777778,1.418726818
+2706,44147.24771,878.4220183,569.9633028,1143.357798,43387.86239,742.2018349,654.3394495,1756.899083,22224.06422,574.2018349,714.2477064,1809.165138,29284.26606,1328.036697,7430.275229,6988.201835,11024.82569,1420.165138,372.8073394,2406.825688,21969.90826,462.1376147,145.2844037,595.9174312,27823.20183,450.9174312,142.1376147,5025.568807,20168.01835,1641,753.6055046,2821.678899,17369.36697,661.1651376,323.8623853,4071.761468,12100.92661,886.4495413,465.7798165,1317.183486,8924.825688,659.3761468,178.8715596,3151.577982,7421.311927,1412.93578,246.4587156,3359.917431,191.4495413,595.9908257,109,15.52914317,9.123814745,0.809203448,0.947826087,0.605555556,-1.065700342
+2707,30694.74242,979.6136364,533.8939394,1090,28009.40909,747.1893939,977.5075758,1573.522727,16309.28788,629.3333333,1263.840909,1789.19697,21763.47727,1359.757576,4905.916667,2885.575758,7753.856061,1389.681818,389.0454545,2859.916667,15772.09848,472.5530303,303.4848485,946.7121212,17785.56818,450.2121212,131.3106061,2257.863636,13982.5,1946.80303,621.3030303,2822.848485,12165.33333,652.969697,291.2878788,1358.159091,9566.992424,1354.469697,443,1342.340909,7368.477273,788.1060606,176.8712121,2873.189394,6615.893939,1382.856061,259.0909091,3374.712121,395.2651515,596.0984848,132,15.80500215,10.74557062,0.733319526,0.936170213,0.75,1.222466165
+2708,40356.77876,993.7256637,529.2477876,1092.566372,38073.12389,806.8230088,712.2920354,1664.336283,22137.72566,604.9823009,1117.876106,1772.088496,29524.83186,1414.39823,5270.778761,3614.654867,10413.52212,1356.539823,360.460177,2349.380531,21381.38053,464.3451327,155.0884956,926.9557522,26442.51327,449.0530973,200.7610619,4443.610619,19170.76106,1893.061947,640.300885,2804.061947,17018.44248,625.8141593,286.9292035,1762.185841,13830.26549,1144.495575,433.6460177,1312.513274,9945.725664,681.6814159,166.0265487,2981.061947,8197.964602,1376.274336,293.5044248,3367.309735,772.9380531,597.2300885,113,14.53707763,11.22632667,0.635313043,0.875968992,0.668639053,0.519516764
+2709,24817.66071,797.0892857,500.9107143,1055.482143,21341.71429,809.9464286,959.4285714,1507.571429,12028.33929,509.1607143,2542.5,1867.107143,17573.92857,1217.107143,6077.535714,3920.053571,6414.446429,1255.714286,317.6964286,2560.910714,12087.69643,436.4285714,466.3571429,1984.035714,14920.76786,478.5714286,786.6964286,2837.821429,11291.03571,2000.607143,573.3214286,2795.857143,9614.321429,638.5,250.9107143,1896,8022.035714,1035,398.3392857,1280.875,5786.428571,699.3214286,160.1964286,7648.732143,4951.482143,1253.071429,955.7857143,3177.785714,829.5178571,595.1964286,56,10.49418103,7.198690449,0.727630084,0.903225806,0.622222222,-1.16726839
+2710,25460.13415,927.1707317,884.695122,1135.865854,21388.78049,708.6707317,721.1707317,1607.207317,12826.21951,715.1219512,578.097561,1822.195122,16955.52439,1311.390244,4251.060976,2180.54878,6001.963415,1342.182927,324.3536585,2471.707317,12178.08537,572.402439,628.2804878,547.1097561,14649.82927,456.3780488,132.1097561,2208.280488,11404.19512,1682.817073,711.8658537,2792.658537,10026.69512,760.4512195,272.304878,1734.463415,7879.707317,970.5365854,421.5243902,1339.560976,6101.231707,782.6707317,167.3292683,3269.585366,5634.536585,1372.780488,495.5609756,3388.670732,604.7439024,597.3170732,82,11.62353476,9.60647065,0.56298482,0.891304348,0.525641026,-0.660779436
+2711,33346.7205,939.9192547,530.8322981,1110.254658,30626.9441,751.8944099,666.6708075,1570.832298,17213.36025,557.6397516,1332.273292,1817.21118,23708.04969,1407.832298,3188.913043,3560.900621,8517.695652,1324.838509,366.5962733,2405.89441,17531.73913,482.863354,428.2049689,1175.118012,22038.25466,689.6583851,141.0186335,2038.888199,15595.65217,1795.229814,598.7080745,2802.372671,13972.24224,646.173913,291.826087,1790.950311,11571.17391,1648.192547,440.8695652,1317.701863,8361.198758,746.8136646,173.4720497,2635.285714,7261.89441,1465.602484,1141.795031,3215.254658,745.2298137,598.5838509,161,18.62128864,11.64450223,0.780358194,0.930635838,0.596296296,-1.040967567
+2712,39977.87156,821.1100917,517.6238532,1096.587156,34483.07339,708.412844,787.9908257,1564.082569,19306.87156,509.1100917,1598.33945,1800.027523,27556.97248,1242.174312,4874.59633,3977.275229,9894.284404,1261.944954,339.1192661,2660.724771,19024.82569,433.5412844,877.6330275,1912.009174,23579.45872,498.3577982,156.3577982,2827.633028,18698.89908,2306.59633,536.4954128,2798.614679,15745.50459,620.1009174,277.7247706,1638.587156,12314.15596,1321.889908,416.853211,1302.376147,8278.146789,824.146789,166.0183486,4665.018349,7358.137615,1258,199.8256881,3237.908257,899.440367,597.0917431,109,17.23349432,8.990742776,0.85312799,0.858267717,0.550505051,1.458766972
+2713,47141.94737,982.8026316,555.6447368,1113.684211,40659.03947,731.5263158,617.9210526,1654.171053,24275.09211,545.5131579,401.5657895,1694.184211,32987.17105,1298.171053,3596.815789,3506.105263,11640.48684,1359.842105,355.5263158,2330.526316,22126.23684,439.3289474,1065.842105,456.1842105,27217.97368,439.4210526,135.2763158,2919.434211,22129.69737,1479.736842,585.5131579,2865.631579,18530.52632,670.3026316,292.4078947,1752.276316,13798.18421,846.3684211,428.5,1324.789474,8811.394737,862.5263158,167.3684211,2603.947368,8265.565789,1338.710526,283.2236842,3348.105263,977.1842105,598.0657895,76,11.51852133,8.871948938,0.637762206,0.915662651,0.584615385,-0.117814418
+2714,52293.71942,954.7625899,634.7553957,1175.964029,32522.92086,608.9208633,520.2302158,1579.553957,16736.80576,453.5179856,502.5899281,1702.179856,23930.35971,1134,7430.028777,4262.496403,8885.978417,1212.640288,309.5899281,2434.028777,17127.72662,397.4460432,170.1223022,555.4820144,22601.33813,387.1726619,123.7482014,6946.992806,16602.55396,1539.381295,617.5755396,2792.086331,13612.79856,581.647482,264.2086331,2439.633094,10509.43885,879.8417266,397.323741,1293.784173,6295.007194,616.3597122,153.5179856,2442.568345,6144.848921,1184.086331,296.676259,3214.906475,1018.94964,601.3021583,139,19.21429387,10.3722187,0.841781857,0.832335329,0.66507177,-0.003029403
+2715,35264.22857,898.8285714,568.7257143,1099.16,32850.29714,727.1885714,958.9942857,1571.617143,18976.88571,559.3485714,1794.594286,1796.822857,24916.61143,1325.422857,5780.034286,4325.457143,8956.794286,1411.302857,388.9885714,2646.194286,18944.02857,450.3257143,568.2114286,988.9714286,22056.17714,537.16,143.6,4687.182857,17069.58286,2215.777143,743.6971429,2810.691429,15065.72,645.1371429,301.24,1533.251429,11691.76571,1200.085714,469.4342857,1347.125714,8961.942857,770.0628571,182.5142857,4343.8,8085.08,1419.257143,186.7885714,3334.937143,410.0685714,601.8057143,175,20.90819912,11.98556382,0.819382573,0.78125,0.511695906,-0.856944573
+2716,17021.55828,835.9631902,459.1226994,1066.08589,15478.85276,665.5889571,531.5092025,1413.920245,8918.411043,511.6257669,433.0552147,1716.558282,11699.47239,1255.251534,1258.920245,1006.141104,4293.245399,1252.815951,324.7116564,2374.533742,9058.840491,409.4601227,184.1042945,445.6748466,10503.33129,439.3312883,123.7730061,1095.110429,8043.404908,1368.680982,651.2822086,2828.276074,7129.503067,758.803681,265.4233129,1714.165644,5663.773006,798.0122699,420.5153374,1309.595092,4411.055215,671.0429448,166.5521472,2365.877301,4108.619632,1355.785276,1787.564417,3213.687117,446.9570552,600.6871166,163,16.27216509,12.87318756,0.611664763,0.953216374,0.783653846,-0.162566928
+2717,25678.32624,873.5886525,622.1702128,1103.35461,23861.80142,712.9787234,651.9716312,1546.93617,12769.57447,527.5248227,647.2765957,1739.326241,17982.58865,1331.730496,1875.815603,1885.177305,6323.957447,1288.382979,333.6808511,2383.815603,13637.50355,460.8085106,539.4893617,562.8014184,17023.16312,433.4042553,156.3333333,1314.148936,12141.23404,1507.432624,583.8014184,2797.014184,10832.85106,775.3900709,275.9007092,1746.439716,8916.368794,982.9361702,417.3900709,1302.021277,7094.198582,764.4397163,164.0567376,2112.574468,6027.695035,1456.439716,3102.269504,3117.056738,707.2765957,600.0851064,141,14.77057338,12.29689365,0.553985233,0.959183673,0.671428571,-0.606388441
+2718,34149.61184,1031.789474,526.5263158,1095.947368,28052.36184,711.5,467.6184211,1428.756579,16203.90789,551.3223684,541.7828947,1682.697368,21842.90789,1283.065789,3333.171053,2683.789474,7601.072368,1238.375,326.25,2305.526316,15890.48684,412.5986842,196.6578947,547.7302632,20398.35526,383.9013158,137.3289474,4059.894737,14455.11842,1431.375,761.7236842,2779.578947,12888.07237,576.8684211,262.4342105,1688.993421,10666.90789,904.9210526,397.7763158,1297.006579,7585.506579,641.2960526,157.5065789,2147.657895,6649.144737,1265.973684,304.2763158,3242.940789,760.6710526,599.2763158,152,17.43585971,11.36874724,0.758191015,0.932515337,0.638655462,-1.187209973
+2719,51943.73988,914.7976879,617.9075145,1187.109827,30291.02312,593.3757225,571.9768786,1591.306358,14467.60694,478.8901734,659.6647399,1736.387283,19156.4104,1120.855491,7020.612717,3548.595376,7731.150289,1171.82659,310.1791908,2982.052023,15048.69942,397.2196532,142.6300578,562.9190751,17348.3237,397.433526,130.8381503,7365.641618,12739.19653,1699.34104,457.4739884,2812.046243,10824.03468,542.8323699,262.7687861,5073.011561,6131.65896,766.5260116,388.9884393,1299.098266,4425.612717,634.1849711,151.2601156,3060.393064,4049.566474,1108.971098,227.0404624,3135.872832,138.6011561,603.1618497,173,17.48596606,13.11903244,0.66114215,0.896373057,0.565359477,-0.552907118
+2720,27998.31579,1020.807018,589.2017544,1100.675439,24790.20175,789.5,759.6491228,1591.912281,14517.14912,612,572.0175439,1763.807018,18917.59649,1468.824561,1319.263158,1517.491228,6462,1435.973684,370.0877193,2402.5,11171.88596,496.5438596,163.1052632,634.6052632,13674.05263,483.877193,134.2807018,1058.666667,10172.08772,1559.72807,658.0263158,2841.657895,9045.482456,713.5701754,286.4298246,1846.877193,7081.824561,950.5087719,458.0263158,1320.035088,5508.429825,681.3947368,175.5964912,1394.842105,5019.131579,1568.552632,12619.18421,3307.535088,515.8596491,600.122807,114,14.95303684,9.890152818,0.750020724,0.93442623,0.74025974,-0.474149213
+2721,21899.375,908.4615385,636.5865385,1088.605769,19355.88462,878.5480769,1135.75,1574.567308,11265.57692,664.2980769,1429.519231,1886.365385,14618.94231,1335.413462,2327.538462,1556.298077,5150.153846,1370.586538,354.7692308,2534.826923,10863.64423,491.7403846,248.1346154,1126.403846,12694.80769,423.4519231,903.5673077,942.9711538,9694.5,1982.894231,672.4230769,2833.653846,8614.855769,999.6634615,282.125,1751.903846,6844.567308,932.8076923,449.3461538,1381.634615,5289.442308,670.5,172.0384615,4713.692308,4828.605769,1423.278846,2360.057692,3331.875,540.75,600.7211538,104,12.249099,11.10197966,0.422526188,0.936936937,0.615384615,0.827335676
+2722,42174.59341,967.956044,739.010989,1160.571429,36470.73626,807.5274725,984.1978022,1717.230769,22250.53846,730.8901099,1117.912088,1749.802198,28656.82418,1496.208791,2163.527473,2104.186813,9562,1465.593407,382.7802198,2440.087912,20375.1978,557.3406593,218.6153846,1329.681319,24177.17582,479.8241758,134.8021978,1301.659341,18706.47253,1848.56044,682.043956,2859.450549,16410.58242,1107.802198,330.6263736,1672.340659,13129.13187,1221.901099,494.5714286,1352.703297,9740.362637,708.6153846,181.4065934,1401.285714,8955.835165,1532.230769,408.3736264,3360.89011,569.0769231,600.5714286,91,12.05775419,10.04468989,0.553200479,0.919191919,0.583333333,-0.401327916
+2723,22718.71519,1279.772152,575.8164557,1162.43038,19310.62658,966.9620253,538.4873418,1791.35443,11330.98101,663.4240506,391.8544304,1718.651899,15409.10759,1666.272152,1438.936709,1125.196203,5770.550633,1485.753165,410.1708861,2352.759494,11536.1962,592.9746835,180.2848101,561.9556962,14324.38608,486.1012658,150.056962,870.3227848,10895.61392,2042.746835,581.0949367,2822.348101,9780.892405,732,356.2658228,1589.886076,8168.158228,1290.044304,512.278481,1333.759494,6236.955696,971.6708861,195.3544304,1611.259494,5848.506329,1886.189873,5557.139241,3200.664557,692.2151899,602.3101266,158,18.58128824,11.20127773,0.797872921,0.908045977,0.619607843,0.57487239
+2724,36686.34058,926.1956522,491.3188406,1097.15942,34831.0942,729.384058,731.5217391,1547.601449,19199.94928,554.3188406,654.7391304,1723.384058,26444.44203,1347.717391,3485.34058,3030.282609,9225.485507,1290.297101,339.2608696,2357.188406,19143.78261,451.5362319,276.442029,1372.753623,23581.44203,446.5072464,134.9057971,2467.775362,17178.18841,1523.072464,590.8768116,2785.528986,15213.62319,741.7028986,283.9275362,1905.608696,12435.58696,1598.137681,429.173913,1306.050725,9015.934783,913,168.4057971,3162.536232,7734.637681,1368.717391,501.3188406,3440.369565,786.1666667,602.6231884,138,16.73658995,12.18977484,0.685225633,0.816568047,0.5390625,1.002275965
+2725,30238.09735,820.5044248,606.0442478,1103.787611,26721.39823,653.0973451,744.5575221,1652.415929,14205.93805,477.2123894,831.2654867,1743.292035,20206.23894,1179.150442,9770.353982,4319.849558,7604.283186,1234.389381,326.159292,2642,14049.61062,433.300885,492.1769912,762.2389381,18369.9646,1022.893805,127.8230088,5300.424779,13597.02655,1607.070796,578.5575221,2793.716814,11170.02655,661.6814159,263.0353982,4396.619469,8318.451327,891.7345133,394.7522124,1301.876106,4790.433628,725.3274336,154.7168142,3542.761062,4780.19469,1197.460177,562.4690265,3292.716814,1034.150442,600.1327434,113,13.91529536,11.17456655,0.595922439,0.904,0.627777778,0.096853772
+2726,36631.36612,937.7677596,681.942623,1175.29235,27194.41803,639.9453552,520.3907104,1673.142077,14611.94536,467.8579235,705.0765027,1762.699454,20185.31967,1178.423497,7716.114754,3232.620219,7604.986339,1227.357923,313.9453552,2520.980874,13946.14208,1597.26776,643.6666667,703.2295082,17767.28415,530.5846995,125.5491803,7226.057377,13696.88798,1577.540984,560.579235,2806.120219,11107.64208,772.1939891,256.2923497,3144.491803,8117.65847,869.5245902,389.1639344,1303.551913,4414.150273,728.1584699,153.7677596,2985.010929,4504.860656,1161.188525,789.0628415,3195.401639,1046.051913,606.8469945,366,28.6298824,17.38976561,0.794396815,0.897058824,0.631034483,-0.393618421
+2727,46284.44304,874.9493671,531.3924051,1107.974684,42905.65823,721.3924051,525.8481013,1646.810127,23683.91139,565.5822785,556.1139241,1781.848101,30407.08861,1309.987342,6826.392405,4053.949367,11147.44304,1423.873418,362.2025316,2346.405063,22857.3038,452.6708861,158.0759494,464.2658228,27895.55696,417.9367089,137.2911392,4452.202532,21529.06329,1565.202532,583.2278481,2825.632911,18922.20253,633.1392405,320.2911392,1961.443038,13575.60759,919.6835443,450.0253165,1311.911392,10011.89873,672.4303797,176.0759494,3670.936709,9185.822785,1406.696203,179.0506329,3356.316456,261.835443,600.8227848,79,11.72544136,9.129645628,0.627497588,0.908045977,0.598484848,-1.104733506
+2728,35267.58484,963.9927798,509.1732852,1090.357401,32125.36823,750.0433213,592.3718412,1527.021661,18346.91697,590.6967509,720.368231,1769.00722,23308.45126,1380.198556,3034.400722,2833.787004,8700.00722,1435.67148,364.4115523,2384.01444,15921.81227,426.9458484,328.3176895,784.6425993,18407.59928,422.6101083,128.6389892,2581.870036,14094.2491,1507.079422,669.6642599,2807.046931,12579.51264,629.6281588,294.66787,1393.252708,9669.851986,1027.624549,440.7256318,1310.776173,7505.707581,679.6750903,172.0830325,2575.368231,6786.555957,1392.534296,274.0649819,3265.577617,354.6498195,605.4296029,277,20.69769362,18.35443991,0.462178869,0.893548387,0.629545455,-0.407388362
+2729,27111.49714,914.0285714,663.2457143,1113.405714,24384.51429,745.0914286,835.0514286,1576.942857,13416.42286,840.4571429,1154.148571,1774.4,17671.02286,1328.074286,4210.48,3897.68,6367.051429,1406.954286,356.9657143,2537.794286,13109.53143,472.1142857,407.72,566.1885714,15720.29143,465.2171429,130.5371429,2708.502857,11581.92,1700.634286,709.0457143,2818.285714,10294.24571,1032.651429,287.6342857,2251.8,8124.611429,1179.691429,443.68,1397.765714,6454.937143,750.5028571,174.6685714,6219.428571,5586.131429,1372.662857,385.2171429,3320.531429,555.0114286,603.7028571,175,20.7400427,12.61932113,0.793590653,0.810185185,0.486111111,-0.969306312
+2730,22596.38636,798.9015152,504.9772727,1080.409091,20760.80303,644.1893939,671.5984848,1524.363636,10872.07576,486.0454545,706,1752.613636,15852.31061,1186.515152,4897.507576,2386.772727,5685.666667,1231.121212,322.6893939,2484.272727,11469.09091,1131.348485,776.5,562.0833333,13941.53788,488.7954545,126.2651515,1721.409091,10512.07576,1891.977273,1008.090909,2818.522727,9288.045455,724.9242424,257.7575758,1616.840909,7118.924242,1027.227273,402.3712121,1291.181818,5339.621212,804.0984848,159.0151515,2994.560606,4544.772727,1280.477273,625.4621212,3163.590909,877.0151515,601.5909091,132,15.08161978,11.68979318,0.631836164,0.904109589,0.589285714,-0.487862836
+2731,49264.5098,928.0686275,609.6960784,1155.745098,48787.80392,762.4117647,633.6176471,1792.421569,25102.46078,596.3333333,593.5784314,1781.872549,32431.79412,1379.362745,8113.068627,8080.313725,12613.90196,1477.362745,379.3431373,2375.754902,24261.22549,479.2745098,140.7058824,473.2058824,31091.28431,467.8431373,146.372549,5439.441176,22668.07843,1628.686275,1011.166667,2850.95098,19722.77451,673.2647059,341.8529412,3744.176471,13710.39216,908.5098039,483.872549,1324.715686,10053.38235,665.4705882,182.0490196,3067.558824,8255.519608,1463.068627,206.9705882,3364.735294,196.4313725,602.2941176,102,17.83974444,7.894510459,0.896756789,0.842975207,0.428571429,-0.946239237
+2732,28684.44503,931.7434555,455.5602094,1056.858639,24787.22513,722.0209424,408.5759162,1432.963351,14543.32461,573.4764398,369.0314136,1681.827225,19133.75393,1380.937173,1398.858639,2156.282723,6735.795812,1291.251309,335.6335079,2320.528796,12065.12042,423.1151832,283.8638743,434.9319372,14419.18848,418.7591623,117.2513089,1488.366492,11230.27749,1375.078534,750.2513089,2793.34555,9952.732984,726.2670157,268.7801047,1781.764398,7941.089005,806.8534031,408.1989529,1320.209424,6043.319372,695.0418848,160.565445,1959.366492,5363.062827,1390.727749,2262.481675,3176.162304,637.9005236,605.0575916,191,18.17074921,13.6677062,0.658955684,0.93627451,0.718045113,-0.111292472
+2733,13747.80667,969.98,528.26,1100.186667,12639.78667,722.3,455.6,1426.76,6761.626667,539.34,429.2,1683.093333,9909.34,1459.066667,943.58,932.3933333,3638.513333,1286.36,352.2133333,2337.713333,7227.213333,442.7333333,109.6266667,564.64,8866.353333,444.06,119.56,815.78,6622.226667,1341.06,590.0266667,2817.426667,5989.14,593.8866667,264.84,1735.306667,4980.44,983.7666667,417.0666667,1300.226667,3959.953333,662.66,164.92,1234.813333,3671.04,1706.233333,4545.746667,3147.84,669.0133333,603.0866667,150,15.71706596,12.54740937,0.602219889,0.955414013,0.666666667,0.797365103
+2734,42621.46087,909.2347826,597.6695652,1130.826087,42135.82609,764.2608696,680.2695652,1743.643478,21983.34783,586.6086957,535.7913043,1767.278261,28053.29565,1345.521739,7817.330435,8518.617391,10536.13043,1425.147826,360.6608696,2355.913043,21419.58261,462.6782609,137.0086957,445.0347826,26528.29565,456.0608696,138.2782609,5656.495652,19832.15652,1530.513043,761,2815.608696,17089.53043,638.4695652,319.6434783,3741.086957,12228.04348,915.9130435,469.626087,1318.878261,8854.33913,682.6608696,178.4782609,5239.06087,7518.582609,1753.382609,179.5652174,3342.13913,213.3043478,604.3217391,115,16.78667431,9.075991115,0.841237078,0.8984375,0.552884615,0.515469333
+2735,46215.51282,887.4358974,586.1923077,1120.269231,43166.20513,752.8461538,883.1282051,1708.846154,24293.74359,586.3717949,547,1786.551282,30695.12821,1355.051282,8510.410256,5229.051282,11719.9359,1453.25641,372.1794872,2331.564103,22524.26923,472.8076923,143.4871795,448.5,27922.42308,458.5769231,144.3717949,4985.589744,21959.55128,1584.705128,749.2948718,2818.615385,18768.37179,632.2435897,324.8461538,3210.115385,13337.82051,897.2820513,475.2435897,1322.384615,9311.294872,677.8589744,188.7692308,4540.24359,8492.051282,1437.153846,194.5512821,3384.923077,221.6794872,602.7307692,78,13.58726187,8.156691362,0.799760656,0.804123711,0.545454545,0.336184403
+2736,47341.36232,970.3188406,555.3043478,1129.797101,42689.57971,780,915.4492754,1671.449275,25172.47826,612.942029,1147.695652,1765.971014,32446.62319,1466.173913,3389.753623,3793.318841,11647.53623,1508.84058,390.5217391,2560.826087,23602.88406,513.5942029,137.2463768,948.6666667,27944.2029,1587.971014,144.4492754,2854.797101,21682.14493,1763.768116,731.7681159,2831.695652,19131.18841,729.1884058,349.884058,1831.289855,15177.14493,1444.768116,508.4347826,1331.42029,11347.98551,684.8985507,185.1594203,2742.347826,10409.24638,1575.73913,255.1304348,3419.985507,494.5072464,601.5217391,69,10.94437616,8.199190305,0.662378596,0.945205479,0.696969697,-1.274648963
+2737,23283.42857,867.0803571,501.0625,1042.9375,20338.42857,674.0625,568.3482143,1430.5,11360.17857,504.2678571,924.4285714,1732.410714,16193.5,1248.678571,4962.160714,3141.767857,5710.223214,1226.696429,326.5,2779.214286,11925.25893,415.9821429,534.5892857,1038.473214,14321.55357,462.0178571,122.4017857,2342.696429,11042.25893,1801.803571,560.9910714,2790.803571,9609.5625,650.5535714,264.1785714,1850.205357,7663.348214,1229.258929,403.2946429,1319.357143,5713.080357,744.8035714,157.2589286,4298.125,5040.142857,1286.598214,982.3303571,3176.580357,856.3303571,603.4910714,112,13.48498295,10.83548734,0.59527437,0.925619835,0.615384615,0.559142669
+2738,27333.16418,759.4029851,500.6567164,1062.223881,23993.02985,860.4776119,708.5671642,1584.507463,13219.95522,480.358209,1883.19403,1846.791045,18909.37313,1225.820896,5125.731343,3317.880597,6722,1204.313433,305.7910448,2515.776119,12966.04478,419.9850746,1379.761194,1900.58209,15792.85075,527.9104478,1004.014925,2377.970149,12702.46269,1769.343284,516.7164179,2837.089552,10600.44776,910.2537313,254.5671642,1575.328358,8165.970149,1117.164179,388.6119403,1320.19403,5615.238806,943.8358209,158.4925373,7929.447761,4992.298507,1186.477612,590.1791045,3188.059701,913.5522388,601.9850746,67,14.28125746,6.436714593,0.89267011,0.893333333,0.468531469,-0.989039117
+2739,49101.53947,927.4210526,591.2236842,1165.828947,39501.71053,706.1447368,1230.039474,1827.078947,22173.38158,518.6710526,1771,1757.210526,29423.36842,1273.907895,6954.210526,4714.855263,10942.01316,1323.868421,339.0263158,3698.460526,20376.71053,439.3947368,231.9736842,1582.868421,25843.68421,494.2894737,131.9605263,3865.723684,19883.92105,2108.671053,575,2947.605263,16363.97368,602.2368421,288.1447368,2210.342105,12054.57895,1957,423.4605263,1296.434211,7015.118421,667.1973684,154.0263158,4241.947368,6875.763158,1258.842105,355.3026316,3296.026316,1009.697368,602.9078947,76,12.58144897,8.663336668,0.725160193,0.938271605,0.584615385,-0.286312582
+2740,40247.84615,1166.153846,643.4461538,1111.707692,36330.01538,841.8769231,698.7230769,1685.2,21064.23077,669.3384615,867.1692308,1752.492308,27193.23077,1500.923077,4752.169231,4243.584615,9178.969231,1484.707692,379.3692308,2412.938462,18052.27692,470.5692308,366.0769231,695.9538462,20787.32308,517.2615385,137.1076923,3449.323077,16429.89231,1892.938462,674.3538462,2844.215385,14347.73846,690.9846154,325,1717.753846,10842.75385,1057.630769,470.6307692,1348.984615,8361.046154,740.2307692,181.8,4106.030769,7149.153846,1412.507692,148.3230769,3463.046154,382.0461538,602.6307692,65,10.51838427,8.427640883,0.598357016,0.942028986,0.65,-1.044556184
+2741,20637.41414,982.4242424,537.4747475,1141.656566,19114.66667,726.3434343,413.9090909,1496.535354,10022.49495,540.8686869,384.4747475,1692.808081,14515.14141,1474.707071,1092.282828,935.3737374,5508.393939,1308.353535,354.969697,2318.444444,9911.737374,441.8686869,117.5050505,537.040404,12059.35354,393.7575758,124.2222222,898.7474747,8564.666667,1358.818182,559.4141414,2829,7606.40404,645.6363636,269.2828283,1443.10101,6433.40404,1257.444444,424.7979798,1308.050505,5438.909091,685.5050505,172.7070707,1463.414141,4680.89899,1482.454545,1960.040404,3144.959596,681.1919192,603.6060606,99,14.51768121,9.175227228,0.774965426,0.891891892,0.634615385,0.942272482
+2742,40963.44248,877.5044248,471.7433628,1083.619469,36822.97345,729.0707965,745.1150442,1568.00885,20821.02655,540.5929204,1734.212389,1809.663717,28716.25664,1285.823009,3909.548673,4151.00885,10260.14159,1292.663717,342.9734513,2408.769912,20329.95575,576.9823009,241.3628319,1962.097345,25401.52212,1015.610619,198.4424779,2038.80531,19007.63717,1764.053097,553.4424779,2787.893805,16463.38938,610.9380531,285.6106195,1621.734513,13474.41593,1268,427.0884956,1301.672566,9629.80531,684.4778761,163.2566372,3301.743363,8267.823009,1329.530973,160.7876106,3214.575221,814.7433628,604.3893805,113,22.99789662,7.383747586,0.947058223,0.80141844,0.42481203,-1.114745665
+2743,38263.99167,865.8333333,536.575,1103.758333,34796.56667,696.3083333,606.4166667,1667.05,19147.63333,508.1416667,456.6666667,1747.733333,27141.35833,1273.225,4668.775,3864.783333,9714.641667,1322.975,344.7,2376.725,18747.05833,441.45,972.55,493.7333333,23391.41667,438.25,130.9083333,3361.633333,18427.13333,1498.725,658.875,2803.158333,15721.00833,762.5833333,287.25,2446.2,11866.51667,864.375,426.275,1332.416667,7835.791667,901.725,165.5583333,3998.391667,7023.758333,1424.333333,828.0666667,3296.516667,965.275,606.075,120,22.21927158,7.371384112,0.943365112,0.845070423,0.476190476,-0.513232813
+2744,39098.49254,853.6865672,586.358209,1125.328358,28994.92537,638.6119403,463.4776119,1675.507463,16308.0597,468.0447761,530.5671642,1747.671642,22093.0597,1164.850746,8355.61194,3347.761194,8409.059701,1243.58209,323.0149254,2384.716418,15534.13433,444.4626866,237.9104478,565.8656716,19883.08955,460.1044776,134.4029851,9188.567164,15484.31343,1657.19403,806.0149254,2795.58209,12678.53731,604.1343284,271.119403,1923.567164,9402.880597,816.119403,393.1641791,1280.895522,5289.507463,659.1940299,152.1343284,2675.686567,5483.029851,1209.656716,242.0895522,3319.522388,1026.761194,604.2835821,67,13.20633803,6.901614908,0.852578802,0.905405405,0.572649573,0.405781769
+2745,43513.33824,899.6911765,578.5,1115.838235,43025.33824,733.5147059,607.6470588,1707.294118,22300.97059,590.7352941,540.8088235,1785.970588,28719.47059,1355.852941,7130.235294,6295.882353,11007.41176,1418.161765,374.5294118,2372.426471,22518.26471,479.25,134.5441176,430.0147059,27025.36765,444.8970588,135.0294118,4235.323529,20168.79412,1563.382353,703.7352941,2837.705882,17827.33824,671.4852941,320.9411765,2632.5,12696.39706,869.7941176,472.5735294,1327.176471,9545.632353,656.0294118,182.9264706,3393.514706,8066.926471,1407.073529,242.5294118,3342.323529,231.0294118,603.7058824,68,11.31397825,8.260934034,0.683283793,0.918918919,0.618181818,1.391424545
+2746,29659.30939,1007.055249,583.2044199,1067.762431,27504.71823,732.3093923,581.0497238,1525.596685,15335.07182,587.4033149,762.8232044,1734.983425,19864.75138,1333.618785,7502.513812,3478.861878,7203.38674,1356.027624,350.3867403,2351.320442,16172.33702,608.2320442,761.3646409,544.2872928,18925.20442,429.5248619,130.281768,6639.729282,14315.66298,1654.475138,656.359116,2831.917127,12833.08287,649.7127072,295.7734807,1655.712707,9525.127072,1061.01105,442.9005525,1305.265193,7488.022099,808.6629834,173.5082873,3825.867403,6583.911602,1365.618785,172.9944751,3383.635359,338.6740331,605.8563536,181,17.95733043,13.18341411,0.67898491,0.928205128,0.635087719,1.562159162
+2747,49298.87023,1188.916031,606.4580153,1176.564885,45655.36641,919.9083969,1026.916031,1802.755725,26885.67176,703.5038168,1486.610687,1754.557252,35263.12977,1645.80916,3978.778626,3773.10687,12153.35878,1619.80916,431.1984733,2647.015267,24308.9771,518.3206107,263.3664122,884.8778626,28533.44275,1227.687023,152.6870229,2505.122137,22548.84733,2420.740458,671.3435115,2848.091603,19744.93893,708.7251908,367.9160305,1433.816794,15254.98473,1330.770992,525.5343511,1341.022901,11741.0229,851.7328244,197.4656489,2439.305344,10399.36641,1600.839695,211.4885496,3409.572519,393.3129771,605.9389313,131,17.18781941,10.50143625,0.791645028,0.829113924,0.592760181,1.443076956
+2748,15630.09783,829.4021739,441.9130435,1047.815217,14566.68478,698.9565217,465.0869565,1402.836957,8053.576087,512.0543478,495.7608696,1714.315217,10662.44565,1302.630435,2684.48913,1448.097826,3893.26087,1284.880435,368.5652174,2356.5,7697.271739,403.1304348,922.8804348,458.7065217,9132.5,422.3152174,131.1847826,1195.108696,7160.641304,1578.108696,682.9565217,2808.858696,6223.880435,590.923913,272.8043478,1760.51087,4936.902174,838.673913,431.5978261,1334.402174,3968.641304,896.826087,177.25,1818.98913,3634.576087,1408.369565,4071.184783,3223.608696,436.0217391,604.9347826,92,11.29416264,11.0815639,0.193114496,0.910891089,0.638888889,-0.263121893
+2749,23523.23188,798.821256,594.1980676,1084.792271,20076.89855,683.1642512,883.6811594,1534.555556,11751.67633,542.2512077,1612.536232,1821.125604,15371.11594,1229.507246,4158.478261,2952.714976,5684.743961,1282.565217,312.3091787,2547.067633,11408.23188,2985.333333,332.9371981,849.6086957,13744.02415,525.2028986,241.7971014,1120.961353,10391.83092,1758.714976,635.4830918,2792.801932,9189.855072,672.0676329,265.8743961,1487.246377,7299.927536,1570.10628,406.0917874,1322.188406,5686.695652,685.6183575,152.9033816,3091.328502,5006.550725,1294.125604,513.0531401,3279.512077,594.7246377,605.8115942,207,18.23794861,14.57852154,0.600864426,0.985714286,0.726315789,1.490471697
+2750,38850.0098,862.1960784,571.0784314,1098.053922,33099.71078,710.2696078,671.9803922,1561.27451,19628.77451,520.2303922,901.5980392,1761.421569,26746.7402,1268.230392,5161.328431,3725.372549,9530.406863,1288.176471,338.1421569,2443.171569,19021.51961,468.7352941,514.4068627,1078.705882,23534.37255,451.4607843,253.2990196,3350.279412,17993.93137,2083.705882,1156.421569,2794.073529,15403.36275,634.2107843,275.3970588,1791.303922,12623.82353,1029.803922,427.3382353,1308.52451,8867.779412,742.5931373,167.6960784,5482.181373,7840.705882,1325.053922,332.7254902,3227.759804,833.9362745,607.4068627,204,18.69134245,14.72088514,0.616215313,0.898678414,0.666666667,0.415180975
+2751,38699.30634,828.3239437,500.2640845,1081.105634,34786.32042,726.056338,861.834507,1578.862676,18954.55986,516.6056338,2070.014085,1817.267606,27277.66549,1299.214789,5839.211268,3454.052817,9768.609155,1282.598592,333.7992958,2477.735915,18971.30634,523.1408451,1189.158451,1292.010563,23809.09859,820.5915493,324.2359155,2087.947183,18094.79577,2121.679577,582.5985915,2836.31338,15502.23592,872.7535211,273.7852113,1513.926056,12013.82042,1410.31338,416.6021127,1319.774648,8318.496479,926.8485915,165.1232394,4763.080986,7357.34507,1282.514085,460.5246479,3260.721831,897.8732394,609.4683099,284,20.13948545,19.39474503,0.269426764,0.898734177,0.645454545,-1.080355292
+2752,33806.85223,858.3161512,575.395189,1097.982818,27967.05498,639.4020619,732.419244,1650.405498,13731.65636,460.5876289,1444.745704,1747.14433,19024.19588,1196.185567,10232.94845,3413.357388,7144.996564,1171.302405,300.652921,2559.436426,13126.57388,481.5085911,656.0618557,1161.690722,16626.45017,441.7285223,201.9209622,3525.051546,12863.2921,2350.865979,403.1134021,2796.594502,10171.67698,792.4467354,250.5154639,2057.814433,7074.33677,1229.168385,380.9621993,1291.697595,3649.426117,715.95189,148.8487973,3501.66323,3877.955326,1084.766323,446.8453608,3154.639175,1072.752577,611.2061856,291,25.57913003,15.04336116,0.808780412,0.892638037,0.612631579,-0.387651265
+2753,40214.26316,878.9172932,504.6992481,1117.240602,35950.93985,711.962406,690.7518797,1591.233083,19944.71429,547,1246.857143,1767.93985,27836.78947,1339.233083,3616.631579,4234.616541,9988.315789,1323.082707,346.6315789,2657.669173,21149.82707,465.4511278,234.8045113,791.0225564,25914.99248,430.1203008,165.5263158,2818.323308,18697.70677,1901.992481,712.4285714,2795.338346,16802.42105,655.7218045,286.3759398,2090.075188,13666.72932,1221.360902,427.9924812,1298.924812,10241.59398,685.0827068,168.8721805,3962.827068,8965.691729,1418.473684,566.556391,3210.488722,731.7368421,607.075188,133,15.80195618,11.07400246,0.713358331,0.904761905,0.682051282,-0.253426875
+2754,31399.60606,810.5050505,456.010101,1062.454545,27751.80808,652.2020202,628.8989899,1508.59596,15405.38384,493.6060606,756.0909091,1728.444444,21474.46465,1215.474747,3775.727273,1960.676768,7740.161616,1245.939394,327.5050505,2410.59596,15553.44444,420.989899,219.6060606,697.5252525,19046.56566,466.2727273,140.3535354,2237.393939,14644.22222,1616.282828,505.9494949,2788.010101,12885.07071,1117.40404,270.1515152,2104.717172,9824.505051,952.6161616,408.2929293,1293.616162,7026.40404,669.3131313,167.7070707,3389.191919,6178.010101,1273.434343,757.2222222,3146.070707,885,607.0707071,99,15.04351148,8.492221201,0.825425841,0.942857143,0.6,-0.342770893
+2755,27397.98131,867.2056075,596.1448598,1086.939252,22720.51869,664.8738318,563.453271,1511.037383,12925.68224,474.4158879,757.5607477,1742.509346,17815.58879,1212.149533,7056.509346,3460.658879,6556.803738,1238.299065,320.771028,2488.719626,12159.79907,436.5747664,1847.640187,685.6074766,14871.36449,507.6308411,165.9859813,3522.457944,11966.19626,1615.794393,592.3785047,2788.275701,10016.47664,685.3738318,247.864486,1857.598131,7730.280374,855.088785,393.8130841,1333.271028,5046.191589,1063.771028,157.3271028,5887.453271,4588.682243,1208.037383,668.6915888,3183.35514,921.4719626,607.9579439,214,19.68133509,15.03411896,0.645361873,0.887966805,0.594444444,-1.193043477
+2756,36284.78302,890.6415094,632,1126.95283,12899.28302,419.5471698,236.0471698,1168.584906,6922.09434,342.0377358,388.509434,1596.783019,10291.65094,870.1226415,3472.528302,1317.443396,3909.839623,944.6226415,245.1981132,2310.311321,7222.207547,297.3018868,111.0377358,612.5283019,9083.40566,299.009434,103.1603774,1685.235849,6933.09434,1291.198113,409.0471698,2801.679245,5530.075472,481.4056604,202.0471698,1246.537736,4152.311321,748.3867925,327.3207547,1259.773585,2247.179245,518.9528302,131.3113208,799.1698113,2223.877358,895.3679245,168.8962264,2946.556604,1062.90566,604.8584906,106,13.36744837,10.962175,0.572270553,0.938053097,0.679487179,-0.752072806
+2757,33585.07692,839.2884615,564.9038462,1100.375,13704.95192,473.2403846,340.8269231,1225.884615,6713.326923,354.6346154,801.4230769,1648.817308,9789.336538,885.6153846,5896.298077,1541.846154,3706.528846,933.4423077,245.1346154,2321.317308,6764.875,284.2019231,252.875,1051.932692,8354.903846,293.9903846,442.7211538,2659.528846,6525.711538,1413.163462,391.6057692,2788.596154,5211.288462,525.9711538,193.4423077,1598.211538,3607.625,668.0096154,309.3173077,1261.769231,1786,533.0576923,126.9615385,1491.038462,1967.942308,856.9807692,216.875,2919.596154,1085.336538,606.5961538,104,13.57704793,9.907837744,0.683715097,0.936936937,0.742857143,-0.113201913
+2758,22777.34711,859.8264463,474.1157025,1073.53719,21272.8843,691.7024793,623.7190083,1480.396694,12306.18182,534.0826446,437.0578512,1726.214876,15990.85124,1304.68595,1603.661157,1523.528926,5799.157025,1305.247934,357.1983471,2381.297521,12267.96694,414.7603306,322.3140496,433.5867769,14308.80165,418.4545455,129.1404959,1565.198347,10911.71074,1500.636364,694.9917355,2829.909091,9826.46281,825.553719,284.0661157,1527.826446,7737.099174,982.2396694,435.6942149,1335.280992,5980.727273,708.0165289,169.9173554,2176.264463,5553.966942,1459.826446,7067.46281,3214.438017,458.446281,608.0495868,121,18.79838861,10.07194933,0.844352602,0.834482759,0.504166667,0.759195091
+2759,56893.57143,951.3357143,596.45,1168.9,55039.72143,806.65,777.8928571,1846.657143,29514.16429,613.0285714,602.3642857,1805.628571,37742.83571,1426.385714,5379.564286,6381.628571,14612.37857,1547.835714,400.2642857,2360.121429,27651.62857,498.9357143,151.6928571,533.8642857,34990.99286,475.4142857,161.1142857,5104.928571,26313.27143,1697.414286,614.3214286,2825.807143,22625.44286,684.2428571,353.9857143,4151.878571,15355.29286,926.0642857,499.6214286,1314.814286,10893.07143,687.7571429,190.1928571,3444.378571,9317.242857,1486.671429,204.6857143,3375,182.2428571,608.1785714,140,15.92008883,11.91684438,0.663088143,0.909090909,0.625,-1.153817616
+2760,55080.33333,945.1194969,598.0691824,1162.496855,54144.16981,789.4654088,824.4528302,1804.238994,29311.10063,612.6666667,523.2201258,1777.553459,37069.55975,1420.685535,6491.880503,7847.779874,14089.72327,1526.226415,388.3081761,2338.830189,27307.55975,496.2327044,140.8930818,445.3522013,34525.26415,475.6352201,147.7421384,5189.534591,25929.74843,1608.679245,784.8930818,2826.490566,22468.67925,662.3899371,345.327044,3224.515723,15750.9434,923.7295597,491.2704403,1302.503145,11125.84277,678.3773585,186.6477987,3748.320755,9501.918239,1508.616352,156.509434,3411.616352,202.7232704,609.672956,159,16.69004162,12.88030063,0.635943424,0.898305085,0.55017301,-0.831389314
+2761,22954.70248,957.9421488,563.1239669,1086.057851,20507.6281,714.5206612,624.8181818,1482.38843,12140.8843,571.7438017,451.4049587,1741.61157,15766.57025,1318.090909,3266.214876,2467.404959,5598.214876,1309.77686,367.8347107,2360.008264,12119.86777,424.785124,279.6115702,468.7933884,14229.92562,432.1239669,126.9669421,3488.38843,10704.59504,1630.190083,734.2066116,2811.22314,9494,682.5206612,275.4876033,1908.165289,7410.991736,1069.983471,431.7438017,1313.512397,5729.446281,690.553719,172.0495868,3108.917355,5260.495868,1364.479339,1074.570248,3357.123967,468.9421488,609.214876,121,17.19915219,9.68897349,0.826225055,0.883211679,0.540178571,0.685924549
+2762,32772.91589,896.7943925,561.9252336,1121.635514,29883.63551,730.2336449,866.364486,1627.028037,17354.54206,558.0934579,1126.495327,1801.700935,22545.40187,1358.028037,3519.803738,4263.084112,8003.514019,1378.785047,358.6168224,2449.11215,17256.51402,483.9719626,178.8037383,1479.785047,20079.26168,1093.719626,132.8598131,3640.971963,15445.93458,1551.448598,807.3831776,2854.588785,13603.41121,720.9158879,310.1962617,1974.130841,10801.24299,1386.364486,469.2056075,1334.990654,8207.084112,713.4766355,179.7383178,3688.775701,7526.514019,1472.102804,431.8130841,3301.186916,482.5233645,607.6542056,107,15.83194888,8.857511921,0.828850112,0.922413793,0.548717949,-0.816892081
+2763,34867.40488,885.2536585,478.7365854,1115.068293,30610.03415,710.1219512,555.6731707,1557.941463,17749.87805,527.2243902,671.8536585,1740.009756,23772.96585,1350.55122,3475.297561,2904.75122,8640.487805,1294.75122,348.2439024,2415.17561,18309.48293,741.7170732,296.2682927,565.1073171,22771.87317,545.0439024,128.0487805,2470.039024,16607.07317,1607.087805,751.395122,2791.678049,15065.78537,678.4,289.9609756,1982.604878,12146.56585,1030.970732,432.1560976,1308.712195,9183.112195,701.0585366,165.6097561,4023.068293,7975.95122,1440.75122,1057.892683,3209.141463,718.6878049,610.404878,205,19.32829009,13.98782757,0.690117744,0.923423423,0.753676471,-0.632710998
+2764,42275.19231,1119.769231,740.3717949,1220.846154,36739.34615,887.1153846,570.5512821,1732.987179,21840.39744,625.4102564,713.7435897,1737.576923,28992.07692,1653.666667,3238.628205,3134.679487,10091.87179,1512.179487,453.2307692,2401.230769,21674.39744,557.6538462,128.5,1002.782051,27587.26923,510.1282051,148.3205128,3344.615385,19536.61538,2224.564103,745.6923077,2798.153846,17883.83333,682.4871795,343.8461538,1999.423077,14097.79487,1379.269231,494.3205128,1329.089744,10379.53846,726.3589744,194.2307692,2874.897436,9052.038462,1667.448718,227.7948718,3339.461538,751.0128205,607.8717949,78,10.71048629,9.483825475,0.464694556,0.975,0.590909091,-0.065370764
+2765,28315.43798,816.496124,484.127907,1067.507752,24602.07752,657.0503876,647.9224806,1532.050388,13953.60465,505.9302326,843.8449612,1747.476744,19564.16667,1242.116279,5250.197674,2881.379845,7095.465116,1241.306202,359.6046512,2550.166667,14202.06977,422.6511628,847.379845,779.0232558,17301.5155,485.4844961,126.244186,2266.379845,13410.14341,1890.972868,541.8023256,2785.810078,11894.52326,717.1705426,269.5620155,1722.023256,9215.468992,1311.112403,413.3023256,1321.965116,6608.523256,843.6511628,157.751938,3117.875969,6071.124031,1330.837209,1409.476744,3194.189922,869.0930233,612.6899225,258,20.98112672,16.85066636,0.595797787,0.902097902,0.585034014,0.659981638
+2766,32381.54545,866.0606061,544.3232323,1088.464646,27494.9596,680.9494949,539.2323232,1620.69697,16130.41414,506.1111111,458.0606061,1731.434343,22336.08081,1223.959596,6074.656566,3363.626263,8084.090909,1279.313131,324.2020202,2334.818182,15261.64646,418.2020202,1499.656566,500.7373737,18789.66667,440.5353535,130.3535354,4285.434343,15271.36364,1467.373737,547.7272727,2794.808081,12807.68687,935.8686869,267.040404,2660.424242,9652.616162,801.989899,409.7070707,1304.464646,6276.888889,996.4747475,160.7171717,4599.555556,5876.757576,1305.20202,1300.505051,3299.757576,972.969697,609.2121212,99,13.39010211,9.564815632,0.699819378,0.942857143,0.66,-0.039361254
+2767,43034.51667,914.025,586.2458333,1145.254167,24466.67083,582.2291667,535.2291667,1555.920833,10047.02917,418.5416667,1343.55,1720.220833,15520.47083,1038.554167,8954.666667,2971.870833,5921.016667,1093.020833,286.2166667,2431.9625,10558.21667,336.5333333,239.925,942.85,12838.325,738.6916667,198.2708333,3551.0625,9724.783333,1997.675,377.0875,2801.654167,7578.316667,505.6541667,226.2541667,978.125,4447.666667,1034.220833,345.3541667,1261.579167,2069.858333,561.7625,135.2833333,1730.329167,2407.129167,963.1208333,217.7958333,3051.725,1134.420833,611.4416667,240,21.11811837,14.94892485,0.706340726,0.930232558,0.714285714,0.078338484
+2768,50441.11032,926.911032,639.0747331,1177.548043,45670.9573,745.3523132,633.6690391,1802.014235,22742.26335,576.4839858,536.2775801,1765.839858,30108.11388,1360.637011,7574.629893,6429.412811,11893.33452,1430.341637,371.8718861,2414.494662,22265.07473,460.7900356,1066.886121,457.4448399,27891.11032,464.3451957,141.569395,6600.88968,20199.9573,1610.270463,551.252669,2825.309609,17248.6548,610.0854093,317.6227758,6112.466192,10437.00712,864.7295374,452.2989324,1329.128114,7255.409253,892.0569395,176.3843416,4148.683274,6536.373665,1347.174377,203.8469751,3288.918149,151.4163701,610.6690391,281,25.94202268,14.59906709,0.826622059,0.894904459,0.661176471,-1.224370392
+2769,34006.44516,903.5677419,539.5741935,1093.406452,30576.98065,735.2064516,965.516129,1593.864516,18006.91613,613.0580645,1199.658065,1826.309677,23585.90323,1375.574194,2692.929032,3481.748387,8402.987097,1422.380645,367.5741935,2446.251613,16887.83871,496.6258065,276.5290323,1511.76129,20180.26452,1062.270968,136.8774194,1489.006452,14820.9871,1767.612903,692.9096774,2821.290323,13426.45806,700.5419355,301.8387097,1788.612903,10575.08387,1844.406452,463.3225806,1327.877419,7973.23871,825.6129032,179.0645161,2691.709677,7253.16129,1457.806452,516.8387097,3303.083871,514.4322581,611.8709677,155,18.42344742,11.81925703,0.767095095,0.837837838,0.509868421,-1.201478336
+2770,35218.07595,941.5696203,478.6329114,1096.329114,30061.98734,755.4683544,575.7468354,1512.481013,18767.64557,591.8734177,419.6075949,1715.202532,23995.37975,1451.088608,1157.721519,832,8484.936709,1402.936709,373.2278481,2367.151899,15850.60759,494,133.278481,468.443038,19752.50633,423.4683544,133.1898734,855.9620253,14989.56962,1490.417722,648.0759494,2918.696203,13333.50633,675.6582278,309.3797468,1785.898734,10528.49367,859.5316456,458.0126582,1325.632911,7849.481013,651.4303797,176.0632911,2772.316456,7519.772152,1547.164557,6839.35443,3175.708861,531.278481,607.4683544,79,10.82259993,9.872313923,0.409757936,0.908045977,0.598484848,-1.355065889
+2771,30142.66216,965.1621622,832.527027,1131.864865,27782.05405,739.7162162,690.7972973,1612.675676,14903.89189,637.027027,582.3783784,1784.310811,19497.89189,1365.445946,4348.256757,2961.959459,7010.972973,1368.743243,349.972973,2416.594595,14742.21622,520.2297297,155.1891892,476.4054054,17722.5,435.3783784,125.3918919,3447.594595,12882.62162,1495.337838,711.3243243,2821.283784,11389.2973,1106.905405,285.5810811,2165.594595,8972.486486,877.1216216,444.5,1351.094595,7183.567568,669.3513514,171.9189189,3951.391892,5971.567568,1378.27027,402.4054054,3429.932432,564.0675676,609.7567568,74,11.95537792,8.73919566,0.682394091,0.822222222,0.480519481,0.193946046
+2772,25107.83168,959.7425743,622.1386139,1083.094059,22753.26733,678.4158416,683.9158416,1568.910891,12585.58416,493.6386139,1154.940594,1755.316832,17171.5495,1361.009901,6487.970297,4178.826733,6264.346535,1223.118812,321.5346535,2479.326733,12013.26238,422.1386139,1988.811881,907.009901,14812.4604,1407.346535,122.7326733,3910.826733,11599.9901,1628.871287,653.6336634,2795.00495,9722.39604,634.5594059,258.470297,2020.59901,7527.029703,1148.430693,403.3564356,1326.336634,5000.376238,1118.633663,163.2722772,6264.252475,4538.985149,1239.425743,665.7772277,3245.049505,938.4009901,610.3861386,202,18.56114798,13.95575408,0.659300096,0.948356808,0.660130719,-0.808848272
+2773,45834.61871,932.0719424,555.028777,1118.683453,43140.53957,762.3956835,545.1007194,1674.42446,23538.64029,587.4460432,577.4892086,1775.402878,29727.08633,1334.251799,5340.928058,3843.338129,11065.19424,1445.23741,362.0359712,2371.726619,22754.46043,461.0719424,150.8633094,452.5395683,27098.91367,440.9568345,135.294964,2958.136691,20988.64029,1571.395683,591.5107914,2834.582734,18620.01439,659.057554,325.3956835,2078.266187,13100.13669,878.8489209,472.4892086,1316.733813,9792.136691,659.8057554,178.9496403,3020.568345,8678.316547,1410.273381,223.8920863,3411.158273,259.9064748,610.0359712,139,16.52696735,11.68258827,0.707333152,0.879746835,0.668269231,-1.540005366
+2774,40095.17172,993.0505051,581.4646465,1106,36567.20202,739.0909091,812.4444444,1607.808081,20451.55556,585.4444444,663.020202,1768.585859,25887.18182,1335.373737,5268.434343,4978.212121,9157.272727,1386.060606,368.4444444,2467.868687,19781.78788,453.9191919,207.0606061,540.0707071,23410.36364,440.040404,134.5454545,4948.686869,18453.78788,1615.757576,639.7979798,2816.737374,15899.33333,638.6060606,302.0707071,1740.666667,11329.47475,1020.828283,458.1111111,1307.010101,8629.10101,669.3939394,167.8888889,3337.020202,7774.232323,1380.353535,261.3939394,3421.919192,284.5151515,610.8383838,99,14.32112768,9.08872513,0.772809939,0.916666667,0.707142857,0.247841746
+2775,27423.87302,1008.84127,584.031746,1089.380952,26757.84921,735.1507937,651.6111111,1545.34127,14020.76984,581.3492063,641.3888889,1761.253968,18303.97619,1323.531746,5504.230159,3293.071429,6964.777778,1348.293651,353.5714286,2422.349206,13985.8254,683.4285714,390.4920635,554.8968254,15582.65873,450.9126984,129.3095238,5296.857143,11944.18254,1635.579365,675.3412698,2815.253968,10506.42857,773.9761905,279.7380952,1560.206349,8282.793651,878.4365079,439.5873016,1343.579365,6646.5,727.6349206,170.9206349,4505.103175,5688.944444,1342.063492,165.468254,3348.920635,378.4603175,612.4206349,126,16.41016264,12.02812637,0.680262969,0.812903226,0.466666667,-0.648470628
+2776,32290.38326,981.3832599,622.9911894,1099.264317,28602.5022,730.2995595,710.8722467,1561.396476,16425.18502,633.7048458,875.2643172,1767.462555,20967.51101,1355.674009,3782.986784,3002.947137,7449.136564,1353.325991,349.4669604,2400.022026,16036.46696,836.1982379,222.660793,560.6828194,19011.79295,507.092511,136.9339207,2027.77533,14452.42731,1560.889868,738.8237885,2806.096916,12606.01762,868.8634361,287.3788546,1602.325991,10031.44493,1257.061674,437.4273128,1343.779736,7854.202643,676.0837004,168.0528634,3481.035242,6732.220264,1365.15859,239.4096916,3371.76652,575.1497797,612.3171806,227,24.89558806,12.71246372,0.859799854,0.856603774,0.54047619,-0.759214628
+2777,30499.77778,1173.2,524.9777778,1080.377778,24353.47778,777.6333333,633.7333333,1479.566667,15672.35556,629.1777778,1058.133333,1674.522222,20287.98889,1438.566667,1724.622222,2790.266667,6890.977778,1285.177778,329.9222222,2415.022222,10293.2,397.2444444,128.7666667,481.9,12917.61111,469.4444444,114.9222222,1098.655556,10117.3,1381.744444,603.4666667,2779.933333,9041.988889,545.6666667,254.7222222,1379.2,7466.277778,1045.433333,397.6111111,1299.611111,5447.988889,671.1111111,160.4333333,1349.555556,5170.444444,1356.844444,582.7777778,3218.111111,660.9111111,609.3888889,90,14.18303812,8.317700744,0.809982468,0.957446809,0.576923077,0.775900803
+2778,41286.9881,974.047619,531.6428571,1092.785714,36297.05952,739.5952381,671.3809524,1574.059524,21136.59524,553.1309524,1238.309524,1740.130952,28438.64286,1355.583333,4870.25,3435.154762,10075.5,1318.892857,343.2738095,2407.880952,20095.52381,551.3333333,223.4404762,1404.238095,25006.47619,513.1666667,259.5357143,3485.107143,18800.08333,2069.321429,680.6190476,2788.059524,16165.44048,637.8928571,287.8452381,1640.5,13237.61905,994.0238095,427.9285714,1297.119048,9301.738095,678.452381,166.6190476,3071.869048,8200.964286,1361.559524,349,3222.952381,822.4880952,608.6428571,84,11.57857523,9.68495088,0.548036439,0.954545455,0.587412587,-1.454528672
+2779,45280.69565,933.8913043,597.1413043,1153.597826,41394.83696,729.0326087,711.0543478,1774.282609,22029.23913,523.5543478,972.0217391,1786.413043,31078.54348,1324.945652,10117.18478,5289.01087,11597.57609,1359.097826,350.2282609,2719.793478,21977.65217,449.6847826,333.8478261,836.3586957,28434.84783,478.8152174,132.2826087,5470.152174,21470.42391,1745.782609,692.3913043,2843.315217,18139.44565,644.6956522,298.75,2561.782609,13522.29348,1018.152174,434.8913043,1302.576087,8120.98913,709.3804348,170.5326087,6506.619565,7838.369565,1336.934783,273.0543478,3259.282609,1004.152174,611.4456522,92,12.82993674,10.26692439,0.599690703,0.910891089,0.547619048,-0.484218308
+2780,54272.31122,949.3928571,607.6938776,1160.22449,53324.66837,902.4132653,761.1428571,1867.72449,27082.69898,608.4132653,1173.882653,1860.729592,34588.08673,1414.153061,5813.25,6343.209184,13468.54592,1523.102041,387.4693878,2442.540816,26257.84694,564.5663265,310.494898,1026.836735,32444.22959,480.3316327,616.5612245,4523.142857,24020.7449,1841.770408,614.2142857,2823.714286,20812.21429,665.4030612,346.3520408,4866.341837,13669.47449,961.627551,485.0765306,1327.556122,9484.908163,725.9540816,184.5867347,5060.576531,8075.234694,1450.760204,359.4183673,3349.72449,171.505102,615.1020408,196,20.39142161,13.95409577,0.729189277,0.813278008,0.6125,0.161133516
+2781,28955.2649,948.5562914,672.3509934,1102.125828,28439.61589,724.0993377,632.4900662,1628.635762,14797.4106,562.9470199,609.4039735,1762.834437,18880.93377,1267.470199,11076.42384,6043.059603,7003.264901,1333.688742,338.7615894,2341.556291,14948.28477,434.7483444,278.1324503,458.9933775,17146.96689,436.4966887,129.3642384,7128.913907,12834.49669,1477.966887,787.0331126,2809.324503,11398.66225,611.7417219,291.4370861,3091.721854,8020.827815,854.6887417,423.8344371,1297.397351,6176.178808,656.5629139,175.4304636,6556.940397,5149.417219,1283.688742,206.1390728,3409.682119,246.9337748,612.4437086,151,16.18999389,13.1457059,0.583706338,0.877906977,0.634453782,-0.688731402
+2782,31504.97297,925.3963964,576.3153153,1077.63964,27836.20721,673.8018018,709.7207207,1574.117117,16327.3964,554.4954955,758.1711712,1779.801802,20406.83784,1235.783784,6766.90991,3923.009009,7567.207207,1314.234234,334.6846847,2550.63964,15320.58559,814.9099099,186.2972973,511.4594595,18544.36036,664.7297297,131.963964,3814.153153,14723.88288,1638.378378,709,2806.198198,12611.4955,605.1531532,286.5135135,1778.693694,8986,1091.747748,426.2882883,1291.648649,6821,650.2072072,170.8918919,5020.162162,6331.468468,1325.225225,345.1981982,3355.252252,293.972973,610.9189189,111,13.82097306,10.52148601,0.648435551,0.940677966,0.776223776,0.325339938
+2783,22236.93333,770.3111111,498.1777778,1048.655556,19939.88889,641.1666667,518.6777778,1432.544444,11966.6,493.8222222,588.9555556,1769.622222,15403.4,1174.755556,4928.633333,3585.844444,5845.788889,1292.566667,316.8,2438.944444,11842.9,550.4555556,1163.688889,455.1222222,13295.95556,435.1111111,121.3666667,4048.077778,10230.35556,1510.455556,744.1777778,2798.3,9017.922222,624.3555556,254.3555556,1399.533333,6934.488889,839.4888889,410.6111111,1370.011111,5328.822222,913.0777778,167.6777778,6333.333333,4933.022222,1280.633333,226.9111111,3167.533333,416.6666667,610.2666667,90,11.87372052,10.14173363,0.520055031,0.957446809,0.629370629,0.554408386
+2784,40089.47138,928.8754209,512.2828283,1106.609428,35143.26936,740.037037,746.0808081,1566.249158,20965.26263,553.6127946,1767.952862,1823.053872,27909.77104,1352.895623,4869.905724,4183.03367,9917.279461,1316.939394,344.6632997,2527.117845,20869.24916,598.1515152,148.5050505,1577.279461,25180.06397,631.5555556,404.5925926,2577.511785,18323.09091,2022.993266,562.3164983,2791.050505,16645.56902,724.1481481,296.4511785,1699.444444,13243.46465,1793.30303,434.047138,1301.377104,9500.912458,668.4983165,168.6666667,3747.670034,8259.861953,1401.646465,496.1717172,3287.13468,778.5420875,615.6430976,297,23.07036921,17.29779002,0.66168285,0.916666667,0.61875,0.019068215
+2785,32221.17117,932.7117117,625.990991,1152.585586,29922.08108,745.3243243,582.8828829,1755.675676,16056.16216,538.5765766,613.1081081,1757.918919,22384.68468,1358.783784,6174.63964,3683.108108,7918.585586,1334.369369,352.0720721,2500.054054,15710.38739,468.6576577,2613.396396,620,18873.14414,489.7027027,134.1261261,3403.72973,14657.08108,1741.369369,822.9369369,2786.945946,12440.46847,734.7927928,285.2702703,2088.855856,9512.945946,1007.054054,439.2072072,1380.036036,6295.216216,1408.261261,172.1981982,7305.387387,5590.036036,1371.927928,473.8198198,3278.45045,953.8378378,611.3963964,111,13.38109324,10.66748802,0.603707354,0.948717949,0.660714286,-0.455536297
+2786,42350.01449,881.4202899,603.942029,1137.144928,39419.3913,710.4927536,582.4202899,1702.014493,22445.07246,555.1014493,523.4202899,1797,27973.13043,1297.898551,7360.289855,6433.652174,10775.52174,1433.84058,355.3043478,2346.072464,20990.47826,494.826087,194.0434783,435.3333333,25644.76812,437.826087,138.4202899,5327.217391,19626.62319,1543.521739,826.6521739,2813.666667,17277.07246,629.1884058,315.2608696,2509.869565,12008.81159,841.0289855,457.4202899,1300.550725,8647.652174,659.2608696,178.1014493,4327.405797,7779.15942,1397.144928,155.8985507,3327.26087,237.1594203,611.2173913,69,12.82943593,7.321551172,0.821169902,0.896103896,0.663461538,-0.216438628
+2787,32825.69277,1074.873494,619.7771084,1101.355422,30136.25904,780.686747,777.6566265,1596.524096,16973.44578,614.6987952,867.2409639,1778.036145,21804.54819,1398.126506,4222.084337,3520.277108,7980.819277,1421.927711,359.4879518,2476.578313,15594.55422,439.126506,446,581.9638554,18334.21687,770.6927711,131.9578313,4355.120482,14393.99398,1738.710843,622.5180723,2833.5,12505.10843,744.5662651,302.1084337,1777.060241,9554.054217,1106.60241,457.126506,1394.084337,7409.355422,741.813253,180.5963855,6849.385542,6667.144578,1397.198795,200.8192771,3458.240964,366.9277108,613.3192771,166,16.91576663,13.04847515,0.636375446,0.948571429,0.614814815,-0.409579659
+2788,23794.15116,979.0813953,1001,1137.395349,22350.31395,725.5,1269.790698,1607.267442,12070.7907,577.372093,1554.802326,1788.302326,15976.89535,1333.05814,3275.174419,4292.22093,5725.418605,1361.627907,338.7093023,2611.930233,11664.53488,623.9767442,130,1244.453488,12722.82558,1420.860465,128.0581395,1947.918605,9891.976744,1527.244186,661.4767442,2818.395349,8953.523256,778.6162791,281.5116279,1823.534884,7099.488372,1932.27907,444.244186,1331.988372,5433.848837,624.4418605,165.3604651,2420.872093,4743.325581,1355.593023,304.4883721,3503.918605,496.5,609.5116279,86,16.17888797,8.070014972,0.866717627,0.803738318,0.505882353,1.391966627
+2789,49841.86364,945.0151515,541.3787879,1129.5,42154.90909,780.6666667,780.8181818,1670.015152,25352.37879,563,1655.030303,1811.075758,33950.95455,1420.818182,4168.848485,4795.787879,12608.36364,1412.727273,378.1060606,2546.272727,26005.15152,474.1515152,153.6060606,1452.757576,31704.65152,490.2272727,135.8181818,3713.954545,23569.95455,2072.818182,711.6666667,2845.166667,21435.30303,652.3787879,318.8939394,2286.424242,17338.56061,1247.106061,454.1363636,1318.954545,12350.31818,678.9242424,179.2727273,3979.666667,11334.01515,1541.878788,215.8030303,3278.121212,740.9242424,610.3181818,66,11.0540239,8.455225181,0.644148796,0.868421053,0.611111111,-1.245046669
+2790,24579.82569,854.2018349,471.7981651,1059.981651,22005.07339,865.4770642,852.8256881,1486.412844,13129.89908,543.5137615,1536.807339,1778.53211,16844.3945,1323.568807,3038.302752,2570.458716,5936.311927,1299.513761,364.7889908,2424.422018,12239.63303,424.7981651,1230.357798,968.8256881,14047.04587,402.7155963,666.3853211,1997.440367,10948.00917,1864.917431,765.5688073,2821.541284,9434.091743,614.8348624,277.0366972,1339.844037,7318.522936,933.9908257,432.2018349,1346.284404,5637.376147,954.6880734,173.7247706,3455.633028,5168.944954,1404.394495,2017.055046,3187.330275,431.3669725,613.440367,109,14.39487727,10.09713111,0.712729301,0.915966387,0.556122449,1.058475657
+2791,41984.78571,890.6428571,509.3928571,1119.696429,35674.875,742.5535714,619.4107143,1602.178571,22148.75,688.3571429,545.9821429,1781.267857,28799.44643,1391.803571,2538.714286,2112.089286,9810.589286,1454.625,365.9107143,2439.303571,20078.26786,486.7142857,284,519.8571429,24326.73214,436.625,138.4464286,2007,19124.35714,1696.535714,741.1785714,2846.267857,16570.875,936.5,309.25,1833.357143,13057.33929,964.1607143,467.7678571,1345.696429,9710.875,725.1071429,174.4107143,2269.642857,9315.125,1488.482143,458.5357143,3334.535714,546.5178571,611.4107143,56,12.20133324,6.058803503,0.867997267,0.949152542,0.509090909,0.763010805
+2792,26735.01338,818.7173913,490.09699,1057.916388,23342.92475,659.0267559,566.9665552,1467.317726,13423.20401,511.9214047,889.4013378,1777.725753,17803.51505,1211.352843,3766.571906,2795.759197,6498.757525,1263.874582,302.4966555,2522.536789,13404.21405,457.5,246.7859532,651.4849498,16047.80602,478.1822742,233.0719064,2223.183946,12260.4214,1566.698997,742.9882943,2833.90301,10839.85452,883.4899666,254.1438127,1614.038462,8466.443144,1006.498328,387.4816054,1308.908027,6694.269231,647.1555184,150.1839465,2450.12709,5935.83612,1301.715719,1541.454849,3223.386288,617.4565217,621.0735786,598,40.89265981,19.96002515,0.872783364,0.871720117,0.538738739,-0.927221009
+2793,38291.85915,959.6267606,535.1056338,1083.549296,33764.11972,712.084507,576.0633803,1535.197183,20576.29577,556.6056338,907.3309859,1742.957746,26601.05634,1332.126761,4743.119718,4113.894366,9528.992958,1320.760563,344.4366197,2443.922535,19720.35211,431.3239437,135.0704225,621.7323944,24558.14789,423.9084507,122.4788732,3493.549296,17703.80282,1502.119718,823.1830986,2789.126761,16182.94366,623.556338,290.1408451,1960.309859,12731.57746,1087.795775,419.4859155,1293.830986,9075.246479,635.084507,160.5704225,2701.429577,8035.098592,1352.809859,266.1549296,3360.992958,757.8802817,614.8802817,142,17.43135258,10.68495116,0.790103735,0.934210526,0.591666667,-0.765195979
+2794,35325.77326,927.4302326,583.6162791,1112.383721,31540.5,756.3953488,667.0174419,1716.145349,17858.89535,534.8372093,493.3313953,1769.732558,24815.33721,1294.02907,5535.680233,3129.139535,8988.034884,1353.877907,356.7383721,2340.72093,17305.43023,445.5581395,2185.418605,518.3546512,20745.18023,450.8546512,137.3372093,2980.488372,16897.72093,1615.354651,623.8837209,2812.19186,14100.88372,642.627907,285.5465116,2192.116279,10449.22093,826.9476744,431.75,1336.127907,6603.662791,1197.80814,166.2034884,3678.418605,6282.848837,1336.406977,559.7848837,3299.930233,985.9360465,615.8604651,172,20.06331267,11.32882774,0.825327798,0.934782609,0.603508772,0.539023762
+2795,48221.80435,929.4456522,614.7934783,1154.673913,47063.03261,771.1630435,688.4347826,1765.98913,25266.94565,605.75,509.2391304,1760.619565,32033.93478,1392.413043,7439.619565,6352.456522,12124.43478,1472.793478,380.6413043,2353.01087,24196.17391,504.4673913,146.3478261,447.9456522,29431.72826,463.7282609,143.9565217,5153.945652,22253.91304,1569.456522,636.75,2918.086957,19434.82609,660.5869565,327.326087,3888.206522,13687.54348,927.0978261,483.6195652,1328.108696,9814.358696,674.5108696,187.1847826,4721.630435,8512.771739,1468.173913,308.1956522,3394.98913,221.3152174,614.1630435,92,15.12900561,8.322978993,0.835076453,0.884615385,0.544378698,-0.860482039
+2796,27794.53237,1004.841727,603.6330935,1091.05036,25629.15827,726.8129496,668.2589928,1557.539568,13996.98561,566.2733813,547.5899281,1763.539568,17853.33094,1290.971223,4010.201439,2373.467626,6604.870504,1357.827338,340.057554,2452.23741,13941.61871,429.8920863,284.9784173,449.7266187,17066.14388,445.7625899,127.8633094,4657.230216,12993.18705,1495.647482,551.4964029,2838.726619,11281.41007,820.5755396,280.9352518,2514.309353,7935,820.9928058,432.2158273,1313.007194,6230.007194,703.4532374,174.057554,3624.719424,5542.258993,1321.906475,378.4532374,3519.532374,275.6690647,616.2014388,139,16.03274961,11.55542406,0.693206781,0.902597403,0.668269231,0.066608923
+2797,39702.35165,881.9725275,585.6428571,1119.967033,32325.79121,710.1868132,625.4505495,1700.769231,18152.15934,497.456044,672.8351648,1746.763736,25126.60989,1273.043956,8362.093407,4186.923077,9577.71978,1305.126374,350.4945055,2404.82967,17671.84615,461.4175824,575.9120879,798.8076923,23021.11538,459.1978022,129.989011,6564.884615,17752.84615,1694.417582,553.3791209,2793.428571,14542.36813,1211.434066,279.521978,2176.664835,10904.31319,851.3296703,417.6758242,1308.730769,6057.489011,735.1593407,165.6153846,4021.175824,6313.71978,1292.950549,2020.027473,3318.917582,1030.010989,617.1043956,182,19.16148754,12.61612391,0.75265906,0.866666667,0.563467492,-0.639849274
+2798,40696.9,864.5375,629.64375,1118.475,12158.63125,465.54375,360.75625,1288.16875,5877.6625,363.34375,857.2375,1627.6375,8537.2125,928.3875,6690.7625,1989.91875,3196.11875,948.08125,245.2,2818.2625,5894.05625,372.0375,423.925,756.175,7123.175,364.2125,102.9625,4305.84375,5540.4,1561.64375,407.85625,2779.3125,4374.1375,485.4125,196.6375,1179.93125,2934.7625,796.96875,319.53125,1262.41875,1436.84375,561.76875,130.0375,1928.975,1592.59375,868.9125,253.03125,2909.4875,1096.2875,614.5,160,14.44555394,14.12810927,0.208488825,0.958083832,0.711111111,-1.006250976
+2799,46490.85915,972.0140845,741.7605634,1231.197183,36710.15493,697.9577465,794.6267606,1768.373239,16849.71127,522.0211268,802.0140845,1768.140845,21901.33803,1189.415493,8320,4233.352113,8722.661972,1265.866197,337.1197183,3128.950704,16922.21831,401,498.5140845,776.5704225,19408.99296,416.7042254,128.7112676,5981.401408,14339.79577,1802.5,419.6338028,2817.647887,12224.57746,574.3802817,290.3098592,5068.915493,6365.859155,905.4859155,416.9507042,1305.887324,4553.485915,716.1197183,153.8380282,3274.816901,4175.422535,1174.035211,202.0633803,3223.028169,132.2957746,617.1126761,142,15.18803218,12.17951314,0.597437937,0.934210526,0.696078431,-0.178573204
+2800,48898.24444,951.2888889,625.9555556,1144.733333,46393.57778,782.6888889,566.2444444,1813.444444,25239.28889,605.7111111,513.6,1784.4,31890.13333,1399.266667,7709.977778,6940.866667,11759.31111,1485.555556,382.8444444,2358.088889,25017.15556,487.3111111,147.5777778,444.4222222,29029.53333,466.7333333,144.1111111,4841.777778,22183.82222,1586.311111,660.6888889,2834.044444,19384.17778,647.9555556,338.8888889,2479.066667,13765.28889,899.8666667,496.2222222,1319.822222,10135.62222,677.8,183.4444444,4156.288889,8754.688889,1456.688889,174.2,3381.155556,230.0444444,613.3111111,45,9.946759774,6.00125457,0.797485857,0.882352941,0.714285714,-0.311453091
+2801,25218.185,841.645,530.645,1075.02,23382.985,679.57,604.445,1542.17,12937.17,538.095,500.24,1763.35,16301.65,1255.575,3320.83,3177.625,6032.115,1422.315,337.435,2361.125,12762.06,427.17,622.075,468.085,14986.415,417.315,126.73,3046.365,11601.92,1547.73,718.85,2851.405,10088.405,892.48,286.705,1727.845,7401.86,814.085,447.365,1387.745,5857.915,762.26,176.195,6079.985,5052.535,1362.62,1541.32,3248.465,308.005,616.215,200,17.1819905,15.37918081,0.445914379,0.917431193,0.694444444,-1.182342231
+2802,38906.27891,1021.469388,592.3469388,1107.387755,35832.68027,764.5578231,887.3741497,1633.52381,20734.37415,617.8639456,1365.482993,1797.108844,26293.36054,1372.510204,6237.44898,3992.92517,9548.034014,1442.197279,362.7414966,2432.129252,20218.09524,632.8503401,843.2312925,780.3197279,23145.68027,466.0408163,142.3809524,5484.530612,17958.06122,2415.823129,611.0884354,2855.680272,15765.14286,669.1360544,310.292517,1476.829932,11391.10204,1229.877551,467.7346939,1333.306122,8764.795918,813.8639456,179.7210884,3551.081633,7548.190476,1385.401361,149.4761905,3444.741497,328.9251701,615.5306122,147,15.38143159,12.24303925,0.605346232,0.948387097,0.706730769,-1.390976169
+2803,21248.68718,830.3282051,435.5333333,1053.333333,18835.31795,656.7435897,580.2615385,1427.14359,11316.20513,516.0820513,507.4666667,1740.476923,14900.43077,1264.733333,1169.035897,1030.369231,5300.169231,1299.85641,329.8820513,2377.179487,11481.70256,422.9589744,227.9435897,475.4564103,12968.99487,539.9538462,125.8564103,1011.420513,10079.2,1415.820513,670.3384615,2834.092308,8880.34359,773.2153846,276.8615385,1674.517949,7016.861538,854.6102564,430.2,1317.076923,5400.702564,687.5128205,168.3846154,2021.805128,5022.769231,1406.112821,3388.897436,3232.974359,444.774359,618.1333333,195,19.71603855,13.02952421,0.750509961,0.906976744,0.696428571,0.058166254
+2804,25263.66016,843.3515625,635.953125,1078.621094,22550.88281,677.9765625,826.8984375,1513.898438,12814.01172,606.5546875,1115.476563,1783.441406,17357.11719,1264.910156,5035.789063,2917.183594,6098.644531,1308.347656,324.6953125,2703.609375,13040.10156,540.65625,617.671875,693.4960938,15473.73438,720.1171875,126.8203125,1397.855469,11817.57813,1756.621094,677.5390625,2820.90625,10548.26563,717.9414063,268.2695313,1419.296875,8286.210938,1206.242188,412.7890625,1353.8125,6500.777344,762.2226563,161.1289063,3192.003906,5864.230469,1332.777344,645.9023438,3264.757813,597.8945313,619.0625,256,22.68776482,15.88906382,0.71381311,0.844884488,0.64,-1.079604586
+2805,24878.89041,1009.828767,506.3972603,1109.924658,21977.4863,764.4931507,451.9041096,1500.445205,12744.55479,572.2534247,676.4452055,1691.321918,16997.5137,1506.541096,1083.691781,1323.719178,5783.815068,1334.856164,372.239726,2374.582192,12634.55479,493.5205479,123.6712329,942.9178082,15554.89726,457.0616438,130.1575342,861.4109589,11679.05479,1577.315068,552.2534247,2809.958904,10450.73973,825.7876712,291.7328767,1619.253425,8634.178082,1408.40411,437.6712329,1326.226027,6506.465753,670.9178082,177.8630137,1698.472603,5621.280822,1707.993151,10514.46575,3201.993151,679.3767123,615.1164384,146,14.42856704,13.01475035,0.43170955,0.966887417,0.651785714,1.288916952
+2806,21835.52239,914.4776119,466.9154229,1062.159204,19826.02985,700.2238806,455.0746269,1405.363184,11247.14925,530.4378109,402.761194,1678.522388,15221.79104,1333.60199,1713.995025,1865.258706,5485.58209,1233.412935,325.8308458,2305.845771,11852.48259,432.6467662,424.7711443,461.9452736,14560.64677,497.60199,117.960199,1479.746269,10934.11443,1363.512438,568.4776119,2787.442786,9793.308458,689.2885572,271.4477612,1767.104478,8016.78607,844.8258706,408.5024876,1311.945274,6319.199005,732.9800995,165.3830846,2156.80597,5551.741294,1470.089552,5292.069652,3128.955224,703.1641791,617.7562189,201,20.38231833,12.9773952,0.771112696,0.930555556,0.705263158,-0.368130311
+2807,51004.48945,1001.105485,642.8523207,1184.658228,44016.81013,755.0801688,665.3122363,1848.164557,23656.6962,537.1983122,756.9578059,1752.316456,33246.4135,1369.472574,7552.594937,4563.189873,12400.10549,1397.797468,360.0590717,2510.388186,23218.55696,475.8227848,225.4177215,621.2489451,30030.6962,493.4936709,137.628692,4758.118143,22619.59916,1910.679325,553.1940928,2814.337553,18565.72152,793.9493671,301.835443,2119.679325,13973.78059,900.4978903,445.5274262,1300.383966,8132.898734,665.5864979,169.1772152,3411.523207,7927.265823,1361.831224,405.6413502,3294.464135,1014.759494,617.835443,237,20.00143559,15.92815685,0.604835178,0.881040892,0.593984962,-0.941705149
+2808,59981.97297,945.9189189,609.5405405,1150,58060.08108,797.4594595,857.0540541,1821.810811,30884.48649,612.4324324,581.5945946,1775.702703,39407.51351,1441.756757,6276.783784,7161.810811,15098,1542.567568,394.027027,2393.891892,28909.35135,507.2702703,143.1081081,468.8378378,36152.54054,464.5405405,163.5135135,6673.243243,27150.18919,1660.054054,774.972973,2828.972973,23592.05405,672.8648649,354.1621622,3066.837838,16227.10811,922.7027027,492.972973,1307.567568,11364.08108,666.7837838,187.2702703,3340.081081,9618.972973,1488.432432,169.9459459,3374.621622,190.3513514,613.4324324,37,8.845165737,6.327650199,0.698736129,0.822222222,0.4625,-1.402083488
+2809,28788.81651,1137.807339,607.4495413,1088.458716,26672.45872,686.3302752,972.1834862,1452.678899,15063.81651,547.7522936,1334.311927,1746.972477,19451.9633,1225.587156,5502.761468,3602.275229,7026.568807,1332.926606,332,2682.715596,15693.86239,408.1834862,425.4862385,676.8256881,17605.93578,969.2018349,124.0825688,3571.284404,13228.37615,1524.119266,640.1651376,2805.211009,11709.01835,579.3669725,263.8623853,1483.541284,9076.889908,1021.724771,429.733945,1330.009174,7233.073394,769.6055046,168.2844037,3334.844037,6382.477064,1323.045872,190.5412844,3337.568807,406.9541284,615.1559633,109,15.00822023,10.02474953,0.744205625,0.872,0.567708333,-1.525763493
+2810,27796.06098,1288.353659,569.8536585,1107.292683,26389.04878,916.2926829,685.2317073,1657.195122,13993.08537,656.3780488,1363.256098,1741.95122,18930.29268,1531.304878,2490.634146,2674.926829,6569.170732,1430.02439,357.4268293,2399.341463,12627.0122,509.9146341,181.5121951,934.1341463,15075.02439,905.804878,138.695122,2110.414634,11500.02439,1926.280488,602.695122,2806.719512,10135.54878,651.8658537,324.1463415,1596.414634,8051.829268,1908.231707,451.5609756,1325.390244,6440.52439,974.4268293,178.8902439,1748.292683,5662.390244,1532.963415,231.7317073,3393.756098,655.6707317,616.1097561,82,11.22147161,9.705664904,0.501911332,0.964705882,0.621212121,0.182159719
+2811,45756.09524,897.6285714,506.6666667,1077.285714,40572.70476,740.6095238,823.6,1625.4,23893.17143,551.6857143,1931.685714,1783.438095,31748.41905,1319.085714,4595.4,4587.657143,11331.4,1327.961905,378.2857143,2739,22579.37143,447.2857143,644.0095238,1199.52381,27898.2,1078.933333,136.2952381,2418.019048,20988.97143,1863.466667,569.1904762,2825.409524,18203.87619,649.4285714,283.4571429,1603.4,14618.81905,1704.609524,435.9047619,1331.780952,10311.5619,784.1047619,165.4666667,4132.428571,9178.961905,1362.67619,256.1619048,3258.8,815.3714286,615.7714286,105,13.1511776,10.73327827,0.577846039,0.875,0.576923077,1.189452869
+2812,33048.07407,987.0925926,662.3611111,1108.37037,31109.97222,700.962963,563.787037,1594.787037,16728.87037,567.3888889,504.6944444,1759.638889,21463.58333,1270.592593,7398.787037,4632.185185,7859.462963,1357.981481,342.9537037,2436.490741,16464.60185,421.1944444,254.0740741,428.5833333,20015.66667,410.6203704,129.1759259,6254.666667,15033.05556,1506.009259,641.9074074,2804.388889,13148.5463,612.962963,285.5185185,1927.601852,9262.75,827.5462963,432.962963,1312.462963,7188.768519,694.25,172.6296296,4276.064815,6332.444444,1322.490741,156.3148148,3374.453704,265.2037037,619.0462963,108,15.02202046,10.81202773,0.694238279,0.9,0.519230769,-0.483146318
+2813,31473.42623,1281.557377,660.9344262,1169.459016,30916.72131,930.147541,784.4918033,1949.540984,16479.65574,698.0655738,588.3278689,1805.885246,21617.54098,1586.967213,5875.442623,3550.885246,7557.672131,1570.885246,405,2403,16690.39344,507.9016393,440.7213115,463.442623,19474.95082,514.2295082,151.7213115,3407.163934,14617.85246,3353.852459,808.5901639,2845.262295,12930.36066,711.6229508,365.6393443,1455.04918,9897.52459,1139.016393,523.3934426,1355.622951,8053.409836,1610.918033,197.2131148,2189.278689,6910.114754,1650.704918,154.7868852,3485.737705,389.1803279,615.0655738,61,11.13108047,7.568384931,0.733274577,0.835616438,0.508333333,-0.977664909
+2814,35068.55556,1002.256944,864.9166667,1130.270833,31478.43056,779.0347222,977.2152778,1658.305556,18690.52083,676.2986111,1432.395833,1794.673611,24072.21528,1404.708333,3136.972222,2824.166667,8463.625,1439.645833,365.5972222,2453.423611,18722.08333,527.2291667,314.7430556,933.9097222,20525.125,649.2013889,132.9027778,1819.131944,15831.16667,1835.465278,675.7361111,2838.291667,13926.29861,662.5138889,311.8472222,1559.597222,11004.52778,1469.201389,472.3958333,1332.277778,8096.152778,674.1319444,177.7222222,2243.618056,7666.4375,1449.277778,194.8541667,3406.381944,490.0138889,616.3125,144,19.51796818,9.75448607,0.866158416,0.905660377,0.654545455,1.51298373
+2815,31557.04505,943.8918919,661.8918919,1123.09009,28684.16216,745.7477477,646.3243243,1584.333333,16423.09009,651.4234234,554.3333333,1765.234234,21560.13514,1391.126126,1547.18018,2080.252252,7646.531532,1443.459459,359.1891892,2504.072072,15746.85586,519.2162162,260.1801802,523.0900901,19196.98198,466.1711712,135.4144144,1510.666667,13676.0991,1586.198198,683.3693694,2816.063063,12369.63063,712.6486486,291.6396396,1839.252252,9775.414414,987.5135135,459.5225225,1371.747748,7563.72973,710.6576577,177.9369369,2849.747748,6597.126126,1494.693694,2751.045045,3327.603604,525.972973,616.7207207,111,12.9161456,11.261992,0.489628182,0.940677966,0.656804734,-0.728649632
+2816,32396.51515,985.2222222,609.7979798,1100.131313,28724.64646,735.2727273,741.3333333,1514.757576,16690.15152,599.8282828,617.7575758,1754.393939,21972.44444,1349.373737,3519.272727,2554.222222,7437.010101,1366.060606,347.1515152,2435.434343,16219.31313,472.5252525,284.6767677,626.7171717,19128.10101,598.3333333,126.4646465,2858.636364,14582.16162,1564.777778,742.4949495,2801.323232,12833.59596,667.1010101,293.4747475,1879.40404,10004.45455,912.4343434,456.3434343,1332.10101,7695.020202,718.5959596,169.959596,3491.232323,7004.232323,1377.666667,218.5858586,3421.40404,556.6262626,616.6666667,99,13.16528571,9.770909951,0.670209165,0.942857143,0.6,-1.330541824
+2817,29546.85965,1084.552632,510.1754386,1069.149123,24816.2193,739.1578947,702.9473684,1480.105263,14954.34211,584.3508772,1084.745614,1703.640351,18844.71053,1345.45614,2989.114035,3014.964912,6568.245614,1241.105263,309.1491228,2467.666667,13058.7193,418.7017544,108.5789474,676.3684211,15537.45614,1071.850877,115.2894737,1643.096491,12204.57895,1496.938596,643.2982456,2795.008772,10598.30702,597.2894737,258.254386,1542.350877,8361.614035,1341.236842,390.9035088,1287.815789,6264.447368,608.9473684,147.8947368,2142.587719,5376.070175,1268.973684,573.3245614,3303,643.4736842,617.3157895,114,15.76322994,10.38647418,0.752225988,0.826086957,0.584615385,-1.436366266
+2818,45693.31395,863.6976744,481.6744186,1093.395349,39898.89535,702.6046512,940.3488372,1519.348837,23999.94186,536.4651163,1713.05814,1806.174419,31766.02326,1322.418605,3717.860465,3517.069767,11418.75581,1338.453488,345.4651163,2477.255814,23822.72093,452.1162791,411.9302326,1292.895349,29087.77907,490.4069767,395.8372093,1838.953488,21598.93023,2233.651163,693,2791.5,19432.7093,633.9418605,277.5,1628.313953,15633.5814,1507,432.6511628,1308.546512,11187.36047,724.3953488,166.2906977,2073.116279,9802.360465,1389.953488,220.8139535,3226.895349,791.4651163,616,86,13.03121796,8.655176176,0.747565748,0.955555556,0.651515152,-0.612800538
+2819,30256.72059,873.5441176,466.75,1093.617647,25886.70588,697.3529412,550.0588235,1569.573529,15182.19118,529.4852941,626.1029412,1769.294118,20374.61765,1281.588235,2640.161765,1966.779412,7580.794118,1293.691176,349.3823529,2360.514706,15306.85294,461.1176471,806.3235294,577.5147059,18486.14706,442.1617647,134.3235294,1328.426471,14476.98529,1698.705882,628.6764706,2859.558824,12752.30882,1151.75,278.8382353,1620.470588,9897.808824,1055.205882,424.0147059,1316.661765,6903.088235,919.8088235,164.6323529,2354.764706,6429.352941,1353.294118,1345.397059,3186.073529,857.3088235,615.7352941,68,10.88461673,8.091124459,0.668898112,0.957746479,0.68,0.766038886
+2820,43573.36134,916.2436975,581.0966387,1141.273109,41782.63025,748.0672269,675.1554622,1750.52521,23097.28992,583.0798319,599.7689076,1804.752101,29805.32773,1341.07563,7041.176471,6693.046218,10990.17227,1431.655462,363.5546218,2358.508403,22143.37395,474.3613445,196.9327731,465.0462185,26957.39496,447.3697479,161.0672269,5229.676471,20684.92017,1598.915966,908.4663866,2824.710084,18086.91597,641.9243697,331.7394958,3779.941176,12376.92437,890.1764706,468.5210084,1318.415966,8776.857143,679.4159664,182.9327731,4214.546218,7584.151261,1436.105042,207.3865546,3366.05042,205.802521,623.6722689,238,26.09864182,12.64967207,0.874687673,0.859205776,0.544622426,-0.532723295
+2821,33949.43511,973.519084,580.1984733,1100.335878,29506.92366,737.7557252,597.7633588,1611.541985,17903.38931,562.9541985,544.4732824,1812.351145,23388.45802,1337.465649,5669.419847,3602.10687,8223.977099,1397.740458,355.6793893,2458.030534,16212.93893,452.1908397,635.1679389,487.6183206,18946.92366,551.7251908,130.7633588,4345.053435,14775.35115,1535.129771,734.1832061,2823.396947,12914.91603,637.9694656,288.4961832,1585.938931,9807.015267,918.5496183,443.0152672,1324.129771,7341.114504,1011.671756,175.2748092,3332.610687,6784.59542,1408.374046,189.0229008,3401.21374,398.4274809,621.6335878,131,19.83777532,9.275339678,0.883961619,0.784431138,0.574561404,0.288405725
+2822,29212.9898,914.8469388,505.4489796,1078.836735,27060.34694,735.4897959,559.7142857,1466.765306,15479.05102,562.7653061,544.2755102,1719.418367,20240.08163,1415.469388,1539.071429,2878.693878,7028,1365.346939,359.122449,2382.520408,14166.47959,450.1734694,223.7857143,546.7244898,16335.39796,464.7755102,131.755102,2628.316327,12254.17347,1530.816327,848.9285714,2821.5,11125.36735,630.2755102,296.0306122,1657.418367,8841.581633,948.1326531,455.2142857,1316.714286,6828.653061,658.3265306,179.7959184,2259.857143,6153.153061,1502.806122,4059.673469,3199.540816,456.3469388,616.9693878,98,12.66580702,10.08149169,0.605347566,0.924528302,0.685314685,1.355825555
+2823,40048.06154,901.1230769,638.3692308,1112.384615,35694.8,770.6615385,905.6923077,1571.523077,21077.29231,618.2461538,1916.430769,1853.446154,27772.35385,1380.2,2374.953846,3258,9580.876923,1474.661538,361.1538462,2434.184615,20497.98462,490.7230769,166.2307692,1283.815385,24323.6,445.7384615,162.6461538,1454.584615,18500.38462,2246.569231,712.2153846,2837.184615,16395.03077,759.1076923,310.9076923,1629.584615,12845.92308,1545.8,472.8923077,1344.353846,9707.830769,673.4153846,176.4,1621.307692,8828.230769,1471.8,275.1538462,3294.8,543.7230769,618.4615385,65,11.31079203,7.991338229,0.707689771,0.915492958,0.601851852,0.117515013
+2824,37741.29193,913.2173913,555.0248447,1130.167702,34793.8323,729.5093168,668.689441,1751.670807,18845.50311,528.5652174,1273.975155,1828.515528,26695.49068,1297.434783,5736.136646,4362.869565,9518.57764,1358.770186,342.2919255,2371.664596,18424.22981,1005.099379,390.3416149,627.2360248,22327.32919,473.7267081,131.2049689,2788.273292,17385.08696,1564.490683,675.9937888,2794.074534,14665.49068,770.6459627,287.6770186,2096.074534,11059.55901,1846.136646,426.1614907,1322.68323,7184.329193,829,165.5403727,4449.627329,6425.167702,1698.440994,583.3540373,3308.850932,960.484472,621.0248447,161,21.98685507,10.05663455,0.889264642,0.860962567,0.470760234,-0.917199381
+2825,33128.77551,845.627551,624.5306122,1107.306122,25290.55612,619.6683673,575.3469388,1624.433673,13637.83673,452.4489796,838.872449,1734.607143,18905.75,1140.77551,9589.566327,4366.637755,7208.928571,1177.081633,308,2551.096939,13275.20408,420.0357143,936.6683673,859.2397959,16725.03061,405.2346939,125.3928571,9269.295918,13265.78571,1772.25,597.8928571,2799.877551,10715.59694,669.7908163,251.5663265,2831.244898,7745.5,837.6122449,383.3367347,1305.918367,4162.94898,801.0714286,150.4693878,5470.515306,4428.096939,1136.040816,529.3010204,3237.923469,1054.5,620.7397959,196,18.74764614,14.5775063,0.628803042,0.899082569,0.606811146,0.611965552
+2826,63766.89362,1024.212766,584.2893617,1207.52766,63234.84681,923.7574468,887.2893617,1968.374468,34505.22979,652.2297872,936.4170213,1829.685106,45751.48936,1542.102128,5728.859574,6844.923404,17496.78723,1633.923404,422.5404255,2378.757447,34091.61277,530.693617,169.2851064,921.0297872,41935.66809,513.3319149,465.2468085,4583.987234,31364.51064,1920.753191,571.3234043,2830.361702,27266.10213,694.3446809,372.9106383,2507.821277,17110.31064,989.2638298,509.693617,1323.242553,11573.81702,698.2382979,191.9829787,2690.987234,10181.32766,1549.812766,196.5574468,3389.859574,159.2382979,624.9744681,235,21.03064234,15.52134748,0.674762569,0.815972222,0.543981481,-0.336391942
+2827,27192.38158,870.3684211,530.1710526,1089.157895,25377.89474,728.1315789,1019.473684,1528.947368,14083.38158,691.6578947,1493.118421,1792.526316,18783.59211,1314.197368,1894.473684,2953.013158,6579.947368,1450.092105,379.9210526,2492.25,13789.46053,463.9736842,233.9078947,1369.052632,16656.17105,447.5789474,159.2631579,1117.486842,12026.65789,1951.513158,682.8157895,2838.039474,10725.28947,932.6315789,294.1184211,1628.052632,8482.342105,1224.460526,447.9473684,1341.368421,6707.960526,674.4605263,173.0263158,2043.776316,5782.684211,1414.434211,993.3157895,3288.171053,536.4868421,618.3157895,76,12.76794754,9.003631945,0.709033725,0.775510204,0.575757576,0.070401212
+2828,32982.51923,841.5865385,497.1057692,1087.192308,28184.11538,694.6730769,650.4230769,1490.673077,16495.83654,682.2403846,735.8365385,1789.519231,22541.57692,1271.471154,4727.894231,3013.355769,8163.990385,1283.346154,347.8269231,2364.019231,17020.53846,406.125,715.4807692,931.1923077,21111.97115,416.8461538,121.2019231,3278.798077,15095.85577,1664.25,639.25,2776.432692,13706.49038,622.3173077,266.9134615,2139.057692,10983.73077,1041.067308,409.0192308,1328.903846,8110.846154,800.0192308,167.9134615,4978.461538,7216.221154,1345.567308,489.6923077,3218.451923,742.9519231,618.3269231,104,14.04716889,9.837487419,0.713830848,0.912280702,0.675324675,-1.321319054
+2829,45221.35417,900.9375,505.4375,1120.28125,41463.26042,717.28125,698.8958333,1580.072917,23821.375,551.8541667,1246.020833,1794.302083,31973.83333,1367.572917,3565.916667,3488.40625,11307.9375,1355.822917,350.40625,2521.5,23659.72917,456.6875,230.03125,1115.53125,28927.94792,723.1875,132.4791667,2726.5,21648.63542,1929.052083,689.0625,2807.677083,19090.45833,628.8854167,300.7708333,1711.760417,15483.44792,1330.958333,448.9479167,1296.25,10973.94792,700.4166667,175.3333333,3371.895833,9576.114583,1429.927083,233.8958333,3256.697917,801.8958333,617.7083333,96,14.740864,8.416583216,0.820971297,0.941176471,0.671328671,-1.012238568
+2830,59468.1,932.0857143,523.7571429,1151.257143,55244.81429,843.4857143,984.4714286,1814.6,30318.48571,611.0714286,1086.785714,1842.385714,38026.22857,1428.557143,4678.871429,5613.3,14542.32857,1517.514286,403.3428571,2367.4,28446.07143,1860.114286,154.8571429,1051.228571,35389.6,497.7428571,1119.4,3260.057143,26805.3,2182.542857,564.2571429,2857,23304.52857,665.1142857,350.0714286,2154.271429,15706.31429,1024.685714,504.7142857,1302.585714,10915.35714,681.3285714,191.2142857,4196.471429,9422.285714,1473.271429,175.1285714,3416.685714,185.1428571,618.9428571,70,11.01249076,8.575912297,0.627341704,0.864197531,0.636363636,1.130034322
+2831,40715.16667,886.8,589.1333333,1123.2,40509.8,753.8333333,754.8222222,1735.2,20885.77778,562.4444444,1270.111111,1888.988889,27433.45556,1350.344444,7368.833333,6989.244444,10187.56667,1423.666667,364.4111111,2396.811111,20875.26667,462.7666667,151.4555556,984.0333333,25690.53333,447.7111111,549.9555556,5777.855556,18722.3,1878.488889,936.6888889,2854.211111,16681.94444,625.8555556,325.9222222,3979.522222,11558.84444,928.1444444,465.5444444,1316.066667,8508.266667,656.3888889,180.9111111,6202.355556,6935.611111,1390.9,321.7666667,3354.277778,194.7333333,621.0444444,90,14.73835433,8.083616908,0.836167042,0.891089109,0.545454545,-0.311074243
+2832,25154.89873,897.8227848,575.8164557,1083.493671,23793.40506,732.6455696,749.0886076,1540.335443,13106.67089,563.2848101,891.1392405,1764.126582,17093.20253,1322.5,3801.398734,3004.28481,6168.379747,1394.740506,333.8860759,2461.85443,13272.51266,455.164557,141.2278481,1074.436709,15246.16456,760.9493671,160.4746835,2989.177215,10928.5443,1601.563291,696.7721519,2811.708861,9924.329114,816.056962,285.6518987,1952.151899,7883.791139,1318.740506,444.0379747,1333.613924,6184.240506,640.4810127,173.7405063,3227.582278,5348.132911,1392.5,817.7025316,3275.474684,507.556962,622.4556962,158,16.39770545,13.57936024,0.560542534,0.827225131,0.6171875,0.970464366
+2833,32910.59155,970.8521127,544.1338028,1074.732394,30645.08451,683.9859155,844.8661972,1890.830986,16661.64085,519.971831,1599.838028,2102.746479,23797.35211,1261.626761,6284.852113,4307.908451,8498.232394,1275.661972,332.4929577,2605.584507,18336.96479,440.3309859,141.9929577,1680.21831,22594.84507,1199.112676,151.4366197,3798.908451,15657.41549,1818.056338,639.2323944,2803.43662,14398.20423,692.4647887,281.415493,1810.204225,11527.8662,1449.65493,413.3943662,1302.56338,8519.049296,642.528169,166.9084507,3181.788732,7327.380282,1351.71831,364.3380282,3287.429577,767.3943662,622.5774648,142,17.13044848,11.34441366,0.749294601,0.87654321,0.556862745,0.304861897
+2834,31825.23077,814.041958,517.7412587,1087.384615,28454.16084,710.7902098,458.7552448,1602.993007,15518.31469,492.1888112,626.020979,1796.104895,22035.2028,1281.93007,4536.769231,2586.27972,7864.496503,1250.363636,331.8881119,2405.797203,15406.86713,575.7762238,868.6643357,650.4825175,18732.06294,445.7272727,127.3706294,2770.993007,14748.45455,1539.258741,585.3356643,2848.636364,12253.08392,1058.573427,269.2727273,1686.027972,9452.405594,832.1538462,409.7552448,1312.307692,6522.748252,850.2797203,162.0979021,5576.034965,5827.398601,1238.867133,510.1538462,3287.839161,916.0769231,621.5944056,143,19.5127268,10.6499678,0.837918105,0.841176471,0.611111111,-0.151537594
+2835,45244.41085,894.4496124,574.4573643,1110.418605,40449.67442,741.6666667,909.9069767,1740.651163,23059.9845,537.8992248,754.2945736,1731.333333,31937.45736,1355.96124,6214.914729,4112.51938,11615.5969,1377.457364,358.2635659,2442.395349,22608.92248,453.6744186,1234.139535,816.9069767,27597.47287,455.5581395,136.3875969,3624.945736,22322.50388,1864.837209,563.0387597,2804.348837,18892.71318,957.744186,287.9534884,1942.193798,14037.73643,948.2093023,431.5116279,1338.457364,8814.310078,932.4883721,170.5968992,4699.162791,8251.883721,1401.868217,417.2248062,3280.682171,975.4108527,621.2790698,129,14.59584357,11.54998135,0.611402346,0.908450704,0.614285714,-1.05101534
+2836,28651.24658,818.3972603,498.1849315,1095.972603,25914.21233,669.4863014,620.2054795,1565.636986,14773.93151,512.5068493,815.8150685,1798.013699,20022.87671,1250.842466,4503.458904,4027.479452,7271.472603,1258.876712,316.6232877,2407.308219,15738.84932,409.3356164,205.8150685,918.8219178,19409.81507,483.3630137,119.0068493,3561.828767,13802.86301,1699.075342,856.8561644,2777.876712,12663.16438,607.260274,269.6712329,2009.541096,10106.69863,1121.582192,409.0547945,1308.136986,7479.527397,663.7671233,162.1369863,3912.178082,6615.232877,1337.794521,267.5205479,3229.869863,729.5890411,622.2191781,146,15.83288131,12.23904633,0.634388392,0.924050633,0.648888889,-0.807323983
+2837,30623.43541,837.1100478,508.507177,1062.708134,26925.28708,675.5933014,722.4449761,1508.732057,15368.62679,508.7464115,1741.669856,1832.330144,21453.5311,1226.564593,3860.760766,3981.588517,7566.569378,1266.746411,333.5502392,2742.090909,15458.99522,738.215311,663.5023923,1732.090909,19217.27273,886.1148325,207.2583732,2276.722488,14296.1244,2308.368421,719.2057416,2800.61244,12207.2488,618.937799,274.1578947,1677.148325,9743.746411,1481.952153,413.0574163,1313.947368,7020.148325,766.8421053,161.6602871,5023.023923,6202.30622,1277.282297,308.9856459,3234.478469,835.3205742,623.6267943,209,23.01656027,13.02597992,0.824446794,0.81640625,0.55,-0.557151891
+2838,22997.55405,782.0337838,488.1824324,1102.324324,21503.02703,724.3378378,495.7094595,1609.243243,11506.97973,477.6418919,695.5675676,1825.695946,16969.89189,1316.689189,3930.560811,2020.655405,6063.574324,1193.743243,314.0337838,2392.054054,11624.25,11825.36486,701.8918919,597.1824324,14388.13514,556.0135135,123.2635135,1818.135135,10875.36486,1624.878378,720.7635135,2821.851351,9153.324324,1598.783784,251.8851351,1468,7294.182432,890.0810811,386.7905405,1302.574324,4965.945946,797.0067568,157.6824324,5427.290541,4469.574324,1212.25,319.2635135,3322.858108,905.5202703,622.1081081,148,15.216877,13.35316953,0.47953335,0.93081761,0.660714286,0.52936186
+2839,32443,828.7916667,578.0833333,1091.6875,27374.34375,677.5,594.3541667,1614.40625,16337.35417,491.5833333,657.0416667,1765.291667,22552.36458,1245.395833,4577.5625,3404.822917,8260.302083,1249.041667,323.5520833,2485.53125,15477.96875,428.90625,1601.0625,800.78125,19211.16667,473.3125,126.0729167,3024.96875,15070.78125,1853.572917,825.03125,2782.260417,12635,651.4479167,272.5416667,1928.479167,9705.552083,1038.78125,403.2604167,1333.78125,6131.90625,1030.177083,158.59375,6425.520833,5706.09375,1237.947917,430.9479167,3256.083333,943.8333333,620.8645833,96,12.93198528,9.942798538,0.639425308,0.914285714,0.623376623,-1.499461796
+2840,25286.26207,1167.213793,606.4827586,1083.344828,25681.82759,738.5448276,806.5448276,1615.565517,13996.27586,602.4,1636.937931,1816.903448,17883.66897,1322.8,4013.124138,3214.517241,6359.682759,1382.406897,341.3241379,2519.862069,14051.57931,422.5517241,522.8206897,950.4413793,15761.55862,567.6551724,128.8758621,3391.724138,11988.91034,2147.696552,600.0896552,2824.793103,10431.50345,801.6206897,289.5034483,1387.737931,8011.641379,1198.910345,449.1103448,1376.737931,6338.613793,724.2344828,172.5517241,4811.151724,5532.772414,1328.262069,180.9103448,3362.193103,359.4068966,623.662069,145,16.65623937,11.47457663,0.724851068,0.923566879,0.533088235,0.900940807
+2841,20964.9375,839.4921875,516.375,1057.40625,19119.78906,751.5,593.8203125,1477.867188,11242.77344,526.3515625,758.265625,1773.039063,14229.15625,1288.789063,4507.140625,4370.9375,5173.640625,1298.46875,332.546875,2401.015625,12334.64844,463.5234375,1415.8125,708.5625,12390.09375,481.859375,137.4765625,3476.40625,9342.320313,1585.679688,935.2734375,2831.210938,8181.570313,638.40625,282.140625,1816.695313,6379.804688,886.1484375,429.90625,1331,5073.265625,991.171875,179.6171875,5121.03125,4527.046875,1381.703125,987.640625,3184.5,425.3515625,622.1328125,128,15.92933086,10.75856183,0.737457808,0.907801418,0.615384615,1.447235991
+2842,18770.95902,1127.237705,785.5,1100.303279,15647.86066,630.6885246,533.5819672,1457.95082,9360.47541,583.5081967,544.1229508,1736.852459,12348.48361,1237.754098,3627.278689,1912.598361,4704.221311,1358.02459,328.8442623,2402.147541,9447.934426,558.3688525,311.3770492,470.5327869,11445.64754,444.8770492,115.9836066,2184.032787,8458.040984,1496.5,698.4754098,2795.622951,7402.57377,993.5655738,262.4344262,1509.47541,6007.147541,897.2540984,425.6803279,1331.52459,4633.032787,712.8196721,158.7131148,1952.016393,4185.336066,1277.942623,210.2377049,3272.532787,579.8934426,622.1311475,122,13.59217399,11.72817284,0.505439277,0.945736434,0.625641026,-0.400856791
+2843,30681.71503,887.626943,516.4663212,1107.450777,27976.45596,723.0259067,513.7512953,1618.689119,15492.36269,524.9170984,477.4663212,1742.917098,21855.21762,1304.699482,5360.803109,3198.80829,7651.145078,1299.709845,369.3316062,2338.243523,15670.85492,451.6321244,836.6373057,526.8134715,19304.19689,450.1709845,133.6943005,3272.818653,14672.65803,1493.699482,546.642487,2792.720207,12693.25389,732.0362694,280.5181347,2361.393782,9684.036269,922.8911917,428.119171,1321.601036,7089.92228,844.9067358,168.9481865,3891.528497,6088.963731,1385.031088,1175.968912,3260.103627,882.6062176,627.1502591,193,24.02766863,10.45567265,0.900357315,0.901869159,0.670138889,-0.048715406
+2844,28460.46207,783.5724138,529.537931,1077.882759,25525.51724,628.0068966,842.4758621,1660.317241,10748.34483,461.2689655,1941.42069,1810.165517,16842.8069,1168.813793,10953.24138,3810.413793,6449.841379,1158.358621,297.1931034,2442.117241,12160.33793,1420.096552,1659.089655,2008.634483,15242.43448,475.2413793,413.2827586,4179.296552,11425.24138,3159.22069,418.9517241,2820.434483,8728.848276,571.5517241,247.4206897,978.9724138,5569.241379,1374.165517,376.7517241,1292.917241,2648.751724,918.2206897,144.3034483,4212.717241,2975.993103,1057.475862,376.9241379,3184.965517,1123.586207,622.0275862,145,14.75828722,13.65257891,0.379775168,0.895061728,0.56640625,-0.784138476
+2845,34709.64865,862.6621622,616.5675676,1102.743243,34175.44595,691.6891892,633.4189189,1661.351351,18127.87838,541.2972973,532.5135135,1791.148649,23459.37838,1274.094595,8768.824324,6536.716216,9154.891892,1330.094595,344.8378378,2355.135135,18488.60811,455.5,135.2567568,442.5675676,21300.43243,431.5135135,133.6081081,6284.675676,15923.83784,1466.662162,683.0810811,2799.662162,14069.56757,611.6486486,299.5135135,3717.297297,9832.175676,846.7702703,446.9594595,1303.418919,7369.932432,664.6486486,186.1891892,6937.621622,6146.581081,1346.77027,266.7027027,3348.567568,226.0135135,621.3378378,74,17.05567617,6.445549492,0.925841405,0.804347826,0.420454545,-1.067367069
+2846,30195.90123,823.8148148,509.7407407,1058.753086,28732.69136,648.6790123,777.0864198,1584.45679,16102.2963,529.3209877,1248.592593,1801.567901,20012.41975,1200.765432,5363.592593,4771.851852,7231.679012,1312.679012,330.7283951,2454.790123,15768.90123,420.4197531,402,892.9506173,18778.16049,824.0987654,267.4320988,4664.567901,14805.02469,1772.246914,707.5802469,2814.283951,12735.96296,591.2716049,279.691358,1911.506173,9062.333333,1564.469136,430.2098765,1310.888889,7141.45679,709.037037,174.1358025,5350.234568,6272.851852,1347.012346,693.2222222,3253.950617,297.2716049,622.4567901,81,11.87970544,9.403608322,0.611079604,0.861702128,0.613636364,0.941459002
+2847,34460.47143,928.2,600.3,1106.992857,32278.48571,728.5357143,761.3214286,1660.621429,17923.62857,571.6428571,1086.957143,1805.885714,23506.52143,1339.821429,6660.435714,4795.707143,8321.228571,1396.15,358.2928571,2565.871429,17820.23571,739.7071429,383.8571429,648.45,20101.61429,811.2785714,132.7071429,6007.371429,15775.32143,1724.521429,716.8785714,2817.235714,13892.38571,792.8357143,300.45,1658.457143,10635.73571,1122.392857,450.8428571,1335.907143,8294.435714,983.8142857,177.4285714,4858.257143,7227.628571,1381.307143,212.8071429,3356.107143,380.6642857,623.8785714,140,14.09658958,13.09923035,0.369456089,0.921052632,0.622222222,-1.448628168
+2848,39890.90141,923.1901408,533.0211268,1116.042254,33622.21127,761.6267606,695.0140845,1607.190141,20146.52817,553.2464789,1373.302817,1777.950704,27732.75352,1358.852113,4473.866197,3184.521127,10075.62676,1345.84507,360.0774648,2432.443662,20296.78169,458.4084507,546.5070423,1260.387324,24612.80986,496.1338028,463.8098592,1508.450704,19380.93662,2238.422535,817.5070423,2834.971831,17000.02817,661.3450704,289.6267606,1512.830986,13064.40141,1344.119718,437.7112676,1319.352113,9096.147887,834.9859155,171.1549296,3573.753521,8414.901408,1431.471831,1782.93662,3254.866197,854.7887324,623.8028169,142,18.99452153,10.19313878,0.843814021,0.865853659,0.633928571,0.991926694
+2849,32509.99387,820.3619632,533.0981595,1122.134969,25027.28834,633.1349693,577.7852761,1725.239264,10757.17791,445.9447853,758.993865,1795.822086,16298.42331,1127.558282,4437.668712,2256.693252,6032.588957,1142.472393,303.0368098,2457.797546,11583.90798,7778.558282,1282.06135,951.7361963,13879.93252,462.8159509,119.1349693,5565.828221,10890.53374,1850.128834,462.5276074,2836.552147,8429.067485,570.8343558,242.7852761,1003.276074,5249.815951,923.4785276,366.6871166,1282.03681,2526.730061,854.0858896,145.0797546,4240.895706,2754.325153,1040.613497,418.7546012,3181.803681,1113.03681,626.5766871,163,20.33921165,10.37774677,0.860035926,0.915730337,0.597069597,0.251206996
+2850,32461.5,1237.058824,638.2745098,1113.872549,29485.76471,778.6372549,716.5686275,1591.372549,16788.85294,618.1764706,964.4803922,1771.205882,20888.65686,1331.431373,6947.284314,4374.137255,7363.95098,1364.519608,345.2156863,2461.715686,15601.67647,426.7254902,156.8137255,745.1960784,18386.47059,604.6862745,130.627451,4176.480392,14905.04902,1667.441176,525.1960784,2825.04902,12525.32353,594.3823529,285.2941176,1344.254902,8688.705882,1157.27451,441.7254902,1320.313725,6733.098039,624,168.2058824,3469.137255,6060.764706,1268.803922,154.8235294,3431.598039,286.0686275,623.6176471,102,13.08445422,10.06012581,0.639416023,0.953271028,0.772727273,-0.848799238
+2851,30367.3,872.5909091,592.1272727,1086.427273,27386.68182,695.5,678.8727273,1544.545455,16232.66364,549.2,552.9,1756.790909,20850.52727,1283.418182,5609.318182,3528.072727,7469.372727,1368.509091,341.9363636,2441.736364,15064.45455,434.6727273,1301,507.4727273,18015.68182,544.7454545,128.1090909,4015.554545,13684.77273,1545.645455,672.2181818,2819.990909,12009.89091,602.4363636,284.2727273,1765.1,9141.9,876.8727273,437.4545455,1368.545455,6948.9,945.0454545,176.1909091,5346.709091,6297.5,1359.190909,203.3272727,3211.427273,410.9,623.8636364,110,14.49783251,9.929335095,0.728652014,0.909090909,0.705128205,-0.939644736
+2852,35178.84862,1282.83945,568.0458716,1120.458716,30347.00459,912.0779817,670.5045872,1690.917431,17735.98624,660.6422018,1088.261468,1734.155963,24093.08257,1580.275229,2137.490826,2045.087156,8864.077982,1495.055046,390.0688073,2429.022936,17005.08257,563.9082569,153.6284404,1077.050459,21162.40367,800.5275229,250.4220183,1292.431193,15872.45872,2244.481651,601.8990826,2802.545872,14025.76147,684.7247706,331.087156,1484.752294,11204.29817,1430.018349,467.9862385,1314.527523,8690.866972,903.3027523,174.3027523,1611.587156,7889.623853,1619.197248,340.4311927,3403.091743,657.440367,626.5917431,218,22.44078711,13.63479303,0.794251001,0.841698842,0.637426901,-0.898771017
+2853,37775.33766,900.2337662,517.1948052,1093.714286,32787.46753,715.1428571,850.5844156,1631.103896,20077.51948,540.1818182,1173.935065,1789.779221,25865.27273,1283.428571,4245.38961,2865.649351,9190.922078,1291.519481,381.8701299,2564.805195,18440.2987,659.5454545,371.0649351,857.7532468,22641.03896,874.4415584,129.5584416,3255.480519,17553.66234,1721.857143,553.5064935,2812.545455,15142.4026,666.4935065,280.987013,1639.792208,12037.33766,1360.025974,419.8051948,1294.948052,8136.896104,723.2077922,164.1558442,5046.623377,7453.467532,1347.077922,241.1948052,3322.350649,824.4935065,623.2337662,77,11.51511152,8.707806096,0.654332648,0.895348837,0.7,0.152863094
+2854,62540.83206,1027.312977,634.9160305,1209.251908,58766.9542,815.221374,701.8167939,1909.587786,28600.81679,613.5038168,680.5267176,1777.038168,39390.63359,1445.916031,7031.549618,5781.801527,15278.55725,1542.633588,399.9923664,2533.480916,29287.20611,512.9160305,155.2061069,548.0992366,36680.18321,543.4732824,150.1450382,6951.274809,26367.03817,1731.458015,538.1450382,2831.557252,22550.0687,664.4732824,343.5648855,4518.603053,12980.60305,981.6717557,482.3816794,1306.557252,9059.648855,685.5725191,184.9007634,2889.305344,8061.877863,1416.984733,175.0610687,3332.389313,143.0076336,623.480916,131,22.37315026,7.715373677,0.938657924,0.891156463,0.567099567,-1.2335632
+2855,51420.87719,953.245614,565.8421053,1129.315789,48106.40351,797.8947368,739.6140351,1670.859649,27609.87719,605.4561404,531,1765.666667,34002.2807,1387.421053,6918.614035,4717.947368,12841.70175,1450.614035,376.0350877,2337.649123,26197.01754,480.4561404,364.3157895,436.3508772,31409.31579,451.0175439,142.0877193,4241.754386,24154.80702,1616.385965,706.9649123,2827.561404,21332.35088,643.9649123,336.1754386,1957.684211,14642.17544,891.4385965,475.5614035,1304.070175,10598.2807,702.3508772,186.1929825,2052.403509,9448.526316,1459.684211,165.0175439,3472.614035,233.8947368,624.4561404,57,11.96831594,7.052966185,0.807912005,0.814285714,0.527777778,-0.175501511
+2856,27436.41143,916.1142857,478.8628571,1072.337143,24473.37714,696.8114286,674.1257143,1474.434286,13903.17143,528.7142857,1199.502857,1704.851429,19022.50286,1335.788571,3342.874286,2748.502857,6680.382857,1259.062857,331.5028571,2761.48,14719.4,549.5771429,132.1428571,818.3028571,18260.85714,668.04,123.0571429,1541.765714,13122.65143,1664.051429,599.8114286,2794.262857,11752.21714,622.5085714,264.8457143,1679.971429,9379.257143,1199.457143,411.9942857,1289.948571,7255.314286,644.2228571,164.5371429,2611.474286,6179.411429,1420.771429,2925.085714,3196.234286,714.88,625.5828571,175,15.85699259,14.46606269,0.409560701,0.930851064,0.777777778,-0.519318198
+2857,34907.03704,841.0555556,527.5277778,1107.064815,30396.16667,735.7037037,906.9722222,1636.574074,18477.75,514.3796296,1729.361111,1892.055556,25093.13889,1230.712963,5413.833333,3679.212963,9183.611111,1259.972222,335.3055556,2531.722222,17708.73148,540.4537037,268.9166667,1661.111111,22231.4537,979.5925926,185.9537037,3125.675926,17416.82407,2056.305556,697.712963,2846.435185,15048.37963,639.0185185,279.1666667,1982.185185,11491.87963,1551.287037,425.4814815,1299.092593,7771.37037,666.7962963,166.0555556,5741.509259,7250.648148,1328.824074,339.0277778,3283.888889,891.9722222,626.4537037,108,16.39389462,8.973678917,0.836884627,0.870967742,0.675,-0.123754843
+2858,29735.92742,819.0725806,524.2822581,1073.798387,25847.17742,675.6935484,505.6290323,1557.83871,14479.64516,478.0322581,747.5564516,1754.854839,19867.23387,1344.766129,5008.927419,2226.612903,7175.532258,1221.943548,322.4596774,2372.943548,13781.30645,785.9274194,923.7177419,759.7822581,16747.70968,430.4032258,152.3951613,2690.91129,13491.95968,1571.072581,595.5645161,2867.258065,11288.33065,1633.895161,263.6290323,1592.483871,8564.814516,872.4596774,398.6129032,1307.169355,5719.193548,871.3629032,155.2419355,4714.58871,5240.008065,1226.370968,255.1451613,3242.266129,924.0322581,627.5967742,124,17.25388367,9.3295354,0.841202066,0.939393939,0.688888889,-0.159747457
+2859,47479.38462,910.4769231,516.3846154,1144.984615,45524.44615,755.1076923,507.0153846,1715.415385,25101.92308,593.2307692,523.6461538,1759.984615,32722.50769,1353.830769,5172.723077,4676.646154,11730.87692,1464.861538,377.6769231,2345.276923,24558.75385,475.5846154,136.9846154,426.7538462,29441.56923,437,143.0153846,3075.846154,22860.58462,1544.292308,565.7846154,2852.738462,20066.81538,656.6923077,338.2307692,3191.953846,13669.76923,890.9384615,467.0461538,1297.261538,9811.446154,680.3538462,176.9076923,3115.2,8671.984615,1449.646154,185.7076923,3349.446154,215.5230769,624.9692308,65,9.862238192,9.162060819,0.370069148,0.855263158,0.65,-0.149186759
+2860,43901.18692,925.1775701,572.7663551,1100.728972,41461.85981,755.1308411,741.2242991,1683.46729,23253.57009,578.635514,544.0280374,1782.233645,28939.97196,1321.093458,6488.766355,5710.542056,10702.16822,1408.504673,350.3271028,2363.841121,22222.65421,455.5327103,172.1682243,460.4766355,26597.52336,443.411215,135.2897196,4046.747664,20058.1215,1535.64486,677.7943925,2828.233645,17744.58879,616.317757,316.4392523,2594.841121,12167.61682,1100.065421,448.8598131,1314.850467,9002.11215,650.0560748,183.8598131,6094.35514,7950.925234,1411.878505,158.6168224,3395.691589,243.2523364,624.1214953,107,15.05888876,9.512075775,0.775246723,0.922413793,0.694805195,-1.232591536
+2861,38693.53982,872.8584071,526.3451327,1101.345133,35735.62832,702.9911504,615.4778761,1645.513274,20387.53097,565.0619469,520.2123894,1755.079646,25997.99115,1285.159292,6200.39823,3537.522124,9693.212389,1446.504425,359.4159292,2338.681416,19739.85841,439.9646018,474.9557522,439.1858407,23458.88496,421.8053097,131.4336283,3396.840708,18244.95575,1614.584071,570.2035398,2829.716814,15880.95575,745.8495575,308.6017699,1894.053097,11073.00885,872.0530973,440.8584071,1319.442478,8277.451327,840.0442478,175.5221239,2491.699115,7446.902655,1360.150442,273.0973451,3325.831858,257.2389381,626.6814159,113,13.51240869,11.04501971,0.576072948,0.949579832,0.620879121,1.218470512
+2862,25374.86364,1024.742424,616.0757576,1115.80303,24727.12121,762.4242424,658.9545455,1663.909091,13013.19697,601.8636364,535.9545455,1832.272727,16908.74242,1403.833333,4669.742424,2589.257576,5983.530303,1394.166667,358.6818182,2392.30303,11700.59091,476.7272727,1005.757576,450.4393939,12828.84848,417.0606061,124.8939394,2649.121212,9636.469697,1536.984848,795.5454545,2816.409091,8580.69697,716.6969697,283.7424242,1480.424242,6510.227273,859.8333333,422.9848485,1322.439394,5195.409091,2050.257576,170.3181818,2212.727273,4405.848485,1398.590909,185.6212121,3380.772727,390.9848485,625.3333333,66,12.02535957,7.288650626,0.795383371,0.904109589,0.75,0.070008812
+2863,30657.96078,1004.558824,562.1764706,1088.598039,27598.42157,742.5490196,795.4803922,1542.333333,16526.78431,592.8529412,523.4509804,1783.401961,21299.92157,1387.196078,2595.696078,1818.058824,7563.392157,1405.088235,347.0392157,2404.176471,15003.36275,461.1176471,611.9705882,517.6666667,18273.93137,435.754902,133.5196078,2016.04902,13858.79412,1628.107843,744.0686275,2824.27451,12283.83333,630.8333333,300.0490196,1535.656863,9358.470588,993.627451,443.8235294,1318.588235,7200.911765,715.7156863,170.4019608,1519.705882,6559.009804,1385.166667,345.5392157,3477.558824,466.7156863,626.3137255,102,13.11057242,10.38048973,0.610826083,0.935779817,0.653846154,-0.445198346
+2864,40339.46825,917.5952381,520.3650794,1096.992063,36505.23016,748.3809524,792.5396825,1605.785714,21471.61905,588.952381,1754.174603,1862.547619,28494.1746,1398.698413,3948.246032,4011.222222,10169.5,1434.563492,409.3571429,2496.825397,20766.34921,496.5952381,295.3968254,1527.753968,25414.83333,557.3809524,139.5396825,2643.515873,18871.63492,2065.222222,720.1666667,2808.285714,16835.39683,668.5793651,323.7460317,1551.126984,13379.34921,1709.468254,475.6349206,1328.484127,9949.857143,813.0952381,184.8888889,3795.619048,9096.349206,1467.420635,215.1825397,3356.166667,494.6904762,627.4126984,126,16.11270513,10.34617653,0.766610048,0.913043478,0.5625,-0.673947661
+2865,32761.37615,946.5045872,773.2477064,1149.495413,29560.12844,767.6972477,971.6605505,1649.541284,17376.25688,584.1834862,1017.633028,1809.981651,23014.0367,1386.385321,2042.275229,1605.018349,7763.862385,1445.394495,354.7889908,2437.302752,16659.21101,506.7247706,138.7155963,582.5045872,19720.31193,440.7247706,407.8165138,1399.633028,15081.72477,1753.770642,672.4220183,2833.036697,13435.45872,766.9908257,310.1559633,1550.110092,10387.86239,1070.357798,470.559633,1337.53211,7863.550459,649.7155963,174.8623853,2431.908257,7140.550459,1464.366972,486.4954128,3347.990826,546.7155963,627.3577982,109,16.4623902,8.828409106,0.844041744,0.893442623,0.558974359,-0.679357024
+2866,38039.97196,884.6448598,538.5327103,1099.28972,34318.71028,705.728972,823.0093458,1570.82243,19914.28037,539.5514019,1911.065421,1834.560748,27184.57944,1315.906542,4625.35514,3920.869159,9547.859813,1296.420561,339.3084112,2515.233645,19685.62617,441.682243,446.8037383,2668.280374,24310.23364,495.8130841,131.2803738,2615.82243,17936.49533,2057.420561,518.0747664,2810.242991,15741.24299,677.2429907,278.3551402,1696.88785,12692.80374,1680.906542,424.1775701,1324.747664,9105.242991,740.4018692,164.2616822,3345,8052.11215,1389.831776,347.4018692,3252.850467,808.2990654,624.4859813,107,16.29997249,8.804102704,0.841581653,0.922413793,0.572192513,-1.261816343
+2867,32595.56061,909.9848485,573.8560606,1081.090909,29552.63636,717.7272727,558.7121212,1620.431818,16359.65152,515.3333333,898.7954545,1755.825758,22404.26515,1281.818182,5786.530303,3366.083333,7993.204545,1262.136364,337.8333333,2406.901515,15408.18939,764.9090909,1955.742424,797.0151515,18634.59848,424.3863636,196.7651515,3668.022727,14692.0303,1809.810606,654.8863636,2809.886364,12270.76515,938.9393939,267.8712121,1538.143939,9257.689394,943.7045455,398.0454545,1318.666667,6260.94697,1094.189394,158.8409091,4075.840909,5608.340909,1221.189394,278.7348485,3312.530303,932.5151515,628.5757576,132,20.61657829,10.34323021,0.865044694,0.75,0.471428571,-0.413863384
+2868,27533.19767,1288.604651,689.9069767,1099.77907,23961.90698,847.6860465,635.255814,1588.837209,13851.60465,679.1976744,794.7209302,1794.104651,16571.36047,1360.55814,6600.395349,2988.953488,6002.988372,1342.27907,334.0930233,2329.581395,10695.88372,404.4186047,191.3953488,583.872093,12269.11628,404.7674419,126.4767442,6877.267442,9493.511628,1560.139535,602.5348837,2792.046512,8172.197674,562.872093,260.1162791,1482.732558,5905.604651,772.6395349,398.3372093,1313.639535,4408.023256,607.7906977,149.3255814,2409.744186,3847.581395,1150.395349,126.872093,3591.430233,337.1976744,626.8023256,86,13.92550337,8.262675765,0.804945727,0.895833333,0.661538462,-0.447925514
+2869,36981.66667,988.5294118,564.0980392,1135.098039,34432.81373,786.6568627,898.254902,1820.068627,19567.33333,719.2941176,1132.647059,1945.794118,25260.34314,1409.5,4764.362745,3945.196078,8974.764706,1436.147059,372.1078431,2533.892157,20420.56863,590.8333333,515.8921569,976.2156863,21604.12745,653.3823529,140.5686275,2863.22549,16045.30392,1877.666667,719.1568627,2815.529412,14205.78431,661.9803922,322.3137255,1779.147059,10959.85294,1604.715686,476.9313725,1334.941176,8470.166667,764.1078431,184.1078431,3533.137255,7480.431373,1453.676471,182.0196078,3437.764706,483.2254902,625.3039216,102,14.4763991,9.484005712,0.755511236,0.935779817,0.6375,-1.188416026
+2870,40070.74126,883.2237762,507.1748252,1092.86014,36232.7972,728.3986014,652.6853147,1565.944056,20695.8042,542.2027972,991.3356643,1763.776224,28959.88811,1286.314685,3804.601399,3526.216783,10161.75524,1307.643357,340.4055944,2458.538462,21273.83916,450.2377622,640.972028,971.8741259,25967.07692,606.6853147,169.2097902,2353.937063,19809.77622,1903.979021,662.1608392,2801.160839,17086.23077,651.2517483,282.6993007,1684.496503,13409.62238,1104.734266,431.4335664,1308.433566,9573.181818,802.7552448,164.7412587,4152.853147,8548.412587,1351.258741,381.3636364,3243.461538,845.3566434,629.5174825,143,14.59641863,13.02535243,0.451311805,0.940789474,0.635555556,0.843677614
+2871,35090.12977,871.3231552,571.0763359,1116.139949,31493.32316,709.9745547,827.4529262,1674.244275,16603.2799,504.2849873,1550.641221,1767.320611,23417.58524,1251.641221,7443.37659,4872.524173,8656.414758,1320.875318,339.3129771,2729.610687,16487.67939,453.7175573,923.2849873,853.7862595,20879.9313,704.9414758,227.2290076,4889.236641,15845.13486,1886.821883,615.5114504,2798.664122,13347.53435,697.4300254,286.6666667,2179.071247,9733.366412,1288.043257,420.0687023,1313.351145,6100.547074,833.8193384,166.9770992,6877.984733,5796.26972,1296.045802,480.5547074,3263.399491,1002.234097,632.1068702,393,24.67887612,21.76745889,0.471197059,0.897260274,0.581360947,-1.490720731
+2872,55658.61493,944.519403,549.2835821,1151.868657,52852.2,810.6328358,768.2597015,1796.101493,28817.11343,607.6716418,662.5432836,1779.385075,36758.47463,1425.39403,5855.423881,5585.862687,13932.15821,1513.844776,394.9104478,2439.949254,27708.24776,636.6328358,150.5552239,566.6477612,34186.0209,475.8686567,226.0597015,4701.665672,25919.4597,1773.504478,691.358209,2825.340299,22581.37015,662.2447761,344.2716418,2690.256716,14777.28955,943.4597015,488.3522388,1313.537313,10205.52239,678.3373134,192.5402985,3675.459701,8882.868657,1484.874627,160.9492537,3340.071642,180.3373134,631.6716418,335,22.68779436,19.25846684,0.528638555,0.925414365,0.634469697,1.460635804
+2873,20298.40157,922.3779528,621.8188976,1079.173228,15568.20472,639.7086614,618.2598425,1535.228346,8591.299213,515.1417323,679.3228346,1736.220472,11400.22835,1199.834646,4161.23622,2132.653543,4282.086614,1478.488189,317.2913386,2391.480315,10301.73228,439.0944882,277.6141732,677.9606299,10714.77953,439.9685039,119.2598425,2771.968504,8122.88189,1660.362205,578.5511811,2817.102362,7182.070866,715.6535433,273.519685,1424.92126,5528.889764,923.3464567,419.1574803,1327.212598,4276.456693,630.2283465,163.7716535,3806.795276,3809.173228,1297.173228,207.8346457,3225.055118,352.3464567,630.9212598,127,17.63205836,10.83757384,0.788798671,0.869863014,0.533613445,0.392347334
+2874,40109.71429,931.6984127,504.952381,1083.333333,34170.7619,756.4285714,863.031746,1566,21779.93651,576.047619,1042.52381,1715.619048,28099.20635,1407.15873,1988.84127,2002.111111,9971.793651,1449.555556,369.1269841,2411.174603,18831.22222,462.3333333,583.5873016,916.4126984,22912.98413,445.4444444,510.3492063,1535.190476,17745.4127,1758.507937,700.031746,2851.206349,15759.33333,657.952381,322.5555556,1563.190476,12139.65079,1160.142857,479.2380952,1317.380952,8981.365079,769.047619,188.1428571,1605.952381,8589.603175,1509.857143,1191.571429,3290.761905,457.6984127,626.6666667,63,10.17782547,8.363056699,0.569929118,0.913043478,0.636363636,-0.171939107
+2875,27822.88525,959.7377049,593.8114754,1079.5,25202.46721,750.0245902,1190.770492,1567.647541,14982,585.0491803,2232.516393,1812.622951,19679.7377,1335.270492,3732.606557,3328.770492,6577.92623,1350.040984,335.9672131,2791.254098,14209.59836,465.3278689,132.9262295,1845.959016,16955.40984,451.5409836,131.0491803,2136.040984,12701.14754,2072.327869,696.4098361,2818.377049,11338.92623,781.4836066,300.3934426,1713.434426,8815.590164,1277.204918,436.647541,1332.803279,6653.278689,636.7295082,172.5983607,2900.57377,6067.032787,1371.336066,406.4836066,3304.114754,533.7213115,628.6065574,122,14.00769864,11.54035107,0.566796621,0.924242424,0.67032967,0.486411595
+2876,36212.44,958.2,721.6133333,1152.44,31684.88,778.5866667,866.92,1678.453333,18733.52,569.1866667,1677.733333,1813.546667,24483.85333,1370.333333,2446.973333,3880.426667,9045.266667,1380.186667,339.1333333,2688.68,18189.94667,511.0933333,129.0533333,1040.826667,21897.21333,1446.413333,144.28,1096.6,17061.37333,1803.693333,641.3733333,2795.28,14868.61333,821.6533333,286.7333333,1582.28,11959.04,2005.2,421.6,1329.186667,9262.133333,655.52,160.4,4037.546667,8322.853333,1447.666667,256.7066667,3295.146667,639.8133333,625.5733333,75,13.18826144,7.595582349,0.817495437,0.925925926,0.595238095,-1.20997478
+2877,39670.47945,887.4794521,532.8493151,1119.863014,35172.87671,712.8356164,424.0410959,1568.054795,20482.79452,551.4794521,549.739726,1769.164384,27176.21918,1314.630137,3886.945205,3121.876712,9872.876712,1344.739726,345.9452055,2359.232877,20805.17808,434.6986301,150.369863,521.5616438,25769.68493,423.3287671,127.3424658,3391.589041,18568.39726,1484.041096,962.9863014,2792.150685,17145.46575,634.5479452,277.6027397,1959.205479,13254.67123,968.1506849,421.6849315,1305.534247,9688.767123,651.2465753,163.2191781,2578.09589,8464.273973,1387.821918,355.6986301,3239.958904,754.3150685,625.3287671,73,12.29705796,8.657027313,0.710208153,0.890243902,0.561538462,1.49161951
+2878,38911.58036,878.6919643,523.6964286,1091.96875,36945.02679,739.2142857,843.0089286,1622.075893,20131.37054,528.6428571,1593.776786,1796.084821,28392.30357,1265.200893,5798.258929,3571.808036,10083.26786,1335.508929,328.7098214,2500.464286,19907.33036,435.7857143,475.6785714,1286.90625,24127.65625,462.3035714,450.0267857,2583.254464,18905.92411,2004.446429,516.6875,2797.933036,15867.90625,777.4642857,277.5535714,1492.665179,11960.48214,1229.245536,420.3616071,1299.991071,7762.741071,694.375,163.7321429,3955.973214,7110.861607,1277.370536,614.2946429,3342.482143,965.0491071,634.2946429,224,22.50492693,13.37484069,0.8042381,0.875,0.608695652,-0.313456749
+2879,38554.10929,999.0874317,601.2349727,1125.836066,36102.68306,761.8142077,552.3661202,1712.661202,20093.49727,609.9453552,654.5464481,1787.284153,25761.74317,1351.191257,5599.15847,4505.344262,9374.994536,1444.945355,358.4972678,2410.693989,20885.74863,493.0163934,392.9508197,529.0874317,22227.98907,479.4918033,144.8579235,7249.065574,17052.77596,1633.978142,737.8360656,2823.295082,14841.79781,648.9016393,307.7322404,1855.759563,11097.44262,937.0819672,459.7486339,1315.989071,8837.568306,708.6120219,188.8032787,4013.770492,7444.73224,1417.601093,149.6393443,3394.147541,323.7486339,629.4590164,183,18.84420845,12.58805256,0.744155494,0.905940594,0.687969925,-1.326986731
+2880,30317.42268,909.8969072,754.0927835,1116.556701,25627.84536,669.0103093,584.0412371,1555.082474,14399.25773,538.7938144,872.0824742,1790.484536,18912.89691,1267.360825,6189.371134,1995.701031,6865.628866,1416.938144,337.0721649,2381.463918,15398.09278,479.7835052,277.7113402,570.6082474,18388.97938,519.1134021,145.8659794,3898.134021,14439.90722,1842.237113,627.3402062,2832.628866,12711.02062,641.4639175,291.6907216,1485.57732,9122.412371,1039.85567,440.3917526,1318.989691,6822.814433,668.8659794,169.742268,2466.247423,6070.886598,1334.958763,215.7731959,3318.185567,343.9793814,632.0618557,97,16.73322343,8.343975992,0.866805002,0.836206897,0.538888889,-0.038359288
+2881,32849.68182,861.8409091,536.2840909,1105.272727,30503.43182,710.7613636,818.8977273,1563.659091,17058.96591,518.7840909,1359.590909,1839.204545,23739.01136,1276.795455,5415.920455,4582.965909,8290.215909,1278.397727,364.7272727,2506.852273,17137.09091,426.2386364,1478.079545,1447.488636,21172.25,680.8181818,151.8863636,2308.102273,15677.57955,2170.636364,551.5568182,2791.988636,13714.70455,653.3181818,272.9659091,1785.261364,10880.39773,1506.045455,415.8181818,1334.465909,8011.75,1010.181818,161.3181818,4177.034091,7007.784091,1344.306818,376.9204545,3270.511364,814.5340909,629.9886364,88,14.93998876,8.347764107,0.829334096,0.862745098,0.483516484,-0.814376969
+2882,17791.54135,803.2556391,445.5488722,1086.323308,15688.40602,645.5488722,410.8496241,1498.075188,8944.172932,495.7218045,399.3984962,1744.969925,12434.64662,1235.150376,1520.699248,909.7969925,4584.804511,1194.526316,324.4511278,2306.526316,8882.992481,400.4586466,191.0526316,459.8496241,11072.4812,431.2556391,122.4962406,978.6165414,8788.451128,1328.037594,444.5037594,2827.285714,7816.804511,653.8270677,258.1729323,1384.330827,6032.533835,771.3684211,402.6917293,1316.345865,4262.007519,651.2781955,160.481203,2314.428571,3989.082707,1300.639098,2845.353383,3158.090226,870.924812,629.9774436,133,16.31964576,10.60177521,0.760248236,0.936619718,0.633333333,0.890229092
+2883,39231.18868,837.8490566,535.0849057,1103.877358,33838.67925,658.3301887,781.4716981,1643.839623,18185.15094,479.6792453,827.5471698,1771.707547,25208.73585,1187.226415,4666.773585,3023.292453,9559.764151,1260.358491,327.5377358,2414.641509,17692.41509,749.0188679,326.2169811,755.1320755,22615.5283,438.3396226,121.9150943,5525.509434,17322.42453,1781.471698,504.0283019,2809.169811,14082.93396,811.0660377,275.8773585,2127.839623,10159.4717,881.9339623,396.8679245,1294.518868,5618.311321,661.9528302,152.5754717,2911.716981,5831.301887,1214.471698,880.9339623,3333.160377,1037.45283,628.8867925,106,12.89985574,11.11493347,0.507532889,0.929824561,0.741258741,-0.40359961
+2884,36154.74308,877.4624506,570.2055336,1116.355731,18528.36364,549.6205534,771.6798419,1459.422925,7806.731225,415.6442688,1718.134387,1721.01581,12648.75099,1038.750988,7145.537549,2985.940711,4851.051383,1078.086957,277.1976285,2561.948617,8946.110672,392.972332,938.4189723,1346.454545,10888.97628,413.1541502,212.2885375,1938.268775,8382.490119,2596.640316,357.0632411,2801.213439,6589.375494,533.312253,216.4782609,889.2766798,3896.628458,1023.114625,345.3833992,1293.592885,1908.84585,746.6916996,137.7628458,2190.27668,2211.16996,980.7391304,528.055336,3053.758893,1133.067194,630.6640316,253,26.70782425,12.46559116,0.88439495,0.893992933,0.608173077,-1.245825831
+2885,41295.47222,881.4722222,568.3055556,1107.895833,40891.90278,738.6805556,565.6805556,1687.715278,22017.22917,577.6805556,503.2777778,1772.916667,28016.45139,1303.638889,6897.284722,4528,10464.68056,1396.263889,354.1041667,2354.493056,21876.96528,457.9444444,211.875,444.0277778,25717.0625,430.3611111,133.9097222,4869.625,19461.47917,1533.305556,578.0625,2815.256944,17245.40972,623.2291667,311.7083333,2433.298611,11663.71528,860.375,453.8125,1311.9375,8631.673611,690.6805556,176.3888889,5014.770833,7318.527778,1389.451389,218.8125,3344.159722,226.2291667,631.9236111,144,14.83783029,12.93636714,0.48977241,0.87804878,0.6,1.56549261
+2886,29553.75758,950.9242424,661.0454545,1115.151515,25008.72727,773.0454545,611.969697,1602.333333,15438.65152,572.1818182,651.4090909,1785.484848,19986.5,1417.575758,7227.454545,3612.681818,6592.560606,1326.439394,340.8636364,2390.378788,13747.33333,481.8333333,270.2121212,587.2727273,16459.27273,477.3333333,126.6515152,3215.909091,12933.43939,1903.090909,692.1515152,2814.636364,11320.13636,704.7272727,292.6212121,1633.606061,8675.954545,1024.409091,438.3030303,1331.5,6774.924242,734.4545455,168.7121212,2197.560606,6089.030303,1384.651515,305.5454545,3308.166667,586.0757576,629.2424242,66,10.78829467,8.394006582,0.628182387,0.956521739,0.5,-0.999013065
+2887,29696.77828,1075.180995,623.6651584,1094.244344,27249.64253,669.2760181,480.9954751,1518.289593,15276.75113,554.0859729,522.0904977,1758.606335,19065.03167,1220.022624,7555.728507,3878.841629,7039.782805,1326.819005,331.1085973,2336.348416,14449.01357,405.4343891,306.1085973,421.3755656,17631.33032,392.6063348,122.3665158,5166.457014,13494.70588,1517.0181,647.9502262,2812.090498,11503.84615,632.0045249,276.3031674,1676.262443,8022.20362,816.2262443,416.1764706,1293.063348,6258.524887,715.4117647,166.1085973,4120.39819,5571.79638,1245.723982,178.7058824,3359.678733,271.2171946,634.4343891,221,22.22167779,13.2998006,0.801118555,0.873517787,0.612188366,-0.764749608
+2888,28126.1773,1022.06383,659.9148936,1131.255319,25305.61702,824.4397163,614.1985816,1629.184397,14874.7234,628.5673759,776.6312057,1810.106383,19320.07801,1438.531915,5480.347518,3476.70922,6582.163121,1428.056738,389.1276596,2428.921986,13877.92199,487.3333333,195.9148936,695.2907801,16388.60284,465.6028369,150.2695035,4747.609929,12132.04965,1895.602837,738.6099291,2815.602837,11037.19149,648.8794326,311.6808511,1852.758865,8561.219858,1283.957447,457.2978723,1336.326241,6421.780142,681.7588652,178.1347518,4009.319149,5639.22695,1454.29078,286.141844,3321.255319,521.1985816,630.7588652,141,16.71596412,11.63912173,0.717762713,0.88125,0.592436975,1.003784357
+2889,30587.5969,1027.232558,736.0775194,1150.930233,27345.96124,777.8449612,652.0852713,1646.232558,16351.68217,604.0852713,601.6744186,1795.689922,21138.41085,1419.062016,4181.51938,3273.27907,7142.906977,1414.527132,360.9612403,2389.550388,15065.29457,534.6744186,172.1782946,485.7364341,18114.4031,461.0077519,153.6511628,3961.209302,13852.00775,1632.015504,863.1085271,2828.271318,12265.25581,867.496124,311.9767442,1793.914729,9267.100775,906.1705426,466.8294574,1345.217054,7198.317829,656.0465116,180.4573643,2442.372093,6484.775194,1429.403101,281.1627907,3380.813953,556.4031008,630.5581395,129,15.44046802,10.8588565,0.710920386,0.934782609,0.708791209,-0.90449872
+2890,24383.41085,903.8527132,544.6434109,1078.883721,22285.81395,704.372093,723.1937984,1496.899225,12428.03101,524.3333333,1355.651163,1797.379845,17213.03876,1250.666667,2096.317829,3400.612403,6341.27907,1304.023256,321.7906977,2498.844961,12922.86047,2322.395349,461.2868217,1307.015504,15479.32558,1271.410853,193.8837209,1205.023256,11568.27132,1573.379845,631.9302326,2808.813953,10161.72868,961.7674419,257.255814,1583.178295,8170.821705,1694.643411,398.255814,1306.418605,6474.457364,969.9534884,156.0465116,5265.744186,5713.348837,1319.968992,334.3100775,3234.046512,642.379845,634.3023256,129,19.04528896,9.21840058,0.875054036,0.889655172,0.597222222,-0.580346778
+2891,36667.02326,873.7906977,531.3100775,1103.930233,33185.13178,715.4341085,498.6124031,1591.418605,18772.10078,640.5968992,612.5658915,1766.984496,25563.79845,1277.992248,4800.023256,3202.325581,8931.728682,1308.410853,341.627907,2366.751938,19648.39535,429.1162791,813.8527132,557.4883721,23827.42636,518.0077519,127.1317829,3245.193798,17223.72093,1565.217054,698.9767442,2804.224806,15620.07752,635.9922481,285.4651163,1897.829457,12103.31008,993.9302326,410.7596899,1326.658915,9025.976744,849.2635659,165.5581395,4041.96124,7782.48062,1356.48062,256.627907,3262.093023,746.0077519,632.627907,129,16.65585079,10.91449089,0.755373315,0.895833333,0.542016807,-0.556896578
+2892,42439.26316,899.6165414,639.3458647,1118.18797,37450.94737,726.8345865,698.4285714,1733.609023,21401.34586,533.2481203,599.5488722,1749.180451,29390.88722,1345.819549,5794.120301,5373.172932,10588.94737,1358.917293,353.1052632,2449.819549,20422.28571,466.8195489,897.2857143,629.3609023,24782.96241,445.4661654,134.9774436,4532.345865,19233.54135,1606.518797,816.1654135,2804.473684,16238.54135,733.556391,282.2857143,2086.842105,12326.87218,1060.142857,427.0676692,1313.729323,7986.887218,833.2481203,169.3533835,5090.075188,7384.616541,1319.879699,313.7744361,3354.330827,945.9323308,630.8646617,133,15.37181615,11.56490182,0.658769843,0.898648649,0.639423077,-1.228948762
+2893,35589.10811,874.2342342,642.5675676,1111.954955,33932.85586,729.4594595,717.5495495,1731.801802,17226.27027,514.8738739,1016.666667,1776.342342,24392.94595,1257.90991,7560.531532,4296.765766,9024.126126,1310.756757,338.3693694,2396.27027,17291.8018,484.6846847,1025.837838,726.5855856,22008.01802,462.027027,163.5225225,5975.144144,16471.0991,2093.414414,519.6936937,2784,13361.27027,874.7837838,282.8018018,2325.927928,9806.234234,1002.765766,414.1351351,1303.792793,5763.666667,854.2882883,163.3153153,4790.594595,5667.126126,1296.918919,821.5135135,3286.486486,1026.459459,630.5855856,111,12.23026202,11.80501068,0.261403626,0.932773109,0.770833333,1.526524631
+2894,19074.66667,851.8425926,479.2592593,1057.444444,18020.59259,721.1203704,596.8425926,1439.787037,10133.07407,528.75,471.8796296,1717.675926,13063.83333,1290.25,2205.685185,2999.296296,4911.666667,1321.842593,350.7222222,2386.962963,10317.25,451.3333333,2113.037037,483.3796296,10812.26852,437.962963,126.9444444,2259.925926,8236.62037,1585.314815,731.5925926,2802.842593,7352.166667,704.6111111,274.6111111,1849.101852,5623.481481,820.962963,428.2314815,1385.175926,4517.842593,1163.101852,169.2222222,3391.935185,4020.805556,1378.388889,734.25,3123.574074,419.3333333,631.2314815,108,15.58248957,9.303273736,0.802216045,0.9,0.6,-1.169422141
+2895,22953.84375,930.6197917,648.4427083,1109.026042,21829.84896,721.9114583,687.9427083,1584.458333,12089.96875,557.4791667,590.75,1771.84375,16071.41667,1351.177083,3742.760417,2832,5492.838542,1424.640625,338.2395833,2376.666667,12904.58854,464.671875,1220.234375,567,14117.32813,438.015625,136.6875,2474.541667,10576.90625,1612.979167,951.546875,2824.770833,9459.755208,764.1354167,297.3177083,1931.890625,7365.520833,965.78125,449.828125,1336.5,5774.401042,888.8645833,175.9947917,2848.578125,4999.390625,1468.354167,2386.635417,3318.192708,451.3489583,635.9114583,192,20.37545997,12.27871518,0.798026223,0.932038835,0.685714286,0.275282776
+2896,46478.01667,988.2083333,591.1083333,1136.741667,41481.425,730.0166667,666.7166667,1887.941667,24025.08333,558.4,614.625,1931.733333,32715.34167,1351.125,5943.575,4426.041667,11640.66667,1364.058333,346.6583333,2350.608333,25077.24167,459.1083333,123.8083333,717.0916667,30456.83333,450.175,134.4916667,4428.433333,22026.3,1628.225,768.3333333,2798.558333,20086.73333,634.675,300.0916667,2076.433333,15735.025,1073.716667,430.05,1294.8,11282.63333,652.7083333,171.95,2918.05,9928.7,1432.416667,146.2416667,3274.316667,760.2333333,633.3166667,120,14.94757003,11.67167203,0.624730101,0.863309353,0.5,-1.208262421
+2897,40915.42424,994.2424242,803.020202,1170.525253,34800.86869,763.1111111,805.8484848,1706.555556,21265.40404,572.8484848,729.5757576,1758.717172,28201.10101,1427.939394,1841.393939,1886.494949,9776.747475,1412.151515,353.3030303,2414.444444,20682.07071,497.6666667,160.1414141,584.1717172,25321.87879,699.040404,136.5959596,1648.262626,18658.90909,1543.181818,518.5555556,2808.272727,16726.59596,819.0707071,301.979798,1985.737374,13259.09091,1063.474747,459.8080808,1324.131313,9451.747475,662.5555556,176.0808081,2221.555556,8035.131313,1489.030303,459.010101,3352.212121,799.4343434,631.4141414,99,16.20048963,8.644706669,0.845732097,0.853448276,0.507692308,0.982585684
+2898,30457.11024,888.6850394,531.5826772,1061.874016,27969.55118,711.1102362,682.1811024,1535.795276,15602.51969,530.6535433,1751.165354,1879.80315,22222.14173,1218.307087,4202.440945,2926.377953,7866.212598,1246.188976,314.8425197,2499.212598,15340.97638,1804.125984,379.9212598,1475.007874,19333.71654,531.8582677,307.5275591,1606.488189,14582.08661,2490.322835,699.8346457,2818.519685,12520.3622,943.7322835,253.4724409,1369.188976,9766.913386,1485.259843,402.1259843,1311.346457,6612.141732,682.4251969,155.5354331,3915.031496,6078.165354,1218.031496,335.519685,3330.80315,900.1653543,632.992126,127,14.50085103,11.8226496,0.579028512,0.907142857,0.564444444,-0.904955948
+2899,61224.83333,1019.757576,591.030303,1203.181818,61339.54545,840.9242424,722.3030303,1924.106061,30691.86364,632.6515152,551.8636364,1733.378788,41760.54545,1524.409091,5803.484848,5984.636364,15798.30303,1586.954545,408.4242424,2351.969697,31905.5,530.6666667,163.969697,458.3787879,38743.60606,557.5151515,158.8030303,4760.757576,28359.16667,1690.878788,566.9393939,2831.575758,24562.10606,710.5151515,377.5151515,5578.181818,14592.10606,992.7121212,497.8636364,1324.318182,10264.07576,690.6666667,194.1515152,2715.772727,8848,1517.106061,158.3484848,3405.848485,146.9545455,630.469697,66,10.9964519,7.885544407,0.696971346,0.916666667,0.75,-1.481210748
+2900,22123.6135,785.5644172,563.809816,1061.435583,21336.70552,629.1595092,575.1349693,1523.595092,11468.51534,497.809816,1038.91411,1819.404908,15114.83436,1168.533742,6940.803681,4984.944785,5409.159509,1270.447853,312.6380368,2451.693252,11647.73006,581.993865,1089.564417,751.0122699,13896.23313,711.8834356,123.2944785,6363.447853,10721.99387,1742.570552,709.7300613,2807.791411,9250.478528,608.6319018,265.9509202,2065.668712,6529.779141,1311.196319,416.9386503,1312.871166,5114.355828,847.0245399,168.6196319,5877.674847,4473.466258,1276.797546,1032.552147,3272.907975,293.5030675,633.3619632,163,15.81371237,13.80946192,0.487256854,0.895604396,0.646825397,-1.41332419
+2901,33957.53211,941.8715596,628.1834862,1108.33945,27454.97248,685.3853211,716.733945,1610.715596,16191.33028,538.8990826,1359.229358,1792.321101,19906.9633,1239.678899,4855.917431,2591.541284,7214.12844,1338.458716,325.7889908,2600.954128,15392.26606,405.0458716,290.440367,770.2110092,16940.88073,1006.752294,123.3761468,3859.330275,13356.74312,1637.954128,604.5321101,2853.513761,11698.21101,753.853211,284.7981651,1385.486239,8747.844037,1246.752294,434.4678899,1393.926606,6639.018349,674.9908257,170.6238532,4823.944954,6104.651376,1324.504587,191.1009174,3219.972477,372.0733945,632.6697248,109,12.6804063,11.19713358,0.469323309,0.973214286,0.644970414,-0.688012834
+2902,36008.4902,912.0686275,535.5588235,1123.166667,33899.37255,753.754902,1064.245098,1619.117647,19522.5098,579.4313725,838.0882353,1818.696078,25754.57843,1382.303922,3884.617647,2897.686275,9072.588235,1467.911765,359.872549,2680.656863,18906.59804,1794.911765,1756.568627,693.2647059,22563.18627,502.9019608,147.1764706,1786.627451,17004.35294,1934.431373,981.1470588,2851,15023.23529,653.1568627,317.8921569,1643.843137,11558.95098,1305.666667,474.0882353,1322.441176,8814.980392,1042.313725,184.9509804,3196.794118,7997.588235,1476.823529,185.9607843,3326.431373,473.5294118,634.1960784,102,14.04143994,10.10208457,0.694546406,0.86440678,0.618181818,0.036996991
+2903,33075.25243,1011.941748,585.7087379,1109.543689,28742.51456,764.6116505,586.3592233,1601.864078,16932.18447,565.631068,767.9126214,1746.320388,22676.2233,1370.019417,4406.543689,3849.514563,7505.708738,1325.786408,318.5728155,2424.067961,15906.59223,453.7864078,196.9417476,618.9223301,19162.56311,979.3009709,135.4271845,3414.262136,14865.32039,1568.757282,766.815534,2805.757282,13093.1165,731.5145631,291.8349515,1815.61165,9866.941748,1012.359223,422.592233,1323.514563,7668.970874,638.4271845,163.2621359,2912.708738,6815.776699,1345.184466,1037.116505,3331.708738,594.4271845,633.8446602,103,12.23747779,11.56267904,0.327480262,0.872881356,0.565934066,-0.254215079
+2904,35659.36449,832.271028,512.2616822,1088.953271,29960.48598,692.1121495,623.411215,1539.859813,18261.66355,780.3457944,1193.420561,1781.607477,24871.7757,1268.411215,3735.981308,3914.878505,9121.925234,1288.831776,357.728972,2557.738318,19016.3271,405.5327103,1127.383178,1516.878505,23957.28037,521.4953271,344.1775701,1733.476636,17314.85981,2025.850467,650.2149533,2785.35514,15879.53271,629.1588785,285.0373832,1689.878505,12570.07477,1119.859813,411.9439252,1389.46729,8816.719626,924.1401869,160.7850467,3736.504673,8226.224299,1363.859813,246.3271028,3240.672897,735.6074766,631.7570093,107,12.06002912,11.99711796,0.102008779,0.938596491,0.633136095,-1.227801634
+2905,32587.632,791.744,507.456,1071.656,27884.264,667.488,901.152,1583.632,16420.536,484.728,2180.832,1742.272,23023.68,1270.904,5422.448,3392.536,8438.488,1265.688,321.92,2462.096,16105.04,768.216,741.992,772.216,19517.92,469.52,451.784,3719.248,15954.8,2401.272,553.112,2810.328,13464.536,1206.528,271.736,1585.168,10042.272,1159.496,407.424,1311.848,6150.248,767.752,169,6316.584,5937.352,1244.352,491.776,3230.888,978.608,633.008,125,14.40363759,11.55973945,0.596575513,0.925925926,0.686813187,-1.129961744
+2906,36537.13253,938.373494,613.2891566,1104.313253,30738.14458,648.0843373,589.1927711,1595.759036,16649.59036,460.6385542,895.626506,1753.795181,22893.38554,1159.349398,7106.289157,3586.084337,8647.819277,1222.361446,315.0481928,2407.228916,16501.66265,414.5301205,218.4819277,1022.819277,20732.46988,401.5903614,128.5301205,6081.385542,16040.86747,1782.301205,483.0120482,2823.289157,12971,658.4457831,265.746988,1739.783133,9344.481928,852.1686747,387.2409639,1292.156627,5125.493976,619.9036145,152.9277108,4434.614458,5310.915663,1147.542169,448.9518072,3187.012048,1051.987952,631.5662651,83,11.52218136,9.30011067,0.590348542,0.976470588,0.685950413,0.828369441
+2907,35125.7,840.1842105,555.1894737,1087.463158,31263.12632,703.5421053,927.0157895,1690.368421,16129.34211,489.8578947,1656.094737,1741.231579,22122.31579,1241.026316,6783.931579,3793.326316,8493.578947,1238.326316,322.4631579,2478.278947,15903.68421,663.4105263,1072.978947,2252.8,19809.24737,443.2526316,601.1578947,4766.457895,15406.21579,2099.836842,494.1789474,2807.905263,12414.74211,654.2263158,263.3631579,1596.3,8463.794737,1001.4,401.2684211,1291.531579,4366.810526,843.6578947,157.8473684,5158.405263,4709.1,1167.573684,505.2368421,3281.752632,1069.268421,632.9368421,190,20.71510387,12.29396337,0.804850035,0.892018779,0.730769231,1.48118489
+2908,32315.22024,843.797619,576.8333333,1095.339286,25695.30952,626.7261905,701.1785714,1593.702381,12284.01786,451.7380952,1004.404762,1752.940476,17708.44048,1122.446429,9068.577381,3586.654762,6730.613095,1184.160714,290.4107143,2470.517857,12880.43452,391.1130952,603.9047619,1249.267857,15823.89286,411.4880952,127.7738095,5191.994048,12338.45833,2035.083333,404.2380952,2795.059524,9702.392857,627.8869048,250.0952381,1505.029762,6501.595238,890.8988095,374.3452381,1277.517857,3330.684524,712.1964286,153.6190476,3632.970238,3675.440476,1090.636905,580.4404762,3175.458333,1084.488095,636.0416667,168,20.35704898,10.70551869,0.850554102,0.918032787,0.6,-0.491285418
+2909,31999.40171,869.4444444,558.0512821,1074.854701,27225.65812,613.5811966,962.5213675,1591.145299,12773.47009,440.2991453,1436.880342,1722.401709,19061.87179,1118.410256,8185.786325,2381.290598,7162.700855,1157.111111,303.9401709,2431.350427,13796.51282,513.6410256,1481.08547,1500.068376,16663.58974,425.0940171,118.5726496,3559.367521,13285.25641,2146.529915,419.4529915,2814.726496,10476.30769,540.2478632,241.9316239,980.3504274,6840.982906,818.2649573,377.2222222,1300.059829,3362.128205,933.7094017,147.1965812,2805.777778,3747.564103,1059.91453,240.4102564,3130.692308,1097.299145,632.8888889,117,15.07977174,10.26970659,0.732259854,0.906976744,0.642857143,-0.900226658
+2910,47821.28169,899.4507042,541.4929577,1145.753521,46183.38732,759.1408451,765.6690141,1743.267606,25287.6831,591.8591549,547.9647887,1784.711268,33265.54225,1359.035211,6286.246479,4797.352113,12085.11972,1460.239437,374.0352113,2416.112676,24583.69718,474.6197183,145.8873239,439.2042254,30053.21831,447.4225352,136.7464789,3573.838028,22767.33099,1581.866197,593.4366197,2821.478873,20322.05634,642.084507,332.1690141,3033.394366,13455.73239,897.7887324,480.6126761,1311.15493,9522.253521,651.3450704,176.6197183,3900.34507,8433.549296,1437.669014,189.9577465,3339.647887,211.3098592,638.6760563,142,22.85473087,8.828306722,0.922381913,0.788888889,0.52014652,-0.287285922
+2911,32087.39506,929.1358025,538.7654321,1073.432099,29618.49383,721.7530864,560.308642,1565.148148,17027.8642,567.5061728,539.6419753,1776.555556,21451.39506,1286.518519,4737.82716,3484.037037,7828.246914,1364.432099,337.3580247,2347.308642,16366.74074,436.1728395,159.7530864,447,19505.65432,430.9382716,128.382716,2921.246914,14824.69136,1491.333333,517.1111111,2802.765432,13075.20988,683.8765432,299.7901235,2715.567901,8889,904.2469136,434.7407407,1323.851852,6590.024691,644.9753086,170.0617284,3589.432099,5944.765432,1310.790123,424.1604938,3289.580247,245.4074074,632.4567901,81,11.92247727,9.407566254,0.614314377,0.9,0.613636364,-1.397700303
+2912,25006.55725,881.6717557,849.8473282,1148.778626,22132.98473,679.8015267,692.3206107,1649.083969,12636.92366,492.3282443,760.7099237,1844.78626,16674.96183,1213.793893,2741.21374,2405.083969,5925.725191,1288.10687,319.1984733,2460.832061,12544.08397,462.9923664,182.6870229,779.9236641,14884.87023,928.4580153,117.389313,1693.198473,11443.28244,1602.007634,932.9541985,2806.78626,10106.45038,635.7557252,268.1145038,1505.580153,7846.755725,1420.351145,391.5496183,1300.015267,6204.007634,630.7480916,157.2977099,4847.801527,5466.687023,1288.282443,513.5648855,3264.290076,621.8015267,634.3053435,131,15.27830003,11.04852243,0.690689661,0.942446043,0.668367347,-0.698896771
+2913,24724.21359,1169.407767,543.2718447,1084.980583,21743,774.7378641,903.9514563,1479.990291,12690.21359,619.8349515,1602.291262,1759.796117,16686.09709,1413.087379,2782.834951,3261.990291,5330.747573,1262.262136,321.038835,2757.864078,12488.47573,1659.883495,194.1359223,1061.834951,15035.97087,973.7378641,119.2718447,1337.815534,11206.53398,1846.504854,590.4174757,2780.281553,10020.65049,611.7669903,276.2330097,1554.436893,7654.019417,1721.747573,397.0873786,1307.145631,6057.135922,641.1747573,156.2330097,2716.378641,5210.495146,1355.320388,667.8834951,3435.048544,672.2621359,633.9708738,103,13.62475089,9.812353037,0.693781173,0.944954128,0.613095238,-0.638119346
+2914,55363.25455,960.5636364,616.8181818,1164.427273,55272.03636,854.7454545,829.3727273,1862.927273,27873.92727,598.6090909,820.3090909,1807.809091,37328.28182,1430.481818,6430.063636,7074.454545,13936.00909,1520.572727,385.8545455,2369.754545,28542.42727,489.6454545,143.9181818,736.1454545,34349.71818,490.2727273,209.6727273,6624.545455,25704.81818,1765.090909,599.0909091,2826.509091,22331.65455,664.5818182,352.1090909,6198.663636,14041.99091,998.3090909,484.1,1323.636364,9608.327273,666.4363636,176.5818182,3839.427273,8508.436364,1450.545455,216.7727273,3362.2,162.5818182,636.9818182,110,17.47915081,8.765820987,0.865156754,0.839694656,0.491071429,-0.813654196
+2915,37378.27108,1085.722892,536.3253012,1097.771084,32175.3012,725.2590361,642.3493976,1512.680723,18945.33133,621.3915663,1403.427711,1735.216867,25414.1506,1383.36747,2713.463855,2678.861446,8963.26506,1351.198795,359.7349398,2751.493976,19187.4759,4508.240964,244.4578313,825.8313253,23500.30723,486.5301205,122.246988,1532.746988,17311.13253,1563.873494,603.9879518,2800.86747,15613.25301,631.0903614,285.0481928,1575.915663,12679.80723,1470.421687,426.2590361,1318.879518,9450.650602,704.5783133,170.3192771,2848.26506,8343.5,1461.945783,1100.331325,3292.379518,680.4578313,637.4337349,166,24.06588294,9.744302823,0.91436048,0.81372549,0.459833795,-0.738794981
+2916,38180.76077,957.7320574,498.3708134,1100.736842,33630.99043,735.1244019,689.0478469,1556.904306,19207.83971,593.8325359,1107.990431,1762.19378,26296.44737,1347.930622,3369.160287,3612.650718,9166.11244,1326.279904,355.5478469,2492.476077,20123.15789,441.8827751,331.7894737,849.7751196,25143.75359,727.069378,124.5047847,1968.028708,17814.60287,1779.143541,642.3564593,2791.380383,16047.08612,623.6961722,288.1770335,1617.165072,12500.67225,1258.373206,423.5789474,1310.703349,9231.476077,720.0550239,164.8660287,2428.95933,8034.220096,1416.971292,434.4665072,3232.849282,722.8947368,641.5454545,418,25.50613038,21.89059756,0.513234402,0.887473461,0.574175824,1.517758449
+2917,52174.05738,1060.762295,531.0655738,1126.040984,45179.7623,722.3032787,881.7131148,1904.811475,27713.84426,556.557377,1660.95082,2002.114754,36664.29508,1353.393443,3271.139344,2389.295082,13235.42623,1366.532787,354.7295082,2419.909836,28464.52459,458.1393443,132.5245902,1454.57377,33974.16393,502.8934426,418.4344262,1341.754098,25539.15574,2012.377049,552.4262295,2818.114754,23284.89344,824.6311475,314.9098361,1499.868852,18001.84426,1643.704918,440.7540984,1303.131148,12701.32787,662.0245902,165.5081967,1716.442623,11381.93443,1447.942623,403.352459,3321.172131,773.557377,635.8114754,122,15.75421827,10.96206527,0.718218358,0.85915493,0.677777778,-0.043261881
+2918,33425.69091,891.6121212,534.9818182,1097.012121,30737.29697,703.7393939,882.5454545,1529.375758,17166.38182,535.6181818,2561.618182,1848.933333,23639.84848,1273.727273,4954.763636,4500.90303,8317.236364,1276.581818,324.9393939,2607.775758,18080.2303,696.9636364,128.1515152,1715.50303,21815.84242,1104.2,586.0060606,1602.127273,15924.78788,2202.539394,580.7393939,2803.587879,14330.94545,656.2909091,276.3151515,1655.169697,11233,1533.630303,421.4181818,1304.636364,8271.987879,626.9575758,165.8181818,2941.8,7182.357576,1343.545455,456.3212121,3203.272727,783.7030303,637.8666667,165,19.18297112,11.16989719,0.812986943,0.948275862,0.75,-0.167594257
+2919,39722.31959,860.4742268,524.2164948,1087.948454,33869.84536,717.4639175,958.5876289,1547.123711,20786.3299,538.9896907,1992.989691,1765.329897,27832.05155,1278.556701,4421.556701,3611.742268,9977.216495,1310.072165,332.5360825,2709.154639,20092.5567,421.3505155,1476.226804,1160,24615.16495,1051.329897,525.3814433,2318.340206,19166.34021,1915.113402,560.6082474,2825.360825,16610.38144,650.8762887,289.7113402,1726.257732,13005.10309,1436.268041,433.5360825,1343.42268,9033.381443,1016.907216,166.5154639,4302.917526,8186.134021,1355.690722,227.4226804,3279.092784,823.742268,634.4536082,97,12.54123912,10.0067746,0.602777183,0.950980392,0.621794872,1.108309223
+2920,40180.10976,950.4390244,515.9756098,1117.804878,36992.62195,697.2317073,644.8170732,1788.304878,16680.96341,478.1097561,755.2560976,1748.134146,24609.80488,1205.158537,5777.292683,2531.47561,9262.378049,1252.658537,328.4878049,2358.926829,17494.92683,467.7317073,1883.012195,909.7073171,21244.79268,459.0365854,124.9634146,3032.719512,16759.78049,1844.902439,417.7195122,2814.634146,13051.2561,582,261.4512195,994.3536585,8262.890244,940.0243902,390.6341463,1311.317073,3936.646341,1045.609756,151.5121951,2246.646341,4403.158537,1145.243902,222.8902439,3225.219512,1106.439024,636.1463415,82,11.563195,10.53855358,0.411548877,0.845360825,0.569444444,-0.581407021
+2921,25585.08,901.95,537.23,1062.7,23440.48,693.79,537.97,1525.08,13518.1,555,721.15,1757.37,17006.39,1271.77,3846.75,2849.06,6374.02,1405.78,332.41,2675.5,13439.75,421.76,766.75,485.88,15160.97,480.8,132.4,4117.54,12008.29,1811.97,580.76,2807.88,10322.58,777.04,284.46,1486.32,7317.04,890.66,436.91,1436.44,5904.34,793.86,177.02,6093.96,4954.04,1316.92,861.02,3280.8,306.36,635.67,100,12.61088344,10.14443783,0.594061962,0.934579439,0.694444444,-0.895952478
+2922,33716.04217,958.2168675,700.8192771,1135.801205,30783.16265,754.6686747,600.0361446,1665.018072,17346.40361,567.873494,554.0542169,1784.819277,23222.71084,1372.144578,4547.722892,3360.849398,7940.728916,1402.933735,348.8614458,2400.572289,16806.12651,465.7048193,603.5722892,496.0180723,19382.48193,442.2710843,132.7409639,3742.331325,14781.13855,1628.114458,712.7891566,2809.343373,12854.61446,683.8253012,304.4819277,1871.006024,9759.090361,972.3674699,463.8493976,1376.271084,7457.843373,795.313253,181.4096386,6057.463855,6556.710843,1411.150602,207.7831325,3322.710843,404.2108434,635.9939759,166,17.06580245,12.5611093,0.676938297,0.943181818,0.751131222,-1.249592212
+2923,18239.33679,910.3212435,507.880829,1074.668394,17253.82383,735.119171,545.5544041,1526.38342,9793.357513,551.3678756,445.3834197,1761.129534,13139.95855,1369.92228,2311.42487,1617.569948,4540.73057,1306.207254,337.1036269,2341.523316,9697.777202,504.4093264,380.5544041,452.0673575,11236.28497,450.7046632,130.4818653,1107.585492,8541.92228,1453.590674,651.6683938,2819.512953,7641.974093,717.8290155,284.4093264,1655.046632,5959.601036,1011.248705,438.7357513,1322.067358,4736.53886,1926.544041,176.9378238,2834.326425,4337.849741,1945.450777,11093.00518,3181.098446,437.0829016,637.3834197,193,17.0116241,14.52093448,0.52094711,0.955445545,0.804166667,-0.225116902
+2924,44470.98438,971.5234375,553.7109375,1135.546875,41594.32031,830.890625,1025.195313,1729.78125,23864.02344,616.7421875,1198.140625,1887.085938,31574.96875,1469.164063,5211.890625,4219.65625,10994.86719,1491.953125,387.3984375,2657.992188,23420.1875,4097.023438,241.0859375,1371.835938,27505.96875,491.8828125,591.1953125,3067.648438,20513.54688,2184.898438,763.8515625,2838.476563,18166.5625,673.59375,348.6640625,1834.710938,14161.24219,1452.757813,497.9375,1338.585938,10664.01563,725.40625,187.4921875,5202.5,9593.515625,1544.0625,260.984375,3401.335938,484.21875,636.5234375,128,14.47357952,12.61907611,0.489737833,0.815286624,0.60952381,-1.210341856
+2925,39088.50505,915.1111111,555.020202,1110.111111,35128.94949,825.8484848,1011.888889,1636.323232,21905.33333,588.2020202,2067.656566,1819.656566,28103.70707,1398.353535,5630.747475,3947.858586,10015.66667,1443.59596,365.5757576,2703.020202,20170.0101,481.040404,138.6868687,1996.252525,24895.14141,1280.494949,669.2424242,2917.070707,18651.66667,2035.10101,698.2929293,2822.585859,16596.93939,658.8686869,323,1611.191919,12952.16162,1741.626263,482.030303,1317.878788,9633,687.2121212,182.7777778,3960.333333,9061.959596,1487.20202,475.1212121,3341.030303,504.4343434,633.4242424,99,15.30786426,8.438332871,0.834345615,0.933962264,0.6875,-1.483924585
+2926,26225.15351,1008.723684,642.9166667,1093.820175,23069.12719,735.004386,771.5219298,1514.530702,13625.08333,561.1710526,1214.460526,1778.280702,17707.76316,1309.679825,3098.925439,2697.539474,6279.004386,1332.464912,331.8640351,2452.368421,13125.33772,1728.048246,158.5219298,609.3201754,16115.15789,688.6052632,345.1008772,2133.850877,11993.97807,1828.192982,708.1666667,2824.828947,10648.92544,1269.149123,285.4473684,1707.307018,8228.135965,1109.517544,427.9736842,1323.311404,6338.47807,653.5657895,167.745614,3728.894737,5731.833333,1364.688596,429.0482456,3345.008772,566.7017544,639.8508772,228,22.9110514,13.07090564,0.821293029,0.908366534,0.690909091,-0.313257196
+2927,29916.49462,800.0430108,547.3333333,1071.268817,27373.7957,686.9892473,603.1182796,1617.634409,15180.73118,493.1612903,1105.731183,1745.408602,20987.26882,1182.903226,4994.806452,4374.731183,7483.870968,1239.322581,311.4193548,2544.086022,14860.07527,594.6666667,447.3870968,1008.741935,17732.88172,427.6989247,148.9247312,2846.354839,13835.72043,1723.408602,573.827957,2796.849462,11685.91398,695.6774194,264.3333333,1817.849462,8737.892473,1490.989247,399.5053763,1308.365591,5782.043011,680.4516129,164.7419355,6591.494624,5366.064516,1254.258065,1770.451613,3277.55914,954.0322581,636.9784946,93,14.22675912,8.704528957,0.790979993,0.93,0.664285714,-0.3940523
+2928,30237.87356,1152.310345,675.4942529,1143.471264,19215.86207,564.6666667,762.3103448,1438.724138,10615.89655,470.7701149,1339.793103,1769.83908,13791.14943,1068.770115,8192.195402,3469.91954,4885.689655,1184.333333,283.3678161,2424.689655,10513.32184,2658.724138,160.7356322,459.1149425,12657.81609,376.3793103,116.4482759,7410.632184,9881.448276,1775.54023,620.183908,2805.954023,8498.310345,553.4942529,248.7931034,1715.896552,5998.425287,1415.62069,391.5172414,1304.126437,4651.862069,609.9655172,166.6436782,10080.37931,4252.091954,1213.022989,220.5747126,3275.528736,282.5402299,637.137931,87,12.09117273,9.483302035,0.620361329,0.925531915,0.608391608,0.044241451
+2929,37884.19725,909.7155963,568.3165138,1103.399083,28048.27982,686.4082569,498.0366972,1595.33945,16103.54128,518.7568807,628.2798165,1767.16055,21055.43578,1254.146789,7677.201835,3357.206422,7556.43578,1351.761468,331.8577982,2417.550459,16340.81193,421.1880734,252.587156,529.3073394,18145.09174,451.206422,132.9036697,5511.981651,13903.38991,1491.495413,655.9816514,2818.733945,12294.25688,634.5321101,288.1880734,1799.302752,9164.784404,960.9174312,435.9908257,1306.761468,7110.279817,702.2522936,173.3348624,4561.981651,6329.701835,1359.770642,207.7247706,3290.944954,381.7568807,639.4174312,218,20.79354218,13.64307309,0.754655981,0.947826087,0.603878116,-0.867601396
+2930,12410.31111,791.6222222,462.9111111,1059.244444,14274.84444,641.2444444,481.6666667,1380.222222,5726.044444,487.5555556,665,1740.133333,10084.44444,1213.2,1642.288889,2875.155556,3488.222222,1200.266667,316,2361.2,7218.844444,390.7111111,648.3111111,703.9555556,9136.511111,418.8222222,123.2,1303.955556,6218.844444,1454.688889,622.9111111,2810.955556,5553.044444,769.4888889,250.8,1765.155556,4397.311111,898.9555556,388.8222222,1298.955556,3669.377778,743.2444444,163.9777778,2816.422222,2961.311111,1296.333333,3421.311111,3106.155556,857.8222222,633.4444444,45,10.7157748,5.803772515,0.840629784,0.957446809,0.584415584,-1.317105209
+2931,35213.82906,884.6239316,566.5042735,1094.487179,33135.99145,703.4444444,525.5726496,1617.076923,18641.01709,569.3675214,498.1709402,1774.076923,23828.44444,1271.461538,8434.487179,5383.692308,8814.957265,1370.623932,353.3504274,2316.760684,18637.77778,434.7521368,631,422.1025641,21921.69231,417.4529915,132.1025641,5173.854701,16653.2735,1585.632479,603.5128205,2819.213675,14536.53846,655.7094017,302.0854701,2237.752137,10203.53846,864.2393162,447.1538462,1309.051282,7766.247863,881.7521368,175.1538462,3987.982906,6786.692308,1362.581197,324.5641026,3341.042735,256.1538462,637.9401709,117,13.41299293,11.30301793,0.538396401,0.959016393,0.818181818,0.528616184
+2932,38311.46457,954.1496063,572.7244094,1119.362205,35471.94488,740.0393701,800.1102362,1628.787402,20633.81102,604.6929134,1736.377953,1816.889764,25685.93701,1341.574803,5989.055118,3266.19685,9346.976378,1454.102362,348.496063,2586.645669,20085.66142,450.5275591,456.8110236,566.1338583,22787.74016,458.6929134,142.6062992,5308.354331,18320.9685,2185.133858,673.9055118,2816.141732,15854.41732,665.4173228,316.9448819,1480.393701,11436.25984,1007.850394,468.5748031,1329.409449,8608.314961,729.2283465,174.2519685,3216.543307,7702.267717,1399.440945,214.3700787,3427.401575,316.4094488,640.8503937,127,14.67903596,12.6318707,0.509385967,0.808917197,0.574660633,-0.552336522
+2933,25490.94444,926.3,502.2333333,1070.855556,23252.47778,754.4,437.9777778,1452.588889,13438.2,567.0555556,395.2333333,1676.011111,17935.15556,1422.455556,4078.022222,2717.833333,6021.555556,1355.011111,357.9333333,2344.455556,12626.98889,458.9222222,771.4888889,432.5333333,15202.37778,423.7555556,134.9222222,3478.166667,11378.62222,1473.677778,728.4777778,2810.733333,10019.91111,664.8222222,292.1444444,1707.777778,7746.233333,843.1777778,459.6111111,1331.555556,6190.755556,840.5444444,188.1555556,3048.9,5515.5,1540.566667,3977.1,3178.266667,424.2333333,638.1777778,90,13.56003601,9.169621945,0.736696061,0.918367347,0.532544379,-0.857750548
+2934,18218.58824,924.8235294,643.0392157,1114.019608,18846.96078,735.6078431,902.9803922,1613.176471,9274.156863,553.6078431,600.6470588,1769.411765,12578.72549,1320.27451,2695.254902,2714.039216,4493.470588,1410.176471,332.5882353,2404.588235,10811.84314,484.0588235,354.6862745,495.5490196,11424.90196,497.0392157,132.8235294,2775.803922,8015.529412,1501.098039,727.4313725,2825.019608,7466.627451,728.4705882,284.5294118,1799.764706,5848.764706,1061.490196,449.1176471,1341.470588,4852.901961,663.7254902,167.4313725,2166.039216,3854.72549,1414.862745,234.8431373,3325.607843,463.1960784,635.5882353,51,10.83760691,6.435402406,0.804610537,0.879310345,0.6375,1.262298527
+2935,12428.32308,996.9076923,688.9,1204.961538,11605.95385,777.0076923,532.2615385,1593.576923,6421.523077,587.3769231,481.2615385,1731.115385,9375.6,1517.692308,798.2461538,1887.738462,3369.569231,1338.146154,383.9846154,2371.030769,7233.730769,577.6615385,535.2538462,513.3230769,9085.284615,477.0307692,131.8769231,878.7076923,6742.676923,1423.469231,550.2307692,2818.515385,6046.207692,648.8769231,289.1923077,2143.053846,4917.415385,1106.4,436.1846154,1338.992308,3821.123077,1408.938462,172.8615385,1229.576923,3589.446154,1503.207692,758.2538462,3351.230769,699.1307692,637.6,130,13.88387013,11.9989071,0.503090728,0.962962963,0.714285714,-0.787387208
+2936,38776.97872,1041.340426,1053.06383,1247.670213,33843.46809,820.1489362,1107.776596,1907.659574,19963.1383,598.9787234,636.2978723,1825.117021,26919.97872,1493.968085,2724.308511,1679.234043,9188,1479.882979,363.5319149,2433.12766,19561.48936,583.7978723,154.6914894,558.9255319,23452.2766,558.7021277,141.6170213,1605.744681,17344.53191,1612.159574,545.2234043,2837.819149,15594.3617,756.2340426,319.6276596,2139.574468,12081.47872,1043.904255,462.7021277,1355.521277,8831.840426,671.3404255,182.1489362,1592.957447,7367.904255,1533.404255,185.5425532,3387.893617,794.9680851,638.1276596,94,13.2030344,9.364865538,0.704910302,0.94,0.652777778,0.831086763
+2937,18521.60274,828.369863,470.7808219,1101.657534,19211.20548,640.5342466,471.369863,1493.657534,9405.013699,478.4109589,481.9863014,1729.863014,14404.17808,1218.136986,1484.287671,1660.09589,5093.219178,1213.178082,320.4931507,2323.575342,10306.43836,396.1780822,133.2876712,519.9863014,12597.67123,420.890411,123.8219178,1123.219178,9468.726027,1390.575342,504.4794521,2926.534247,8355.191781,645.7260274,258.4383562,1524.205479,6539.726027,806.7123288,404.3972603,1294.849315,4887.986301,629.9863014,157.0958904,2012.041096,4281.972603,1325.082192,2924.315068,3118.246575,862.4109589,638.8356164,73,15.40516601,6.831515292,0.896296079,0.802197802,0.442424242,-0.51998248
+2938,39432.11429,920.4190476,537.9714286,1085.180952,36500.84762,709.2571429,644.8761905,1607.133333,20748.64762,577.4095238,491.2666667,1773.07619,26344.50476,1279.647619,3857.895238,4093.019048,9869.12381,1370.761905,339.2285714,2318.219048,19916.78095,427.7809524,161.8571429,412.7428571,23850.64762,407.1714286,130.4666667,3140.2,18279.97143,1477.209524,555.1619048,2827.485714,16119.38095,615.7428571,301.0380952,2167.67619,10846.61905,812.7238095,441.8,1305.504762,8002.019048,638.1238095,168.6952381,2933.104762,7136.12381,1317.428571,207.7047619,3359.057143,237.8380952,638.6190476,105,15.27368078,9.968136524,0.75767258,0.867768595,0.596590909,1.515471306
+2939,29649.05882,982.8088235,679.7794118,1166.676471,27453.66176,825.1911765,895.8823529,1711.455882,16450.19118,590.0294118,1703.176471,1919.367647,21253.20588,1441.867647,7370.441176,4281.632353,7294.661765,1411.426471,371.9264706,2532.117647,15611.45588,520.1323529,159,2211.691176,19413.16176,481.6764706,621.25,5626.705882,13970.04412,2585.573529,683.5882353,2828.058824,12569.72059,655.9264706,318.4705882,1624.514706,9909.308824,1669.485294,482.5588235,1338.602941,7537.147059,703.6911765,191.1470588,5130.485294,6840.470588,1503.926471,444.9852941,3321.485294,514.4558824,637.3823529,68,9.744512317,9.322528176,0.291091551,0.906666667,0.561983471,-0.977368323
+2940,19371.81746,941.2380952,529.6269841,1042.238095,16916.92063,674.1984127,567.7539683,1445,10000.00794,530.2142857,1188.666667,1764.912698,13187.69841,1281.952381,4891.587302,3247.47619,4608.412698,1253.007937,308.0952381,2375.238095,9856.5,437.6111111,443.0714286,1231.087302,11657.57937,653.6666667,116.2619048,2719.428571,8935.730159,2084.952381,708.9444444,2810.238095,7939.936508,780.0714286,269.8571429,1456.325397,6007.198413,1125.793651,403.1507937,1315.84127,4834.02381,691,156.3015873,2267.444444,4356.071429,1270.571429,468.031746,3338.507937,580.7222222,638.7698413,126,13.79271397,11.72960641,0.526103612,0.947368421,0.75,-1.276651698
+2941,26181.68,820.588,604.556,1072.2,23693.732,718.016,782.9,1521.008,13419.412,518.684,1216.444,1808.744,18255.62,1224.58,4648.204,3356.18,6330,1283.076,308.712,2403.096,13697.12,469.58,300.392,1340.984,16427.052,1055.7,183.16,1747.996,12369.516,1785.084,1116.868,2804.464,11003.784,1207.216,266.892,1596.944,8479.952,1277.972,397.684,1321.804,6680.128,671.04,155.332,5780.836,6016.096,1323.46,758.348,3233.504,627.012,645.668,250,29.58161729,10.89119049,0.929756798,0.902527076,0.544662309,-0.51541784
+2942,40731.50633,840.6835443,551.1265823,1103.164557,37041.02532,716.8481013,676.9113924,1639.240506,21188.63291,526.4177215,675.9493671,1775.708861,28497.8481,1297.126582,5039.493671,3595.126582,10428.83544,1306.367089,334.4303797,2392.746835,20185.75949,955.9620253,1589.810127,691.9493671,24276.86076,439.8227848,135.0506329,3392,19232.72152,1835.860759,691.6835443,2844.848101,16267.31646,1082.594937,279.0632911,1747.367089,12295.97468,941.9873418,418.0506329,1326.620253,8017.405063,1014.506329,158.3291139,4483.405063,7361.911392,1280.670886,185.9746835,3257.632911,935.2658228,637.7341772,79,14.81480134,8.238976778,0.831094353,0.81443299,0.526666667,-1.368363757
+2943,40904.15205,916.4853801,532.5438596,1103.397661,35738.95322,632.8888889,835.619883,1560.175439,19147.71345,465.2748538,1012.146199,1758.19883,26350.11696,1164.467836,6311,3266.28655,10100.80117,1235.403509,321.5964912,2533.426901,18824.80117,4609,1156.77193,1022.994152,24029.44444,437.0467836,126.0877193,3745.438596,18293.61404,2191.602339,438.5087719,2824.602339,14780.61988,599.1754386,269.2573099,1305.087719,10608.9883,1002.549708,398.8538012,1304.760234,5906.865497,874.374269,156.502924,2515.853801,6137.94152,1185.187135,205.2982456,3249.497076,1042.497076,639.4210526,171,17.47212148,12.84657417,0.677783792,0.909574468,0.642857143,-1.372999792
+2944,29873.58571,947.7,599.3857143,1085.3,25669.24286,742.1142857,762.1142857,1567.614286,13242.98571,578.1571429,1504.214286,1805.414286,18643.42857,1369.185714,5981.014286,3136.8,6501.228571,1457.542857,337.6142857,2513.514286,13656.77143,395.3857143,190.4285714,1051.228571,17437.31429,691.3,475.4857143,3917.314286,13238.6,2381.614286,568.2142857,2825.857143,11409.27143,616.3285714,296.3714286,1521.785714,8276.185714,1157.128571,444.5571429,1309.871429,6165.071429,639.6285714,173.9857143,2341.428571,5529.4,1297.628571,251,3319.185714,337.6857143,638.9285714,70,11.79139999,7.905747629,0.741939118,0.897435897,0.578512397,0.83992348
+2945,39992.03425,888.8630137,601.239726,1108.650685,35791.34247,724.2328767,827.7123288,1610.417808,21392.92466,546.109589,1772.356164,1760.979452,28170.73973,1324.630137,3953.178082,5082.931507,10273.35616,1324.924658,343.6780822,2417.849315,20805.78082,440.869863,1062.767123,996.4178082,25517.50685,1470.732877,132.0342466,2366.575342,19386.18493,1678.952055,623.9931507,2798.993151,17181.96575,684.9041096,296.3561644,1994.390411,13500.20548,1472.164384,432.739726,1325.253425,9459.506849,910.1164384,170.8630137,4102.486301,8360.561644,1412.623288,291.9726027,3278.287671,811.8287671,640.1780822,146,19.81199172,10.4914291,0.848279077,0.829545455,0.591093117,1.375578018
+2946,56829.0177,995.6902655,612.4690265,1202.867257,56173.56637,814.9557522,692.4424779,1903.849558,26341.73451,615.2123894,529.3716814,1775.044248,36834.0531,1479.176991,6180.070796,6637.522124,13466.38938,1545.955752,388.920354,2377.362832,27631.74336,498.539823,142.8938053,469.3628319,33234.02655,495.0619469,148.079646,5118.778761,24008.47788,1643.327434,592.6460177,2921.938053,20716.16814,667.9557522,354.1415929,5524.283186,12258.92035,951.0530973,489.7256637,1296.964602,8574.132743,663.9911504,184.5752212,3811.283186,7493.80531,1467.486726,165.8584071,3357.035398,148.8318584,640.0088496,113,13.00425096,11.10180246,0.520755865,0.982608696,0.724358974,-1.280493104
+2947,42427.07586,894.6689655,615.9586207,1126.386207,41345.57241,736.4689655,703.6,1734.503448,21813.71034,583.0758621,785.537931,1770.57931,28534.44828,1334.441379,10156.66897,7503.634483,10948.18621,1428.544828,359,3208.22069,21492.5931,460.7448276,347.4482759,484.8068966,26640.34483,451.6482759,139.737931,5940.827586,19552.92414,1821.131034,775.4137931,2889.937931,17378.52414,632.5448276,315.4275862,3079.234483,11594.64828,985.6068966,469.3034483,1316.737931,8345.62069,685.0896552,180.8344828,4580.572414,7040.193103,1405.517241,230.7241379,3312.055172,200.3793103,641.7310345,145,15.33468432,12.73422043,0.557138675,0.923566879,0.69047619,-0.268518296
+2948,24218.61702,807.6382979,592.1489362,1109.340426,24115.80851,668.212766,598.5957447,1634.468085,12566.95745,532.893617,540.3404255,1837.617021,16417.29787,1212.87234,8306.042553,8490.340426,6502.425532,1306.255319,330.7021277,2350.765957,12961.34043,426.106383,207.9787234,449.0212766,15076.85106,412.2978723,126.4680851,4620.87234,11023.80851,1410.702128,552.4468085,2813.382979,10069.17021,606.8723404,270.5531915,3027.765957,6590.87234,787.8723404,414.1702128,1298.12766,4909.617021,637.0212766,168.4042553,4736.744681,4084.276596,1314.659574,230.2978723,3213.021277,217.4680851,640.4893617,47,11.83900008,5.338615969,0.892556942,0.886792453,0.55952381,-0.374898638
+2949,42916.83019,1149,669.8490566,1162.339623,39490.92453,835.4716981,996.3018868,1728.433962,22317.75472,671.0188679,1908.584906,1839.830189,28743.86792,1442.603774,5344.754717,4693.943396,10165.16981,1460.962264,368.9245283,2492.056604,24266.26415,500.7924528,197.4150943,1152.735849,25381.35849,594.0188679,534.3207547,6880.471698,20227.26415,2338.45283,656.490566,2845.207547,17798.22642,659.5471698,347.9056604,1805.509434,12852.01887,1732.641509,479.8867925,1340.45283,9925.811321,686.3207547,177.9433962,3109.169811,9092.056604,1521.415094,229.9245283,3444.188679,328.3962264,638.7735849,53,9.408582151,7.304381042,0.630298349,0.946428571,0.736111111,-0.782806674
+2950,35243.7549,933.6078431,639.9803922,1139.5,33945.2451,753.1960784,888.9019608,1665.607843,19088.32353,578.8235294,1062.303922,1797.22549,25418.88235,1401.343137,5547.215686,4337.137255,8845.490196,1432.54902,386.9803922,2474.941176,19392.40196,494.6372549,231.1372549,701.6960784,22890.52941,1460.323529,149.3039216,4785.745098,16388.44118,1667.480392,757.0294118,2807.686275,14799.22549,653.5686275,313.627451,2095.901961,11678.2549,1345.22549,473.1960784,1329.872549,9041.343137,725.8235294,179.6176471,4871.872549,7981.54902,1477.970588,212.8529412,3383.27451,498.0882353,640.9019608,102,14.58632552,9.884627022,0.73537172,0.829268293,0.490384615,1.165284386
+2951,26990.5988,1169.443114,505.2874251,1058.60479,23169.50299,763.4670659,586.8263473,1436.413174,13376.94012,585.6167665,814.7185629,1726.377246,17920.67066,1368.742515,2272.976048,2256.790419,6036.60479,1256.922156,300.5209581,2364.317365,13033.47904,448.3173653,129.5688623,894.9221557,15835.77246,850.0239521,132.5149701,1374.473054,11971.93413,1554.209581,584.994012,2785.437126,10422.76048,636.1317365,254.1437126,1502.562874,8117.952096,1129.922156,386.8742515,1295.526946,6197.904192,607.491018,154.8802395,1604.718563,5629.922156,1287.473054,715.4431138,3424.748503,662.0239521,642.1497006,167,17.88522361,12.65063074,0.706890456,0.902702703,0.613970588,0.585507568
+2952,39693.1746,864.7460317,461.3015873,1087,32435.44444,704.1111111,609.9365079,1593.666667,20460.42857,523.952381,764.6031746,1725.111111,28048.09524,1317.857143,3131.222222,3718.428571,10127,1314.190476,340.2539683,2450.047619,20001.39683,433.3015873,491.8412698,692.6507937,24013.98413,592.5555556,125.7460317,1696.031746,19350.39683,1584.873016,687.7619048,2807.84127,16991.95238,668.4603175,289.5079365,2099.746032,12804.4127,988.3650794,428.952381,1312.761905,8675.333333,747.1269841,159.5079365,3180.873016,8352.873016,1371.095238,775.8888889,3212.555556,853.1111111,640.5555556,63,10.77458424,7.946916652,0.675280156,0.926470588,0.65625,-0.294444826
+2953,42099.17164,914.4850746,577.9402985,1116.947761,36808.92537,697.2313433,542.1492537,1736.440299,18935.56716,494.4104478,687.1716418,1733.932836,25980.49254,1253.619403,8358.679104,2764.365672,9845.552239,1277.753731,324.7910448,2339.126866,19018.8806,437.761194,433.9104478,653.8432836,23831.05224,441.6492537,136.2164179,5467.358209,18334.77612,1588.514925,440.5074627,2803.029851,14764.48507,648.4104478,281.2761194,1498.320896,10386.78358,822.4179104,405.3656716,1300.843284,5587.41791,710.8955224,164.5447761,4833.761194,5812.686567,1214.671642,307.4402985,3297.074627,1059.044776,642.4552239,134,15.38540252,11.49437928,0.664715673,0.911564626,0.56302521,0.521268951
+2954,25979.29032,859.0645161,446.3870968,1072.387097,21851.41935,673.516129,804.1774194,1481.854839,13444.01613,538.5806452,1047.33871,1775.580645,17505.40323,1243.419355,2382.403226,2903.903226,6292.080645,1267.403226,334.2580645,2410.096774,12819.08065,494.2096774,619.7903226,979.4193548,15720.19355,680.2419355,123.1935484,1270.854839,12058.5,1720,602.3870968,2826.419355,10534.72581,691.7580645,260,1649.935484,8184.129032,1325.193548,398.2419355,1340.580645,6276.5,1238.129032,154.2258065,2077.274194,5780.225806,1316.903226,325.8870968,3262.564516,648.2741935,640.3870968,62,10.62054386,7.499919541,0.708041376,0.984126984,0.704545455,-0.239938585
+2955,38989.97436,842.3333333,529.3461538,1084.5,34610.73077,713.0128205,777.5769231,1530.794872,19582.14103,581.7948718,907.6282051,1765.141026,27495.74359,1249.115385,3544.512821,3137.089744,9520.769231,1319.730769,332.525641,2472.358974,21033.32051,433.2307692,773.6282051,838.2564103,25691.91026,463.6923077,157.0128205,3529.525641,18519.38462,1834.679487,606.4871795,2772.961538,16709.26923,617.6153846,287.8717949,1753.24359,13070.17949,1024.012821,420.5769231,1364.641026,9637.115385,833.7307692,160.8205128,3242.115385,8458.423077,1350.794872,215.525641,3205.179487,748.1923077,641.7948718,78,13.13739038,7.967267409,0.795115992,0.917647059,0.590909091,-0.794231976
+2956,30448.21277,817.4840426,480.143617,1063.989362,27596.71809,670.287234,797.9414894,1528.505319,15561.81383,511.0585106,1908.510638,1748.398936,21995.79787,1241.542553,4121.452128,4528.946809,7718.851064,1259.223404,324.4680851,2836.111702,15927.17021,535.6968085,751.2446809,1455.664894,19699.70745,1296.154255,122.4893617,2554.06383,14699.23404,1841.914894,581.7925532,2785.255319,12843.77128,660.8351064,271.7978723,1704.25,9919.015957,1440.265957,406.7659574,1326.994681,7061.404255,810.1808511,163.8882979,4203.792553,6405.31383,1302.728723,622.1968085,3248.510638,841.1861702,642.6968085,188,17.91610577,13.79055084,0.638370477,0.921568627,0.746031746,-1.330419521
+2957,33169.06731,880.6346154,502.5096154,1082.711538,29258.78846,696.2115385,567.8557692,1506.932692,17213.29808,531.5769231,423.9038462,1693.913462,23324.18269,1314.971154,2419.144231,1540.961538,8330.75,1289.086538,337.2788462,2320.711538,16968.46154,425.6826923,126.375,469.9807692,20651.21154,448.1923077,126.0961538,1132.461538,16601.13462,1399.048077,474.9326923,2806.980769,14594.41346,683.0673077,285.5865385,1424.692308,11034.64423,818.6057692,424.7980769,1304.057692,7678.846154,643.2884615,165.6057692,2091.259615,7220.423077,1398.076923,1851.653846,3190.144231,869.7788462,641.7211538,104,15.54804183,8.801280435,0.824357159,0.936936937,0.577777778,-1.002388199
+2958,33648.47863,830.9145299,548.7264957,1079.384615,28920.52137,698.3418803,780.2051282,1547.760684,16993.46154,503.6752137,1886.641026,1794.581197,23733.62393,1223.931624,4668.897436,3885.188034,8506.418803,1273.213675,324.1794872,2776.059829,16947.49573,458.1025641,443.5470085,1483.324786,21169.22222,1269.435897,176.3333333,2000.632479,16305.7094,1961.128205,899.9230769,2801.598291,14003.11966,650.8205128,274.3247863,1536.136752,10816.81197,1463.282051,416.965812,1300.769231,7402.581197,699.2051282,164.8547009,6117.632479,6700.487179,1303.452991,759.965812,3282.299145,890.8461538,641.7094017,117,15.00445864,10.44028796,0.718223602,0.921259843,0.596938776,0.624312832
+2959,43943.08065,1165.112903,831.9193548,1235.258065,39995.66129,918.1935484,580.5806452,1802.870968,24278.72581,723.5,531.1935484,1767.677419,31320.45161,1741.483871,3158.419355,2980.129032,10404.58065,1645.209677,437.4677419,2401.516129,21864.56452,635.9677419,200.7741935,487.7096774,26872.56452,528.6935484,172.3870968,3938.741935,20448.40323,1738.290323,738.6451613,2830.193548,18156.87097,800.5645161,389.6612903,2056.048387,13795.01613,1064.032258,554.4354839,1349.145161,10561.54839,763.7419355,222.1290323,3957.145161,9668.048387,1741.435484,277.8064516,3332.064516,554.6612903,640.1774194,62,11.79837536,7.894939936,0.743123008,0.885714286,0.645833333,1.411239495
+2960,35155.89869,831.6601307,510.8137255,1091.003268,31741.39542,683.0849673,679.8006536,1609.401961,17597.04248,500.6601307,1077.019608,1740.232026,24239.99346,1242.542484,6384.924837,3525.029412,8914.826797,1295.526144,333.0588235,2545.421569,17505.64379,479.4084967,427.8137255,662.5882353,21503.8268,726.4836601,132.3300654,4078.316993,16986.64052,1524.111111,490.5686275,2798.320261,14305.67647,642.8888889,278.5065359,1808.24183,10556.12745,1015.084967,420.1437908,1300.235294,6467.960784,695.5980392,168.2156863,4972.104575,6200.330065,1268.173203,599.9411765,3226.117647,991.8921569,650.8431373,306,27.67676999,14.81933548,0.844571304,0.902654867,0.666666667,0.208882398
+2961,30183.12088,857.8241758,559.4285714,1128.714286,29096.72527,702.1098901,708.3846154,1725.241758,14617.20879,503.4175824,970.3736264,1927.593407,20706.57143,1234.021978,8055.428571,4853.681319,7710.032967,1287.593407,329.6923077,2576.56044,14707.9011,1653.318681,468.2087912,1139.989011,18413.47253,469.8901099,130.4175824,4383.274725,14002.87912,2090.43956,492.7692308,2782.384615,11383.12088,813.7142857,277.0769231,2348,8171.142857,978.1978022,414.8901099,1294.021978,4690.89011,717.7582418,158.6043956,4352.824176,4678.351648,1259,782.4615385,3297.912088,1029.549451,642.2307692,91,11.1802262,10.40505606,0.365869993,0.968085106,0.827272727,0.269972108
+2962,60670.30189,987.7169811,601.5849057,1202.584906,58246.13208,814.4339623,641.1509434,1858.622642,31418.5283,632.490566,500.1509434,1752.773585,41328.71698,1467.924528,5866.660377,6344.849057,15166.01887,1541.45283,393.3962264,2374.886792,30099.88679,498,148.6792453,442.5849057,36064.07547,479.9433962,158.509434,4400.320755,27880.13208,1634.207547,640.4150943,2820.283019,23887.30189,679.5471698,363.3773585,5821.188679,15039.22642,914.2641509,487.8301887,1326.301887,9898.943396,671.3018868,188.5660377,3406.924528,9023.641509,1488.245283,226.9811321,3398.698113,167.3396226,642.5283019,53,9.712602911,7.260350715,0.664240948,0.946428571,0.588888889,-0.729721963
+2963,40595.01176,868.7294118,609.7882353,1115.364706,39028.25882,721.9529412,728.2470588,1702.247059,21487.84706,560.6941176,514.3764706,1781.258824,27173.94118,1292,8791.223529,7619.435294,10225.35294,1388.188235,356.1294118,2359.705882,20899.4,455.3294118,252.7411765,430.3176471,25094.77647,432.1294118,133.1058824,5999.082353,18992.14118,1516.152941,624.5294118,2816.152941,16895.90588,615.1411765,315.3647059,3072.882353,11268.71765,893.7882353,450.3647059,1313.717647,8182.458824,673.9764706,182.2235294,5315.964706,7181.635294,1389.482353,246.1882353,3341.047059,225.1411765,642.8588235,85,12.81062923,8.750293734,0.730372095,0.904255319,0.653846154,-1.364357906
+2964,45748.53143,949.3657143,545.92,1127.6,41648.11429,813.3085714,883.8228571,1648.965714,23372.29714,573.5028571,1297.828571,1821.234286,32380.42286,1364.491429,4090.24,4019.508571,11447.46286,1368.537143,350.1771429,2367.891429,24583.95429,467.8457143,150.3714286,852.3657143,30015.47429,466.1314286,366.2057143,3528.342857,21735.64571,1950.588571,732.5942857,2793.068571,19547.58857,637.3828571,300.1371429,1881.234286,15261.28,1168.434286,440.64,1307.091429,11018.23429,654.3542857,162.6628571,2211.057143,9479.88,1405.834286,198.12,3301.594286,759.2742857,644.8971429,175,20.44037392,11.45504771,0.828213417,0.906735751,0.571895425,-0.883761309
+2965,23606.14124,748.6553672,479.3898305,1048.067797,20273.57062,637.2655367,826.4463277,1476.983051,11507.15254,475.2033898,1747.881356,1823.548023,16100.06215,1181.276836,5749.785311,4150.661017,5905.903955,1172.073446,298.6779661,2869.751412,11082,3219.265537,962.9491525,1669.920904,13570.50847,738.5932203,120.7740113,2052.932203,10734.45763,2223.706215,556.0564972,2814.887006,9078.423729,989.7175141,252.6440678,1494.20339,6985.813559,1327.112994,387.9152542,1292.649718,4667.20339,942.2711864,160.1751412,4775.214689,4340.112994,1154.463277,324.3333333,3146.734463,915.8418079,645.440678,177,21.22562528,11.32664849,0.845717515,0.863414634,0.582236842,1.101755199
+2966,34567.22131,872.4262295,580.1639344,1131.754098,26307.86066,643.7540984,880.8934426,1649.532787,10693.87705,467.3852459,2315.434426,1760.827869,16907.92623,1164.344262,11384.7541,4645.959016,6419.188525,1203.909836,312.704918,2717.581967,12181.89344,388.1639344,2152.155738,1186.97541,14911.86885,462.3442623,122.6639344,6247.262295,11475.40164,2969.04918,374.5655738,2811.245902,8951.713115,549.4836066,243.8360656,1176.745902,5369.491803,1728.5,362.147541,1312.401639,2569.508197,1095.42623,141.6065574,3765.47541,2950.032787,1083.229508,485.1065574,3153.040984,1125.032787,642.7459016,122,14.89500384,11.09896238,0.666900632,0.93129771,0.586538462,-1.521562004
+2967,60071.50435,1036.269565,711.6086957,1231.913043,48937.90435,762.0782609,727.2782609,1841.478261,22893.38261,578.8782609,511.2,1770.443478,31784.41739,1360.643478,7319.843478,6052.286957,11730.04348,1434.669565,367.0869565,2364.026087,23936.94783,484.9391304,147.7478261,498.4869565,28037.06087,458.3043478,144.4347826,8233.234783,20533.08696,1574.756522,525.173913,2819.191304,17615.64348,638.4173913,332.0086957,4681.217391,9320.6,843.4173913,455,1311.834783,6504.747826,661.8173913,175.9304348,3091.304348,6101.365217,1326.26087,173.373913,3299.834783,135.8956522,643.973913,115,17.49621019,9.298534418,0.847083441,0.891472868,0.605263158,-1.322337956
+2968,53174.55056,939.5018727,585.6254682,1152.94382,49393.22097,771.9925094,660.5168539,1813.228464,25831.02996,591.588015,520.1722846,1763.041199,33895.52434,1385.385768,5910.41573,6609.846442,12440.11985,1479.018727,377.2097378,2352.157303,25595.16105,488.2659176,142.6516854,453.2134831,30751.81648,453.5917603,141.670412,4823.299625,23159.16479,1589.595506,652.1797753,2817.108614,19996.80524,654.6891386,334.4269663,4850.168539,12544.1161,873.3782772,470.5280899,1319.865169,8526.172285,659.329588,182.3782772,3773.340824,7618.411985,1427.138577,193.82397,3309.494382,173.0898876,653.928839,267,30.45486899,12.28342037,0.915053754,0.797014925,0.55625,-0.205954952
+2969,35810.87059,982.2705882,546.7176471,1208.805882,13220.57059,538.6411765,342.3235294,1575.117647,7329.429412,441.9411765,459.6411765,1742.405882,9417.258824,1061.623529,1708.611765,1091.476471,3672.852941,1403.747059,278.2823529,2354.047059,8065.364706,327.3470588,140.5176471,436.7411765,8764.317647,342.6058824,111.1529412,1247.188235,6836.2,1363,561.3588235,2820.976471,6035.9,592.4470588,239.2352941,1073.594118,4399.770588,765,364.4058824,1277.241176,3292.552941,570.4117647,153.1705882,1862.523529,3086.1,1184.658824,272.1941176,3205.441176,355.7352941,647.1705882,170,17.58902564,13.25246013,0.657504636,0.944444444,0.555555556,-0.634287367
+2970,25995.76522,926.4521739,494.3913043,1080.434783,24017.01739,760.3913043,451.3826087,1480.278261,13661.71304,565.9130435,436.5826087,1717.826087,18007.66087,1384.678261,3168.069565,2134.017391,6198.147826,1416.652174,352.7565217,2341.704348,11958.6,436.1826087,1011.165217,455.226087,13052.86087,405.5826087,131.573913,3547.417391,9954.521739,1493.886957,631.4782609,2817.182609,8877.434783,764.2869565,296.4,1587.556522,6888.878261,803.773913,436.9913043,1354.295652,5478.069565,853.6608696,179.6173913,3365.113043,4992,1420.686957,930.0695652,3169.965217,415.3652174,645.1826087,115,12.52362767,11.92748876,0.304854728,0.974576271,0.680473373,0.522932228
+2971,48331.28767,1026.369863,629.4931507,1162.808219,44384.57534,858.890411,1084.082192,1771.931507,26396.9863,642.9726027,1029.863014,1827.479452,34409.65753,1506.684932,4780.424658,5268.082192,11997.30137,1535,389.3835616,2735.410959,25320.58904,652.4657534,276.6438356,808.5890411,30112,843.5753425,147.9726027,4695.561644,22627.08219,2118.287671,840.5068493,2824.027397,19900.94521,671.8767123,350.0547945,2177.424658,15488.68493,1260.273973,514.0136986,1326.547945,11621.65753,745.5890411,188.7945205,6307.520548,10485,1572.671233,198.3424658,3411.767123,472.2191781,644.3561644,73,11.18558267,9.226351539,0.565361596,0.858823529,0.603305785,0.981534746
+2972,43711.70149,1156.253731,691.119403,1246.820896,38003.29851,915.6567164,790.8059701,1847.656716,24538,681.7462687,943.5671642,1817.373134,30871.85075,1692.447761,2601.298507,3530.164179,10409.16418,1623.358209,485.2238806,2418.179104,21519.95522,565.3283582,161.5223881,1081.776119,25815.53731,538.6865672,165.3134328,2066.164179,19447.55224,2088.850746,841.5970149,2822.910448,17289.01493,710.2686567,368.7761194,1760.492537,12865.55224,1369.38806,514.5074627,1329.462687,9677.895522,728.5373134,197.5074627,2272.328358,8779.253731,1621.014925,218.5223881,3423.820896,508.7910448,643.9402985,67,10.58023411,8.351693387,0.613920911,0.943661972,0.609090909,1.390521102
+2973,37414.21053,917.3458647,587.2631579,1134.06015,33004.37594,744.2631579,1078.616541,1641.225564,20330.06767,577.8270677,1317.789474,1776.300752,25701.70677,1379.203008,5358.383459,5467.864662,9068.466165,1432.142857,355.8496241,2586.533835,18863.35338,490.1729323,157.1879699,464.037594,23070.6015,561.0300752,137.3609023,2845.203008,17262.06015,1581.278195,863.3609023,2836.466165,15568.57143,783.9774436,319.8947368,1837.714286,12046.92481,1204.082707,478.5639098,1317.879699,8908.218045,666.3834586,178.887218,3759.639098,8231.646617,1467.571429,389.7368421,3310.601504,533.2857143,644.8947368,133,14.55083472,12.17264391,0.54787557,0.898648649,0.738888889,-1.531003342
+2974,38106.30612,1026.510204,882.3163265,1231.704082,35386.41837,852.8163265,893.9795918,1858.520408,20876.33673,628.7653061,631.7040816,1807.897959,27452.61224,1526.72449,3773.285714,2619.72449,9059.010204,1652.540816,391.1836735,2442.132653,19051.5102,559.1632653,156.1428571,527.4795918,22937.92857,474.3877551,150.1122449,2486.112245,17339.93878,1708.367347,689.3673469,2833.561224,15579.03061,692.1122449,338.9183673,1847.520408,12372.38776,1088.836735,517.5,1335.5,9158.265306,673.6428571,185.1326531,2070.377551,8450.591837,1568.938776,202.8367347,3345.377551,545.9897959,644.2755102,98,11.85851234,10.69981569,0.431129877,0.98,0.680555556,0.631275147
+2975,29292.3629,767.3629032,507.4919355,1059.983871,26662.27419,643.3709677,651.25,1530.508065,14732.51613,466.6693548,1156.935484,1780.991935,20354.54839,1160.354839,5631.193548,3980.532258,7396.209677,1238.282258,305.8870968,2601.766129,14347.33065,681.5241935,555.2741935,1056.580645,17207.64516,413.6290323,126.3467742,3349.346774,13619.87903,1939.935484,603.1048387,2835.370968,11502.75806,676.9193548,256.0080645,1651.096774,8530.637097,1055.846774,392.5645161,1307.798387,5426.919355,703.0403226,158.8870968,5134.806452,5068.532258,1195.153226,696.6774194,3243.790323,978.8548387,644.4193548,124,13.5722947,12.05350958,0.459656746,0.918518519,0.794871795,-0.874038352
+2976,24568.83516,826.967033,485.2637363,1105.472527,21353.23077,688.8791209,497.4505495,1659.802198,10323.16484,466.3956044,603.3626374,1758.956044,15056.16484,1154.692308,4815.032967,1712.10989,5823.769231,1226.32967,329.8021978,2378.692308,10902,418.1098901,2065.571429,715.6043956,13601.67033,462.8571429,141.1978022,2116.241758,10359.45055,1820.175824,402.978022,2860.307692,8342.582418,651.3956044,253.4615385,1307.296703,5915.67033,781.8461538,383.1428571,1316.703297,3123.703297,1121.164835,151.8901099,2314.483516,3324.131868,1161.417582,609.2857143,3208.351648,1072.087912,643.4725275,91,14.9258721,8.45837739,0.823929482,0.866666667,0.583333333,1.067946569
+2977,37063.425,947.91875,647.5,1109.91875,26486.31875,685.65625,964.88125,1641.34375,11607.925,478.54375,2102.38125,1784.65,17828.66875,1177.425,7474.5375,4033.4625,6682.0625,1260.65625,324.4125,2638.2625,13056.1375,415.90625,1291.825,2058.43125,16175.95625,459.5875,128.475,2878.25625,12540.125,3153.8,390.64375,2790.84375,9911.40625,709.18125,252.93125,1257.675,6500.51875,1409.15625,384.6125,1301.575,3356.0875,881.86875,152.86875,3527.525,3689.21875,1149.8625,2154.85,3213.93125,1090.4375,646.30625,160,20.10531276,10.88638021,0.840721465,0.888888889,0.553633218,-0.812603681
+2978,49190.53333,1063.85,578.2833333,1174.983333,42911.1,822.0166667,926.4,1787.266667,26997.73333,638.3833333,969.1333333,1802.883333,34838.56667,1522.616667,4848.666667,4795.416667,11799.91667,1532.2,395.45,2512.9,24810.11667,523.3666667,170.7166667,605.7,29516.85,1092.416667,146.9166667,3487.316667,22801.36667,1687.05,720.7666667,2826.05,19846.93333,726.8,357.7333333,1868.733333,15222.95,1267.85,509.0166667,1325.7,11416.28333,728.1833333,197.8833333,3895.616667,10432.23333,1581.5,219.5,3453.55,462.25,642.9,60,10.4468269,7.291808712,0.716104893,1,0.857142857,1.563648851
+2979,28636.66038,881.7358491,453.5188679,1064.349057,23450.75472,693.245283,472.9245283,1408.216981,14648.65094,546.2641509,492.3679245,1703.235849,19923.81132,1366.188679,1947.584906,3047.433962,7076.584906,1311.971698,338.1320755,2367.462264,14657.77358,517.1792453,189.7735849,492.6226415,17941.18868,400.9150943,122.6037736,1449.169811,13712.17925,1392,647.4433962,2801.339623,12198.4434,586.2264151,279.9433962,1637.518868,9999.018868,891.8207547,423.490566,1297.103774,7068.773585,712.7358491,161.8207547,1841.773585,6712.5,1478.90566,326.4433962,3192.773585,687.2075472,645.8773585,106,13.62899911,10.04329054,0.675995281,0.929824561,0.679487179,0.677900613
+2980,24844.89908,921.853211,737.0275229,1119.119266,23237.55963,686.9357798,600.5688073,1626.541284,12678.86239,554.3027523,558.3577982,1799.623853,16295.24771,1241.642202,9352.66055,8573.614679,6132.229358,1309.761468,326.1926606,2340.009174,12874.46789,418.9633028,258.0183486,429.6788991,14951.3578,439.0550459,133.0458716,9673.275229,11430.02752,1480.614679,1042.357798,2837.715596,9960.651376,608.5229358,284.6513761,3523.256881,6926.577982,844.3761468,431.6513761,1311.733945,5257.477064,654.5963303,175.4220183,5391.302752,4628.192661,1288.53211,357.9082569,3343.981651,247.9266055,647.6788991,109,13.95225589,10.24482664,0.678849505,0.900826446,0.707792208,-0.025485962
+2981,28953.10938,1008.039063,578.703125,1089.578125,24341.90625,708.6484375,598.796875,1546.5,13693.34375,570.6328125,674.4609375,1770.8125,17970.23438,1270.65625,6675.984375,3415.796875,6379.78125,1336.304688,323.140625,2358.328125,13461.26563,436.3828125,451.4765625,497.7265625,16525.34375,414.9765625,125.0703125,6795.625,12731.97656,1676.617188,614.5390625,2817.273438,11024.60938,598.203125,287.0625,1681.578125,7619.09375,935.421875,426.2578125,1296.78125,5922.625,693.140625,174.046875,5675.414063,5184.015625,1284.414063,345.4921875,3441.609375,288.6484375,647.1796875,128,13.60274286,12.11285458,0.455039054,0.948148148,0.703296703,1.318517106
+2982,23976.88976,828.9527559,470.0866142,1045.11811,24301.34646,681.5590551,648.2677165,1501.204724,12809.06299,540.9448819,565.0551181,1781.866142,16235.98425,1231.023622,5520.574803,2263.84252,6092.086614,1392.606299,331.015748,2431.346457,13446.80315,406.488189,1413.19685,466.2362205,15417.46457,421.5590551,126.9685039,3166.015748,11842.88189,1755.165354,530.0866142,2813.401575,10406.7874,676.6850394,290.7401575,1415.015748,7403.346457,832.7165354,441.4015748,1374.700787,5905.669291,958.8740157,175.5590551,5841.685039,5025.850394,1344.700787,675.3779528,3303.543307,302.9055118,646.3937008,127,16.04185917,10.7573668,0.741836271,0.881944444,0.705555556,-1.241168007
+2983,40136.81595,947.208589,650,1148.717791,37844.30675,769.2269939,818.8343558,1689.030675,21781.71779,596.0981595,874.993865,1817.257669,28554.04294,1422.687117,4521.625767,4784.276074,9825.300613,1461.484663,360.8895706,2419.208589,21505.04294,516.8343558,144.0981595,789.6932515,25467.00613,731.7055215,142.5337423,3687.742331,18580.34969,1599.613497,824.4785276,2829.478528,16630.04294,663.2638037,326.398773,1849.165644,12997.22699,1084.147239,482.0797546,1324.398773,9846.447853,674.3496933,181.6380368,3059.067485,8827.306748,1502.91411,441.8343558,3332.03681,487.7177914,649.1533742,163,17.03780351,13.1322216,0.637113938,0.867021277,0.646825397,-0.233245443
+2984,37700.1375,964.6,477.2375,1092.225,34434.875,750.7625,720.275,1550.175,19210.425,565.85,2230.125,1769.225,26150.6125,1408.2,3249.175,3620.2,9463.925,1379.575,343.6375,2517.9875,19652.225,479.2875,206.7,1837.8625,23488.2125,1456.2875,149,1324.2125,17643.9125,1853.2,585.1125,2812.2875,15479.85,842.1125,287.325,1508.9125,12207.525,1904.2125,423.75,1318.625,9255.425,743.675,164.75,2706.6,8225.1125,1535.65,446.0375,3282.6625,653.5,647.275,80,11.71333451,9.098779842,0.629761953,0.930232558,0.666666667,-0.212135024
+2985,36247.625,839.775,536.55,1111.33125,34249.05,758.03125,1014.91875,1652.74375,18963.8,512.275,2312.2625,1819.78125,26168.25,1283.80625,6403.98125,3998.2625,9251.6,1284.225,327.125,2692.6625,18282.2125,714.675,610.74375,2386.00625,22329.65625,452.2125,166.3125,2566.1125,17414.675,2196.925,504.64375,2831.44375,14698.50625,776.85,279.20625,1743.04375,11102.0625,1212.15625,418.49375,1313.6125,7427.825,756.36875,165.14375,5694.425,6688.25625,1268.73125,272.575,3293.75625,932.94375,648.55625,160,16.71798896,12.67704994,0.651919743,0.903954802,0.588235294,-0.459266686
+2986,32710.37433,829.7860963,502.3368984,1091.812834,29313.49733,707.540107,834.0481283,1605.737968,17169.91979,490.5347594,1887.294118,1756.026738,23510.52406,1272.967914,5159.491979,2498.652406,8477.44385,1268.668449,323.3903743,2470.497326,16454.63636,795.5240642,394.7647059,1225.941176,20037.71658,451.0855615,409.8181818,3298.390374,15725.16043,1660.647059,487.6791444,2802.657754,13271.58824,796.7486631,271.0053476,1828.775401,10048.60428,878.2406417,411.6042781,1305.229947,6503.256684,693.9037433,164.9465241,5197.625668,6112.903743,1278.417112,1496.497326,3302.86631,944.9839572,650.540107,187,18.3469654,13.47847047,0.678453831,0.916666667,0.692592593,-0.05610116
+2987,31712.11429,805.25,495.2571429,1063.707143,29508.4,667.0357143,758.5857143,1590.65,15679.20714,489.9428571,809.5571429,1755.642857,21830.87143,1211.721429,7021.257143,2664.364286,8168.464286,1264.65,333.0214286,2413.835714,15458.03571,453.7642857,741.2428571,862.5642857,19777.31429,437.8071429,126.4428571,3719.864286,15157.85,1856.157143,480.2714286,2791.935714,12623.27857,700.0214286,262.6142857,1619.678571,9328.721429,970.2785714,406.2142857,1300.942857,5541.821429,754.9071429,156.9928571,3815.535714,5470.65,1234.264286,575.3642857,3245.714286,1005.857143,648,140,15.16763256,12.01971442,0.609926258,0.939597315,0.666666667,-0.84236998
+2988,39568.98795,843.8072289,479.6626506,1110.156627,29898.83133,616.7590361,694.5662651,1553.433735,13367.90361,452.939759,1256.60241,1716.301205,20338.66265,1128.277108,7007.614458,2541.722892,7711.831325,1205.036145,302.9277108,2498.409639,14869.84337,394.8554217,1007.433735,1494.313253,18838.91566,433.4216867,116.9156627,2086.771084,14698.85542,2385.975904,385.0963855,2840.156627,11598.6506,559.8554217,258.2289157,965.0843373,7500.301205,1055.879518,376.3493976,1283.325301,3706.987952,802.0843373,153.0361446,2166.506024,4168.493976,1131.240964,1139.060241,3147.73494,1105.831325,645.1445783,83,12.00451809,9.521982241,0.608961378,0.922222222,0.628787879,1.236032226
+2989,22465.21642,1015.679104,606.4552239,1089.507463,20470.5,662.1791045,416.7014925,1460.208955,12128.02239,545.2761194,539.0970149,1741.253731,16120.40299,1257.910448,6095.08209,2140.604478,6012.947761,1540.358209,326.7238806,2350.925373,10607.06716,393.4925373,433.5223881,447.619403,12918.22388,450.7313433,135.6865672,4822.164179,9805.402985,1591.753731,579.4552239,2809.201493,8527.858209,592.5149254,271.9925373,1441.947761,6541.261194,875.4328358,423.5074627,1291.746269,4911.880597,723.1492537,165.0223881,2722.895522,4457.432836,1325.671642,519.1940299,3246.455224,332.8059701,648.9925373,134,15.09661933,11.61172322,0.639055655,0.930555556,0.644230769,-0.244658793
+2990,31354.2551,799.0204082,532.9795918,1069.05102,29075.59184,671.6938776,833.1020408,1560.479592,16122.57143,513.7755102,803.5918367,1790.622449,22206.15306,1219.173469,4864.020408,2909.132653,7885.234694,1232.255102,317.0510204,2482.306122,16397.31633,501.5408163,1334.193878,642.6938776,20222.15306,804.3061224,124.8979592,1376.255102,15440.5102,1825.010204,843.6734694,2838.857143,13395.89796,687.2959184,270.8571429,1515.22449,10327.19388,1298.071429,417.8877551,1312.122449,7246.387755,944.2142857,152.3163265,2102.316327,6427.010204,1321.591837,846.5714286,3252.479592,883.6836735,648.1428571,98,12.84012826,11.59431178,0.429693584,0.859649123,0.538461538,0.177639845
+2991,41296.3871,901.6370968,569.483871,1101.774194,38922.67742,727.3467742,679.6774194,1640.790323,21229.18548,579.2822581,528.016129,1756.024194,27106.97581,1293.758065,7328.112903,4349.862903,10083.16129,1386.362903,345.3709677,2321.201613,20933.34677,449.6048387,149.3225806,431.6370968,25076.31452,432.983871,130.3951613,4916.322581,19029.59677,1491.669355,618.1693548,2814.403226,16920.37903,610.0725806,301.9596774,2446.919355,11235.23387,836.5887097,449.1451613,1305.814516,8380.733871,643.9596774,173.2016129,4147.774194,7336.16129,1356.379032,267.8709677,3382.491935,235.5725806,648.5403226,124,17.48158102,10.32817119,0.806815821,0.815789474,0.645833333,-1.389544952
+2992,32269.91781,978.7808219,674.3972603,1117.90411,29451.21918,728.3835616,647.6027397,1647.917808,16473.90411,582.8767123,571.369863,1813.410959,20838.05479,1276.164384,7437.808219,5842.561644,7513.109589,1337.506849,333.0821918,2422.479452,15803.15068,428.6986301,171.1780822,440.8219178,18834.76712,433,130.8356164,7274.09589,14662.10959,1536.506849,1062.054795,2812.178082,12626.63014,591.4520548,290.8082192,2330.575342,8666.808219,857.6849315,438.369863,1299.657534,6682.671233,634.9452055,174.1643836,5612.205479,5956.712329,1295.506849,159.260274,3378.369863,268.4794521,646.6849315,73,13.21953466,7.758659852,0.809653125,0.924050633,0.561538462,-0.933400927
+2993,16926.14286,1176.064935,716.3246753,1071.181818,15457.55844,761.2727273,1125.454545,1519.402597,8708.350649,628.4675325,1271.428571,1824.298701,11084.7013,1274.831169,6971.727273,3114.974026,3912.753247,1300.857143,308.1038961,2455.233766,9230.831169,436.0649351,200.6233766,1075.168831,9292.935065,441.9350649,335.4285714,7768.38961,7573.467532,2104.766234,548.7662338,2814.805195,6582.532468,561.6493506,261.1688312,1294.012987,4535.571429,951.1168831,389.3636364,1316.38961,3580.753247,576.3506494,152.1818182,3667.961039,3236.545455,1153.896104,313.4285714,3622.441558,322.6103896,648.5194805,77,11.07667655,9.464339568,0.519552447,0.950617284,0.641666667,-0.182294053
+2994,34592.22059,878.2941176,539.6911765,1091.323529,31925.22059,707.8088235,777.9117647,1606.5,18024.67647,548.75,1346.102941,1852.529412,23248.14706,1313.382353,5746.426471,3764.485294,8218.029412,1386.882353,336.8529412,2469.691176,17455.27941,429.9264706,383.1323529,825.8676471,20290.58824,478.2794118,391.6764706,6212.779412,15647.94118,1841.882353,619.6029412,2810.911765,13654.54412,643.0441176,302.1617647,1583.411765,10243.89706,926.2352941,439.1323529,1330.426471,7978.294118,709.2941176,186.7647059,6428.779412,7052.529412,1375.161765,252.6911765,3261.058824,384.8235294,649,68,14.70476639,7.306792911,0.867808022,0.819277108,0.402366864,-0.778088246
+2995,39855.96537,924.2683983,568.5411255,1119.290043,35606.04329,774.1861472,853.8398268,1612.458874,21146.13853,580.7445887,1622.519481,1803.441558,27277.11255,1382.147186,4971.735931,4674.571429,9494.636364,1449.82684,370.5411255,2472.580087,20566.53247,505.2554113,291.2380952,1015.61039,24469.81385,455.1948052,233.5757576,2905.541126,18077.05628,2119.090909,794.8831169,2808.519481,16405.5671,759.8831169,319.1428571,2225.662338,12630.00433,1590.649351,472.5670996,1332.251082,9585.147186,701.2164502,182.008658,3790.497835,8700.354978,1465.757576,280.7792208,3325.545455,518.012987,652.991342,231,23.81720049,12.90697008,0.840431355,0.920318725,0.627717391,-0.300805039
+2996,34263.72024,833.0535714,483.7738095,1063.428571,30163.2619,672.3928571,840.7857143,1509.952381,17621.41667,520.1964286,1680.053571,1789.517857,23923.79762,1256.994048,3817.666667,3801.97619,8413.77381,1346.125,310.0416667,2485.375,17618.86905,461.1488095,179.5238095,2109.904762,21459.8869,848.9345238,145.3511905,1770.35119,16264.01786,1885.375,620.4761905,2801.85119,14523.33333,672.625,270.1904762,1499.285714,11131.58333,1928.375,408.9761905,1302.517857,8429.892857,708.8928571,152.1428571,2786.077381,7684.892857,1402.607143,248,3309.309524,639.4761905,649.4821429,168,15.80614131,13.69947204,0.498797931,0.954545455,0.75,-1.349824597
+2997,36218.08182,1016.318182,672.3363636,1112.172727,31350.78182,750.7545455,816.1909091,1576.263636,18767.03636,571.8,1272.309091,1775.945455,24875.60909,1353.809091,5218.154545,3932.290909,8787.309091,1302.336364,338.8181818,2520.381818,18249.36364,448.3636364,138.6090909,1334.954545,22377.26364,535.1454545,168.9818182,2895.372727,17004.12727,2126.281818,650.5454545,2792.654545,15081,598.5090909,285.9090909,1831.290909,11684.14545,1157.045455,433.2818182,1311.227273,8297.545455,622.1545455,168.5909091,2107.363636,7389.854545,1358.663636,180.5818182,3287.481818,787.5272727,650.4181818,110,13.77026828,10.6824739,0.631023553,0.887096774,0.604395604,-0.521597933
+2998,24364.88667,799.9533333,578.0466667,1083.033333,21367.26667,659.9933333,563.4,1488.093333,12343.41333,481.9933333,595.5266667,1768.926667,17222.24667,1246.826667,3602.086667,3247.046667,6236.38,1215.14,314.4133333,2404.446667,12497.68667,397.9333333,1331.98,601.38,15424.52,459.2133333,118.6466667,3552.04,11587.24,1522.193333,612.8933333,2786.106667,10190.82667,714.0533333,257.94,2077.06,7935.966667,879.9933333,403.74,1346.106667,5754.64,981.58,155.6466667,5330.82,5092.126667,1249.766667,374.1666667,3208.42,825.4,649.7266667,150,15.63733346,12.34767553,0.613585939,0.955414013,0.769230769,-0.330026016
+2999,16572.54737,750.4105263,460.9052632,1040.336842,16516.56842,608.4315789,521.0105263,1413.663158,8139.810526,468.1894737,672.1368421,1788.578947,12542.97895,1187.252632,5034.252632,2718.294737,4359.452632,1214.052632,307.0105263,2456.494737,9043.231579,429.9578947,820.7263158,618.0631579,11313.87368,425.1578947,120.8210526,1488,8248.147368,1618.526316,635.2105263,2816.052632,7238.378947,1191.978947,252.8842105,1804.673684,5798.842105,1122.231579,390.4210526,1300.368421,4252.610526,810.9473684,155.5789474,2865.284211,3716.210526,1281.831579,2153.778947,3156.315789,874.6631579,649.9473684,95,13.58013766,9.276690152,0.730318095,0.969387755,0.753968254,-0.085487036
+3000,46446.51852,973.7037037,526.7530864,1138.259259,37427.50617,733.0246914,608.0123457,1802.382716,20086.41975,505.5925926,1027.691358,1798.888889,27107.77778,1263,6584.148148,3300.395062,10349.81481,1307.382716,331.7654321,2433.024691,19680.54321,473.5185185,340.2345679,904.345679,24445.8642,453.4938272,135.4938272,3529.790123,18942.32099,1915.506173,404.8888889,2814.814815,15262.62963,638.5308642,279.4938272,1246.753086,10705.67901,980.2098765,418.2222222,1298.123457,5839.493827,696.2592593,151.3333333,2717.91358,6143.604938,1232.765432,249.0864198,3380.555556,1053.061728,648.8641975,81,14.97560581,7.260063405,0.874629122,0.952941176,0.525974026,0.915341344
+3001,44334.08182,892.1,531.8363636,1120.181818,29507.69091,609.9727273,619.1818182,1619.536364,11558.21818,437.2545455,1368.018182,1696.945455,18356.63636,1057.2,5532.445455,3107.172727,6799.7,1099.827273,282.6454545,2354.927273,12671.3,338.9454545,518.7636364,1202.154545,15508.57273,443.1272727,195.3727273,2114.027273,11678.89091,2813.718182,361.4636364,2891.645455,9289.054545,529.2090909,229.3363636,818.6727273,5195.863636,1092.809091,362.8636364,1276.1,2491.327273,653.5363636,137.3090909,1567.845455,2830.327273,991.8818182,190.8636364,3023.109091,1130.5,651,110,16.90509772,8.719853954,0.856701744,0.909090909,0.491071429,-0.715651026
+3002,30241.26271,1034.228814,588.6949153,1089.915254,27340.63559,747.9067797,513.5254237,1563.516949,15746.52542,584.1694915,608.2457627,1796.389831,20191.44915,1331.550847,7237.322034,2784.415254,7148.779661,1369.610169,342.2118644,2365.279661,14482.73729,597.9576271,375.3389831,477.7711864,17037,451.3813559,129.2542373,7174.720339,13467.86441,1556.432203,606.6016949,2807.389831,11633.27966,607,293.1355932,1408.949153,8467.423729,865.5423729,431.1186441,1325.110169,6530.101695,706.3983051,165.9745763,4910.525424,5817.118644,1302.915254,245.7711864,3423.016949,392.0762712,652.8728814,118,15.79505794,10.54104711,0.744732028,0.861313869,0.533936652,-0.052873581
+3003,22036.90476,1071.928571,557.4206349,1047.301587,19993.47619,734.7777778,508.8650794,1458.706349,11579.79365,576.7460317,580.5634921,1742.634921,15038.96032,1289.793651,3601.896825,2220.706349,5512.444444,1344.111111,313.3015873,2372.150794,11265.6746,405.7619048,282.6746032,491.4206349,13217.77778,406.7142857,123.3809524,2819.539683,10313.7619,1603.65873,620.7142857,2787.174603,8950.666667,742.4206349,270.1666667,1660.936508,6836.611111,905.5079365,441.1428571,1397.634921,5328.515873,647.3253968,166.7539683,4513.738095,4820.769841,1289.936508,167.2142857,3299.079365,402.2460317,649.0238095,126,13.5559697,12.04835554,0.458322503,0.976744186,0.807692308,-1.032975363
+3004,32121.4433,1023.113402,621.8247423,1100.670103,29572.65979,807.8865979,728.5979381,1553.103093,17339.10309,595.9381443,797.5773196,1765.28866,22740.91753,1398.71134,4800.020619,4312.515464,7708.123711,1416.28866,351.2886598,2500.618557,16730.34021,524.1030928,132.1237113,586.1134021,20189.61856,938.5257732,138.7835052,3276.804124,15131.53608,1602.525773,712.4948454,2802.731959,13629.1134,647.628866,299.7835052,2289.649485,10733.98969,1046.309278,462.5463918,1331.443299,7957.42268,647.5360825,176.8969072,4878.494845,7432.381443,1434.886598,197.5257732,3357.216495,554.7731959,650.1649485,97,13.30022934,9.914592183,0.666566911,0.906542056,0.621794872,-0.905814756
+3005,43356.01418,916.5460993,608.929078,1117.957447,37036.1773,726.2340426,851.4964539,1631.87234,22096.86525,562.3333333,1815.489362,1797.042553,30176.75177,1340.432624,3770.567376,3987.64539,10881.9078,1333.680851,343.9787234,2613.304965,22626.43972,465.5673759,138.106383,1370.978723,27934.07092,763.8297872,245.4893617,2870.319149,20811.91489,2025.177305,580.5248227,2809.453901,18562.66667,828.4113475,295.4822695,1834.453901,14550.70922,1313.304965,434.8014184,1304.425532,10221.95035,647.7092199,162.3262411,2610.539007,9378.702128,1425.41844,675.2269504,3281.219858,771.0567376,650.035461,141,15.01926989,12.8998699,0.512163541,0.892405063,0.626666667,-0.331040485
+3006,33661.85577,1071.355769,1219.105769,1233.807692,31925.96154,807.9903846,826.9615385,1872.990385,17666.33654,595.3365385,835.3653846,1754.057692,24022.39423,1549.980769,1632.442308,1658.201923,8367.336538,1520.096154,381.3942308,2431.567308,17924.875,501.4519231,192,781.0384615,22104.73077,547.7980769,137.7884615,1094.394231,16178.53846,1693.230769,516.5288462,2807.413462,14450.14423,660.875,320.3076923,2378.230769,11260.53846,1282.567308,485.6634615,1301.105769,8402.394231,689.1538462,186.3557692,1324.115385,7201.153846,1627.682692,232.2211538,3394.076923,801.9711538,649.8076923,104,13.01815897,10.22437734,0.618996819,0.971962617,0.727272727,-0.466609187
+3007,23939.11728,851.6296296,481.8641975,1070.209877,20896.7963,698.0617284,572.308642,1501.549383,12582.51852,510.4135802,534.1481481,1739.098765,17226.90123,1279.049383,3500.401235,3117.753086,6296.320988,1268.358025,328.1666667,2343.765432,12374.03086,421.7839506,562.8271605,551.8271605,14941.23457,458.1049383,137.4691358,2529.024691,11737.80247,1462.419753,656.1666667,2783.895062,10362.46914,813.1234568,271.3271605,1893.469136,7916.388889,866.9938272,406.654321,1313.290123,5493.54321,744.9382716,162.9012346,3352.487654,5154.469136,1359.753086,1350.691358,3174.487654,860.3333333,651.462963,162,20.35961263,10.48608854,0.85716397,0.870967742,0.532894737,1.112755508
+3008,33833.98962,837.9446367,526.2525952,1079.131488,31183.32526,683.9377163,712.5709343,1570.16609,17244.72318,501.4982699,1561.041522,1803.820069,24093.04844,1227.027682,5077.525952,3705.685121,8595.615917,1271.456747,318.283737,2603.740484,16579.44983,413.1557093,261.0968858,1469.051903,20021.70242,435.0519031,129.4878893,3140.044983,15557.28028,1977.847751,526.8546713,2788.055363,13110.20069,747.2179931,262.982699,1477.304498,9707.820069,1302.896194,406.3633218,1294.086505,6232.795848,635.1522491,167.3702422,3975.647059,5776.051903,1235.737024,1064.252595,3269.871972,964.7128028,654.3806228,289,22.62654652,16.37620968,0.690050838,0.941368078,0.69138756,-0.502443391
+3009,42263.7037,873.6234568,545.308642,1120.037037,28050.32716,616.5432099,686.8148148,1609.728395,11639.05556,451.2222222,3166.87037,1798.537037,17761.57407,1091.462963,7979.240741,4451.67284,6724.098765,1153.345679,295.4444444,3024.154321,12580.00617,367.5679012,1617.166667,1348.907407,15523.62346,663.537037,115.5246914,1724.679012,11964.98765,3226,374.882716,2832.833333,9364.987654,540.4382716,244.6481481,913.4320988,5672.907407,1570.055556,359.3580247,1302.395062,2725.814815,922.8395062,140.2037037,3096.537037,3075.012346,1051.382716,269.3580247,3122.469136,1115.882716,651.3641975,162,14.9296063,14.35868857,0.273895851,0.931034483,0.675,1.151813845
+3010,57015.6747,933.1686747,594.9759036,1159.73494,54387.12048,786.8433735,682.2168675,1821.325301,27580.3012,602.5783133,552.5783133,1759.951807,37721.06024,1417.927711,5294,5038.457831,13841.61446,1499.493976,387.4698795,2903.626506,28519.86747,487.9277108,142.1686747,494.5060241,34098.42169,470.1445783,144.6506024,4391.590361,25638.60241,1735.289157,585.5783133,2815.325301,22051.85542,658.3975904,351.626506,5698.26506,13769.03614,922.253012,493.5662651,1333.53012,9306.120482,678.3493976,189.6144578,3223.048193,8478.53012,1472.301205,191.9879518,3311.710843,162.5060241,651.1325301,83,12.95890478,8.8373317,0.731398321,0.892473118,0.709401709,-0.206607881
+3011,32680.09474,904.3894737,531.7789474,1059.621053,30057.56842,699.3894737,507.6631579,1557.663158,17188.29474,552.0421053,709.4631579,1771.726316,21763.56842,1251.694737,6987.652632,2834.094737,8032.673684,1345.978947,326.4842105,2574.136842,16472.6,432.9473684,146.9578947,564.6736842,19658.25263,431.4315789,123.4842105,3414.357895,15181.16842,1616.757895,557.7894737,2806.631579,13106.36842,593.9157895,288.3368421,1600.084211,9013.494737,850.9263158,431.8526316,1290.273684,6773.631579,634.1789474,165.9684211,2364.526316,6072.263158,1281.336842,155.6842105,3426.147368,258.4105263,649.8947368,95,12.46051044,10.05295403,0.590845005,0.931372549,0.71969697,0.601097364
+3012,24227.95431,901.4010152,503.9086294,1041.832487,21053.69543,676.8527919,720.8527919,1437.84264,12199.10152,536.0812183,1285.893401,1768.411168,16135.62437,1255.304569,2790.48731,4047.568528,5448.365482,1412.263959,301.8172589,2662.80203,11789.98477,422.6395939,898.0253807,813.5685279,13962.43147,1353.761421,117.6700508,1403.187817,10769.35533,1585.563452,779.3756345,2797.847716,9613.167513,761.9441624,270.4111675,1568.705584,7340.025381,1320.649746,416.177665,1330.233503,5673.350254,824.8020305,157.786802,2851.126904,5334.979695,1297.203046,726.6395939,3288.553299,582.964467,653.319797,197,21.05277561,13.84604451,0.753295147,0.804081633,0.579411765,0.108460413
+3013,29173.81959,918.5979381,504.371134,1056.469072,26388.60309,832.5154639,831.2010309,1479.262887,14658.6701,518.1494845,1428.07732,1845.463918,19755.53093,1265.979381,2643.010309,2961.623711,7223.716495,1258.479381,307.3041237,2474.984536,15098.63918,693.3762887,106.1237113,1560.195876,18464.15464,459.0824742,343.0876289,1445.85567,13732.07216,1791.134021,593.2989691,2802.128866,12284.79897,838.0773196,257.7835052,1554.510309,9863.927835,1283.319588,405.3917526,1284.474227,7386.819588,600.5979381,161.685567,2581.365979,6553.938144,1345.572165,1359.180412,3271.097938,681.4123711,655.2628866,194,19.63783685,14.7240231,0.661689175,0.788617886,0.510526316,0.470265587
+3014,35576.34667,887.8666667,520.9466667,1076.086667,21733.16,643.8333333,591.6266667,1392.22,12169.27333,617.4466667,1419.926667,1771.706667,16658.59333,1167.806667,3336.793333,2879.966667,5987.373333,1224.533333,303.9533333,2677.826667,12637.54667,375.0533333,1135.313333,1171.966667,15740.53333,419.4466667,260.0066667,1413.006667,11346.57333,2200.726667,562.6133333,2788.88,10030.52667,715.0333333,252.1133333,1398.533333,8061.413333,1252.86,380.98,1354.513333,5836.28,875.04,153.8733333,3049.673333,5272.633333,1225.02,547.64,3169.286667,738.72,652.24,150,15.37173706,12.47238416,0.584513237,0.9375,0.666666667,-0.842921278
+3015,42182.20661,893.7272727,599.6694215,1119.900826,36266.4876,703.9586777,1010.446281,1632.53719,21558.96694,530.7190083,1743.363636,1786.264463,29372.87603,1380.628099,3343.719008,4402.727273,10621.44628,1323.975207,341.2066116,2527.421488,21492.80165,449.7768595,528.0661157,1238.983471,26613.1157,1123.909091,128.1570248,1655.669421,19908.28099,1766.140496,570.9090909,2802.933884,17781.95868,733.0743802,292.677686,1733.694215,13900.49587,1984.578512,438.661157,1319.264463,9727.661157,743.6363636,167.5785124,3893.933884,8517.504132,1388.099174,344.553719,3272.173554,813.0082645,651.2892562,121,14.54661861,11.38136313,0.622768573,0.846153846,0.617346939,0.520278789
+3016,24571.54167,816.5952381,947.7380952,1084.922619,22597.35714,662.202381,760,1546.392857,12678.81548,476.8452381,1610,1857.85119,17792.53571,1191.392857,7345.940476,3953.482143,6435.732143,1215.64881,314.547619,2577.470238,12485.51786,411.4047619,1517.27381,1692.642857,15517.8631,441.1071429,205.452381,2208.517857,12074.38095,3163.928571,2531.779762,2810.255952,10395.25,660.9821429,256.1964286,1489.821429,7992.928571,1525.97619,395.547619,1336.339286,5478.458333,943.5178571,166.5654762,11645.95238,5021.583333,1238.505952,327.577381,3244.892857,900.5952381,653.0892857,168,17.17026883,12.70375468,0.672750643,0.971098266,0.666666667,-0.222012516
+3017,57040.79412,999.7529412,602.6058824,1193.217647,55084.00588,818.7882353,719.7764706,1861.952941,27074.12941,614.6823529,717.4588235,1817.470588,37486.5,1452.194118,6777.570588,6114.958824,13507.80588,1518.547059,384.0058824,2448.717647,27824.29412,492.1647059,141.8294118,584.3647059,33577.14706,833.4,142.5058824,5140.817647,24850.48235,1615.658824,570.2117647,2821.988235,21405.27059,658.9823529,343.9,4875.035294,12299.02941,957.0882353,476.4117647,1316.570588,8251.911765,669.5235294,177.1058824,3609.394118,7569.570588,1439.758824,175.4411765,3376.582353,151.7058824,655.3764706,170,21.62908579,10.42458919,0.876187243,0.899470899,0.596491228,-0.52561593
+3018,36384.01563,1037.3125,639.9375,1104.328125,32499.60938,765.234375,554.9375,1627.65625,19055.78125,612.25,538.453125,1736.34375,23624.1875,1300.421875,5638.40625,5290.5,8500.9375,1393.234375,339.0625,2359.453125,17480.6875,427.484375,352.53125,430.578125,20875.625,446.71875,128.078125,4469.09375,16441.5625,1512.296875,779.921875,2817.515625,14191.03125,642.515625,301.1875,1845.625,9509.1875,828.625,437.078125,1303.421875,7081.703125,667.34375,169.453125,4154.921875,6446.71875,1295.828125,153.125,3460.34375,273.265625,651.421875,64,11.9937266,7.012414694,0.811268662,0.984615385,0.581818182,-0.680154073
+3019,37152.34109,985.1317829,690.875969,1128.790698,20133.31008,588.9534884,403.4263566,1533.372093,10884.31783,462.4031008,587.9612403,1770.333333,14154.17054,1124.899225,8886.666667,3160.069767,5186.914729,1262.193798,294.6046512,2383.054264,10913.85271,369.0542636,276.6589147,539.255814,12203.1938,421.5116279,119.8914729,7896.186047,9242.922481,1413.968992,632.6821705,2806.860465,8254.829457,544.3488372,262.3410853,1395.565891,6074.116279,843.1782946,392.2325581,1287.658915,4734.302326,639.372093,152.0930233,4561.162791,4163.968992,1237.209302,183.1007752,3259.286822,370.5736434,652.9224806,129,14.81266816,11.44310167,0.63498885,0.921428571,0.575892857,-0.843235094
+3020,33613.36986,1062.616438,576.890411,1111.712329,29974.69863,794.2328767,1198.30137,1591.136986,17072.72603,615.7123288,1480.219178,1851.150685,22449.57534,1425.191781,4439.863014,4180.575342,7811.452055,1433.30137,354.2465753,2411.808219,16755.72603,460.7260274,183.0547945,1153.383562,19020.72603,484.3150685,133.6575342,3191.356164,14406.46575,2088.575342,738.4657534,2827.917808,12693.28767,863.5753425,317.2191781,2204.534247,9669.123288,1796.506849,464.6849315,1326.808219,7408.178082,677.0684932,172.7534247,4098.09589,6381.246575,1399.30137,1070.917808,3404.753425,454.4383562,650.5205479,73,11.06305359,8.553229145,0.634242021,0.924050633,0.73,-0.731322177
+3021,34081.59701,892.6716418,594.6268657,1109.253731,31338.23881,721.2537313,883.9552239,1589,18496.28358,572.3731343,1604.507463,1795.656716,24559.40299,1354.835821,4325.208955,4891.537313,8710.865672,1425.059701,345.358209,2453.044776,18306.50746,463.0447761,133.9253731,797.9701493,21617.95522,2031.283582,131.3283582,4337.761194,15998.43284,1628.641791,807.5970149,2796.149254,14428.49254,651.7164179,305.1641791,2072.835821,11247.46269,1535.940299,459.6716418,1330.791045,8392.447761,673.1492537,182.1044776,5717.567164,7720.641791,1437.865672,605,3387.014925,499.0597015,650.3432836,67,11.41972685,8.86075528,0.630835539,0.817073171,0.609090909,-1.429146518
+3022,41116.68391,993.2931034,556.8448276,1117.683908,25677.4023,576.3045977,586.1206897,1504.994253,10758.71839,416.7126437,1871.643678,1754.063218,16606.8908,1007.614943,6949.557471,3708.275862,6353.603448,1071.591954,283.2126437,2554.114943,11888.77586,346.4655172,382.8908046,1838.367816,14813.77011,537.3793103,201.8448276,1875.356322,11483.2931,2828.770115,373.2183908,2812.155172,8918.856322,524.7126437,222.9137931,897.5344828,5807.597701,1281.965517,349.2528736,1274.183908,2869.735632,608.5632184,141.545977,2278.321839,3120.902299,996.1724138,438.4655172,3030.977011,1099.074713,654.316092,174,15.94912521,14.81633134,0.370143613,0.883248731,0.537037037,-1.036465677
+3023,18547.75159,882.8089172,478.7452229,1056.834395,17382.92357,716.910828,630.7515924,1487.828025,9849,536.2866242,433.4203822,1707.101911,12702.52229,1317.006369,1733.235669,1544.280255,4427.566879,1297.726115,328.7452229,2339.528662,8875.070064,424.4968153,188.7643312,447.8407643,10045.81529,451.7261146,124.6942675,1288.719745,7770.55414,1391.751592,651.0828025,2807.11465,6864.369427,757.7006369,287.1082803,1663.980892,5374.636943,926.5477707,437.3757962,1322.515924,4299.038217,871.9681529,179.2993631,3316.859873,3851.394904,1486.636943,6710.178344,3201.808917,432.4585987,653.6496815,157,16.453419,12.24931027,0.667640094,0.951515152,0.747619048,-0.502506774
+3024,24442.36207,1322.241379,603.3965517,1103.448276,23615.12069,840.2931034,713.0689655,1524.672414,12259,669.0172414,679.8448276,1714.275862,16344.34483,1408.586207,6465.534483,2937.137931,5264.844828,1295.913793,319.2758621,2420.534483,13104.48276,428,151.4827586,550.0689655,13413.2069,710.6724138,125.1724138,3222.827586,9790.137931,1509.172414,649.0689655,2803.827586,8669.086207,587.7586207,275.3448276,1554.465517,6466.137931,961.6206897,406.1034483,1320.086207,5430.62069,598.6724138,161.9137931,2599.275862,4345.017241,1206.5,222.5,3472.448276,463.5862069,650.6034483,58,11.83740767,6.432631831,0.839463817,0.892307692,0.604166667,-1.026808211
+3025,38746.24576,866.3728814,520.940678,1143.576271,37900.27119,752.2542373,688.5423729,1794.694915,19088.44915,507.3559322,574.1101695,1811.652542,27130.13559,1246.601695,5355.550847,3037.194915,10334.44068,1358.576271,343.7966102,2424.152542,19400.05085,532.9830508,2019.305085,618.5,24741.66102,467.6525424,136.4745763,3144.29661,18608.24576,1757.177966,445.9322034,2809.415254,15141.17797,678.8559322,280.5254237,1500.008475,11083.81356,864.7542373,418.6101695,1337.355932,6084.474576,1122.90678,164.4237288,3436.491525,6181.830508,1268.194915,364.0169492,3311.432203,1041.059322,652.9576271,118,17.96678957,10.14259096,0.825420193,0.802721088,0.491666667,-0.847765539
+3026,41115.64912,890.5789474,544.622807,1131.280702,26974.30702,696.7280702,517.5175439,1638.105263,13374.99123,487.5526316,1031.236842,1728.324561,19368.82456,1220.982456,5894.72807,3172.885965,7175.947368,1211.710526,319.7368421,2335.035088,14047.2807,414.4122807,1609.736842,863.5087719,17475.57895,417.7105263,144.7017544,4852.692982,13705.35088,2042.614035,409.5087719,2817.096491,11007.13158,628.1140351,254.7017544,1432.078947,7571.149123,949.1754386,397.6315789,1313.087719,3967.315789,977.2017544,158.7982456,3800.587719,4418.22807,1177.54386,1732.421053,3320.157895,1068.675439,651.9736842,114,13.59571357,10.7989789,0.607534996,0.982758621,0.690909091,-1.564678824
+3027,41678.91743,890.9266055,590.0917431,1145.431193,39361.63303,730.7981651,588.3394495,1710.651376,21439.44037,573.853211,511.1009174,1793.192661,27161.80734,1313.293578,6572.788991,7856.46789,10416.10092,1409.40367,346.293578,2353.376147,20732.77982,451.6605505,134.8165138,436.8715596,25221.44954,428.5045872,132.4311927,5361.761468,18782.30275,1496.366972,709.3577982,2808.93578,16784.05505,629.146789,308.8073394,3249.46789,10741.69725,836.559633,441.5504587,1293.40367,7936.422018,637.7431193,172.8348624,3806.412844,6918.899083,1368.981651,220.1100917,3270.779817,220.6972477,653.1926606,109,12.93716473,11.06281383,0.518431962,0.96460177,0.698717949,-0.239575848
+3028,34875.32609,908.1702899,582.1376812,1100.057971,32432.15942,738.0362319,696.0797101,1581.108696,18414.16667,557.3115942,629.6557971,1796.050725,24365.37681,1331.445652,5096.253623,4716.01087,8626.75,1413.518116,341.1557971,2423.315217,18689.52536,822.1231884,153.6956522,513.5724638,21575.6558,475.6086957,138.7101449,3869.652174,16053.27536,1571.235507,860.1992754,2812.826087,14339.49638,705.4855072,302.4818841,2205.677536,11195.06159,898.1231884,452.8949275,1318.065217,8465.550725,653.8007246,176.4963768,5029.666667,7666.289855,1415.992754,272.4601449,3335.467391,473.423913,657.8586957,276,22.11544361,16.72287284,0.654383694,0.878980892,0.69,-0.68139407
+3029,27690.95076,884.7954545,484.5871212,1068.590909,24615.13636,699.6212121,684.4393939,1494.227273,14449.15909,557.0378788,593.2234848,1744.329545,18606.44697,1315.545455,2943.818182,3076.340909,6498.367424,1507.098485,325.1931818,2406.484848,13967.64773,477.8977273,819.5113636,502.4886364,16762.09848,499.8295455,124.0984848,1656.969697,12515.53788,1561.575758,790.4962121,2810.356061,11185.68561,734.2007576,293.5719697,1693.693182,8757.583333,930.2348485,442.3030303,1334.534091,6536.189394,837.1780303,168.2878788,3294.409091,6075.462121,1394.026515,427.2916667,3253.818182,569.4166667,658.1136364,264,19.80707323,17.74819684,0.44394613,0.942857143,0.666666667,0.165656137
+3030,33832.88811,858.6223776,553.5664336,1089.797203,33369.99301,701.6013986,660.1958042,1695.06993,16560.46853,507.5804196,588.2447552,1800.482517,23530.13287,1216.692308,7219.216783,3732.412587,8803.300699,1308.440559,331.1748252,2424.797203,16984.6014,478.2727273,2663.076923,714.7972028,21582.52448,451.4125874,135.6783217,3937.993007,16336.13986,2162.062937,485.5594406,2793.503497,13451.46154,750.0909091,273.4055944,1590.293706,9767.398601,1033.286713,414.6013986,1348.447552,5521.097902,1496.328671,160.8181818,4235.482517,5607.706294,1271.559441,646.8391608,3278.132867,1029.734266,654.5734266,143,16.44901639,11.56150106,0.711319474,0.916666667,0.733333333,-0.496112716
+3031,43418.81579,968.9144737,553.9013158,1097.927632,42140.91447,755.1776316,643.1842105,1679.177632,22831.61184,609.4605263,780.6842105,1770.671053,28461.48684,1339.098684,7656.125,5254.782895,10197.91447,1428.111842,355.0328947,2392.085526,22326.06579,448.2434211,307.7105263,668.6907895,26592.76316,560.7171053,139.1118421,5427.901316,20509.16447,1739.572368,645.3815789,2814.111842,17676.02632,667.2828947,324.5592105,1705.381579,12110.78947,981.9868421,458.375,1310.901316,9308,688.4934211,177.8552632,4127.210526,8169.151316,1381.25,200.0065789,3393.848684,278.1776316,657.9671053,152,21.12301835,10.25111743,0.874344641,0.826086957,0.444444444,-0.79085566
+3032,31813.78824,870.1647059,518.9294118,1087.047059,29347.59412,745.6882353,732.8823529,1546.241176,16761.92941,545.7705882,1245.429412,1767.017647,22008.87647,1309.111765,4078.117647,2969.423529,7634.629412,1426.035294,387.7,2435.458824,17449.79412,473.0588235,518.3352941,1039.047059,19807.40588,530.0941176,226.5294118,2749.3,14557.89412,1832.323529,742.3882353,2814.782353,13164.24118,734.0235294,295.7,1578.317647,10181.02353,1119.476471,452.6882353,1346.758824,7847.882353,746.5882353,171.7352941,3673.347059,7025.052941,1403.211765,266.6529412,3282.447059,507.4411765,659.6352941,170,22.84740404,10.80744349,0.881047826,0.813397129,0.527950311,0.244806347
+3033,26938.92,998.464,534.192,1054.888,22643.712,711.232,730.072,1456.848,13253.528,586.272,1346.312,1731.832,17180.136,1290.096,4792.6,2959.92,6196.688,1257.504,304.896,2363.328,12935.448,424.32,283.344,1564.84,15640.712,1472.32,117.544,1764.856,11587.616,1599.816,843.312,2798.704,10235.36,644.68,266.52,1476.248,7879.568,1270.04,390.648,1301.184,5953.168,654.656,152.872,3116.504,5192.168,1266.992,706.128,3322.056,601.288,654.952,125,14.21911735,11.70182609,0.568093078,0.932835821,0.641025641,-0.107285039
+3034,28456.61688,878.4220779,497.5064935,1058.487013,25209.96104,659.9025974,630.8636364,1457.564935,14474.82468,511.2337662,969.1948052,1740.798701,19651.99351,1263.831169,3661.525974,2912.292208,6979.545455,1281.292208,311.0844156,2452.616883,14913,507.2727273,133.7207792,944.7012987,18242.61688,995.525974,121.8506494,2147,13690.27922,1555.454545,605.2077922,2784.948052,12082.48701,1415.967532,264.7077922,1588.409091,9669.824675,1198.584416,395.0064935,1286.220779,7254.012987,615.7727273,155.2337662,2447.727273,6627.935065,1346.12987,1829.850649,3245.032468,669.9675325,657.0779221,154,18.69331209,10.68336926,0.820596797,0.944785276,0.647058824,0.417460256
+3035,26517.90741,749.1481481,488.2777778,1040.018519,24427.44444,615.5925926,759.4074074,1445.333333,13485.27778,454.7407407,1708.796296,1802.796296,19107.61111,1142.055556,3901.185185,3689.814815,6973.555556,1209.796296,309.1481481,2611.037037,13450.7037,428.1851852,259.6851852,2359.777778,16678.55556,513.8333333,118.2962963,2288.518519,12981.09259,2290.222222,645.7407407,2795,11167.48148,617.9814815,242.4259259,1429.222222,8272.148148,1302.5,395.2407407,1302.37037,5792.111111,630.5,149.8518519,4798.12963,5184.518519,1179.092593,289.4814815,3133.296296,911.0925926,652.5,54,9.099191523,8.12135631,0.450976085,0.964285714,0.75,1.343052875
+3036,22153.56897,738.4137931,450.6810345,1032.586207,20868.72414,597.4741379,996.2586207,1498.974138,10857.12931,459.7586207,1013.465517,1797.724138,15387.44828,1124.284483,6826.827586,2725.982759,5833.215517,1164.706897,295.3534483,2531.353448,10897.86207,590.6982759,717.1465517,1609.37069,13751.99138,458.25,122.5689655,2346.698276,10678.75862,2212.068966,425.3103448,2839.034483,8782.844828,886.6982759,242.3965517,1391.396552,6572.517241,1043.508621,389.0086207,1285.008621,3839.844828,732.9913793,153.9396552,3190.482759,3919.862069,1156.284483,779.0086207,3127.284483,1016.025862,654.9051724,116,12.66141032,11.89970908,0.341612951,0.950819672,0.637362637,1.205210794
+3037,23721.6194,914.1119403,557.7238806,1403.873134,14802.55224,594.858209,435.8731343,2034.656716,8200.104478,480.7164179,456.6791045,1780.925373,10665.61194,1157.80597,2633.880597,1410.052239,3695.708955,1508.679104,298.2313433,2338.746269,8391.462687,368.7910448,147.4850746,406.1044776,8937.544776,375.9402985,118.141791,1732.074627,6837.597015,1387.208955,542.619403,2813.067164,5922.977612,606.261194,245.5746269,1125.835821,4468.514925,835.9029851,395.6492537,1287.440299,3447.134328,582.5149254,155.2164179,2240.410448,3121.589552,1204.985075,334.4104478,3256.11194,347.9253731,657.8955224,134,13.5312612,13.02291973,0.271522579,0.95035461,0.598214286,0.088521529
+3038,31036.71478,820.9175258,424.3333333,1059.323024,29321.47423,687.2542955,717.7182131,1518.436426,16162.91065,528.3402062,1335.357388,1778.769759,21797.66667,1270.264605,2849.154639,2811.357388,7586.072165,1311.030928,324.3883162,2369.274914,16679.2268,459.8316151,372.6872852,1015.652921,20781.2268,700.6116838,212.7800687,1180.66323,15149.16151,1698.219931,597.8281787,2793.281787,13488.00344,614.3367698,279.0927835,1519.718213,10584.08247,1269.206186,410.6563574,1287.491409,7900.367698,719.6563574,156.8900344,2029.32646,6979.213058,1360.467354,613.8075601,3136.890034,711.5910653,661.4707904,291,26.89838394,15.57469594,0.815313506,0.829059829,0.529090909,-0.559802208
+3039,32926.64052,850.1568627,486.4183007,1084.169935,29395.15686,690.7124183,546.4575163,1517.457516,17162.67974,526.0457516,821.7973856,1744.392157,23325.39216,1273.045752,3655.973856,4331.320261,8557.431373,1314.48366,335.9281046,2441.575163,17324.27451,419.4117647,1180.359477,651.9150327,21582.98693,470.3529412,125.9477124,2484.816993,16044.88889,1632.856209,691.3137255,2790.54902,14239.50327,678.5098039,272.8627451,1695.993464,11011.9281,1143.647059,426.5359477,1328.222222,7650.379085,940.7843137,168.2679739,3508.339869,6954.986928,1342.281046,582.7189542,3241.627451,839.5424837,655.2875817,153,15.78447841,12.75951807,0.588690459,0.950310559,0.683035714,1.353085304
+3040,47776.34,894.205,580.9,1136.365,44696.6,745.38,719.085,1745.805,23173.025,574.35,770.725,1767.765,30223.55,1336.865,7769.87,6812.72,11336.735,1440.58,363.45,2817.23,22743.415,461.56,138.62,647.245,28178.245,447.27,136.66,4831.155,20702.99,1753.81,800.625,2832.08,18038.28,640.73,323.08,3655.375,11459.905,953.875,461.205,1318.58,8174.86,644.575,171.795,3318.92,7050.045,1398.04,223.435,3351.435,186.745,657.135,200,21.55607414,12.74690817,0.806424414,0.896860987,0.680272109,-1.467308572
+3041,23673.20536,767.8214286,491.1339286,1057.25,23075.76786,643.6875,493.7767857,1473.642857,12621.07143,507.9017857,604.7857143,1732.526786,16215.51786,1178.660714,3033.821429,2611.491071,5925.982143,1333.25,325.25,2388.866071,12964.21429,396.8214286,1014.955357,493.6071429,15197.61607,464.7767857,124.7053571,2950.366071,11819.875,1713.401786,549.0357143,2816.758929,10294.5625,665.9642857,274.9642857,1469.196429,7320.294643,967.7946429,429.2946429,1352.696429,5755.535714,851.9910714,170.2410714,4057.142857,5036.982143,1295.678571,234.5357143,3221.25,303.3928571,656.6160714,112,15.72922844,9.49695414,0.797152894,0.933333333,0.662721893,-0.853863213
+3042,32791.7217,853.8679245,545.5,1092.042453,29832.2783,699.75,817.9150943,1544.646226,17582.56604,546.9056604,1022.216981,1796.169811,22564.97642,1283.693396,4589.792453,4656.061321,7849.896226,1393.080189,338.1226415,2576.438679,17249.99057,469.5943396,294.0424528,723.1273585,20289.1934,431.1037736,135.5849057,2234.268868,15229.64623,1733.301887,806.3632075,2814.990566,13925.25,728.2641509,347.6698113,2011.679245,10708.83491,1386.825472,447.8726415,1318.721698,8032.778302,697.9292453,173.2264151,3204.103774,7355.778302,1404.70283,273.3018868,3296.834906,533.240566,656.7830189,212,21.26758047,13.28822085,0.780775934,0.898305085,0.721088435,1.560650181
+3043,31410.77451,1277.392157,575.9607843,1059.833333,28647.53922,841.2058824,596.1666667,1430.656863,14649.71569,624.3137255,1097.77451,1733.068627,20147.42157,1313.176471,3473.147059,1985.352941,6720.588235,1187.990196,293.9215686,2364.009804,14122.60784,393.0098039,119.1372549,694.2745098,17432.16667,455.5098039,232.9313725,2353.539216,11914.26471,1626.029412,542.4901961,2783.137255,10267.52941,559.3235294,245.8235294,1392.352941,7991.352941,820,381.3823529,1271.411765,6042.284314,568.4313725,146.4019608,1411.098039,4936.539216,1130.284314,248.1078431,3532.176471,761.9215686,657.1764706,102,12.69174453,10.45857308,0.566523838,0.935779817,0.653846154,-0.013923313
+3044,37083.41071,844.1607143,501.4285714,1097.607143,31372.67857,684.1785714,998.1428571,1543.517857,18762.51786,533.4107143,2231.839286,1824.089286,25362.46429,1280.785714,3034,4602.035714,9350.071429,1293.910714,331.3392857,2737.375,18968.28571,433.7321429,304.5178571,1268.25,23375.71429,533.1428571,136.875,2161.696429,17407.75,2055.142857,580.125,2850.982143,15530.28571,613.4464286,281.1428571,2228.982143,12340.55357,1275.482143,412.2678571,1312.428571,8477.160714,677.0535714,160.4821429,3551.375,7754.035714,1334.446429,271.3035714,3196.428571,777.9285714,655.7321429,56,11.16641493,6.682291103,0.801176875,0.903225806,0.56,-0.725877377
+3045,40226.64623,878.0990566,558.1084906,1115.372642,37340.39151,734.9009434,850.0377358,1681.646226,20206.68868,521.5141509,2032.150943,1837.320755,28136.98585,1293.391509,6515.731132,4605.669811,10178.82547,1341.415094,342.3160377,2708.966981,19903.35849,434.6650943,254.6933962,1265.627358,23955.74528,460.995283,400.7924528,2774.245283,19065.90094,2401.240566,549.995283,2808.735849,15808.22642,696.3537736,289.4198113,1497.080189,11694.86792,1488.849057,429.3066038,1302.099057,7395.051887,644.7075472,164.7971698,3639.466981,6872.457547,1319.018868,856.3301887,3311.693396,978.4622642,660.3584906,212,19.31463216,15.0583115,0.62623753,0.861788618,0.587257618,-0.330566402
+3046,25027.36066,982.6885246,565.557377,1092.57377,22620.54098,643.5737705,612.6557377,1446.393443,12430.93443,496.8852459,558.7868852,1780.344262,16298.16393,1181.016393,6821.901639,3254.934426,5861.868852,1306.967213,305.4918033,2377.098361,12607.68852,389,192.7377049,536.1803279,14087.7541,378.1803279,124.3934426,3181.57377,10830.90164,1562.885246,580.4918033,2780.606557,9525.213115,1196.606557,266.557377,1612.47541,7225.311475,825.4262295,414.2131148,1369.803279,5466.770492,628.8032787,163.1967213,4027.196721,4989.295082,1310.42623,152.557377,3277.245902,379.3606557,657.0983607,61,9.026508324,8.912560259,0.158392143,0.968253968,0.61,0.407575643
+3047,15211.38816,829.2631579,439.4802632,1038.059211,14181.98026,728.9276316,573.0657895,1442.230263,8037.085526,515.8881579,427.5526316,1765.25,10465.28947,1267.171053,1897.427632,1372.947368,3813.697368,1285.776316,342.7763158,2345.868421,8007.736842,418.3815789,1450.447368,460.3947368,9317.151316,414.7171053,123.8947368,1283.960526,7255.421053,1571.631579,584.1973684,2815.309211,6504.526316,759.7894737,273.6381579,1612.006579,5003.986842,786.0592105,430.4144737,1374.203947,3916.5,956.4473684,174.0855263,2287.947368,3682.572368,1410.342105,1894.723684,3158.072368,417.5526316,659.4539474,152,16.57421076,12.180935,0.678139687,0.899408284,0.678571429,-0.040984488
+3048,37455.72,967.2533333,603.6533333,1113.213333,33769.81333,844.32,957.44,1577.12,19697.96,583.1466667,1708.413333,1828.853333,25872.34667,1375.746667,2633.493333,4251.946667,8784.68,1452.12,366.16,2647.613333,19166.8,522.7066667,376.36,1182.84,23043.97333,453.8933333,322.0666667,2042.52,17318.37333,1998.88,701.3066667,2826.72,15523.09333,685.0266667,330.9333333,1701.413333,12221.08,1456.066667,477.6133333,1321.733333,8991.666667,716.48,176.0933333,2293.093333,8250.746667,1458.786667,277.68,3395.32,546.1466667,658.04,75,13.69582931,7.518941531,0.835825647,0.914634146,0.576923077,-0.429215631
+3049,24028.48148,848.3580247,516.2469136,1052,22681.8642,656,727.4444444,1441.419753,12315.50617,521.1111111,1572.049383,1750.864198,16968.80247,1237.901235,2499.962963,5468.320988,5917.17284,1320.061728,311.5432099,2639.580247,13164.5679,426.3333333,596.1728395,1189.679012,15588.08642,1105.790123,114.8148148,1663,11789.01235,1642.246914,792.2098765,2792.407407,10715.2716,672.5555556,275.2716049,1907.209877,8366.111111,1399.691358,415.8271605,1316.209877,6436.703704,968.9135802,163.2716049,3559.407407,6140.37037,1342.160494,413.1728395,3307.209877,592.0493827,657.6049383,81,12.52001136,8.498193312,0.734352022,0.931034483,0.675,0.249993395
+3050,37392.87755,846.3265306,625.047619,1078.734694,33268.53061,688.6734694,760.7006803,1571.394558,18648.03401,517.1360544,1057.306122,1807.115646,26453.14966,1251.027211,5607.598639,3225.789116,9398.92517,1288.367347,339.9931973,2369.884354,19078.93878,425.0612245,1165.319728,956.707483,23287.22449,472.8979592,128.3197279,1691.70068,18206.53741,2354.07483,1201.061224,2822.210884,15841.95918,662.1632653,287.3265306,1445.836735,12130.94558,1786.748299,426.7959184,1325.503401,8272.29932,893.9251701,163.6666667,4686.346939,7422.129252,1321.095238,278.7755102,3252.204082,885.9387755,660.6462585,147,20.41717227,9.996705232,0.871934567,0.849710983,0.628205128,-0.290133532
+3051,26112.38182,751.9181818,443.1272727,1062.863636,24256.20909,652.9,752.7818182,1544.336364,13667.54545,476.6,1065.909091,1754.209091,18760.36364,1166.545455,4821.345455,2681.909091,6786.009091,1216.845455,310.7727273,2423.636364,13312.7,586.5727273,278.1090909,810.0363636,16115.88182,888.4,128.7454545,1922.418182,12623.25455,1631.9,462.6090909,2850.581818,10598.06364,1217.709091,265.5272727,1697.245455,8068.890909,1448.718182,404.6090909,1284.936364,5448.145455,677.7454545,159.7909091,4030.609091,4969.036364,1219.663636,757.4454545,3192.354545,925.2363636,658.6272727,110,13.26375787,10.74716184,0.586063354,0.956521739,0.705128205,0.465739656
+3052,44206.3964,916.7207207,553.1261261,1114.324324,40369.33333,739.5765766,578.1351351,1634.810811,22270.15315,586.1351351,514.8558559,1779.315315,28345.47748,1319.423423,6214.189189,4811.855856,10604.18919,1413.459459,346.4054054,2332.324324,21659.58559,446.963964,147.8288288,425.4954955,25782.46847,421.1531532,126.2882883,4084.234234,19829.67568,1498.405405,676.954955,2802.783784,17424.18018,614.0990991,310.6216216,2092.612613,11335.8018,840.2612613,449.6036036,1290.324324,8350.945946,635.8468468,169.9009009,2656.603604,7407.207207,1352.108108,234.8378378,3431.648649,231.9459459,657.4504505,111,17.79606654,8.455901611,0.879901759,0.860465116,0.560606061,-1.376472534
+3053,31585.78082,793.9452055,565.1643836,1084.547945,30196.35616,655.2465753,521.7671233,1602.506849,16391.53425,519.739726,695.8082192,1799.246575,20591.56164,1188.890411,9224.410959,4822.575342,7788.315068,1311.246575,314.3287671,2602.972603,16644.31507,524.5342466,294.7260274,595,19463.43836,413.7671233,127.260274,5596.534247,14824.39726,1618.260274,842.8356164,2806.726027,12847.87671,588.0958904,283.9041096,2130.534247,8841.835616,881.6164384,426.9315068,1297.657534,6947.164384,659.9863014,162.3287671,3802.945205,5944.589041,1294.315068,162.2739726,3263.780822,251.9863014,657.7945205,73,12.68219314,7.932325127,0.780248609,0.829545455,0.561538462,-1.353112577
+3054,29155.65546,924.4705882,497.1764706,1056.495798,27743.15126,735.8991597,602.3781513,1535.302521,15299.36975,569.2605042,557.3697479,1774.302521,19200.61345,1275.865546,5490.882353,2499.504202,6815.596639,1368.89916,350.9243697,2377.294118,14524.06723,411.7058824,2022.042017,469.7394958,16968.73109,408.0588235,126.3865546,2403.806723,13396.11765,1702.739496,510.1512605,2806.445378,11518.66387,669.8319328,285.2941176,1283.689076,7841.781513,860.1932773,434.1176471,1348.731092,5999.319328,1090.697479,168.7731092,3389.831933,5343.02521,1332.235294,660.0504202,3295.260504,290.9159664,659.2605042,119,13.90272332,11.07664071,0.604342637,0.983471074,0.762820513,-0.800861606
+3055,24596.38849,959.2086331,930.2661871,1132.043165,21599.71942,705.8417266,814.9640288,1640.899281,12214.79856,595.7913669,727.5395683,1833.323741,16944.02158,1295.28777,1715.179856,1563.208633,5885.640288,1343.446043,317.1007194,2423.223022,12535.33813,533.3884892,327.8992806,611.4748201,15215.33094,564.8273381,120.9208633,1111.47482,11317.4964,1580.928058,648.3956835,2817.294964,10152.79137,3232.460432,272.8417266,1772.05036,7840,942.0143885,415.1366906,1363.151079,6077.964029,689.8201439,154.9208633,2054.517986,5458.258993,1376.971223,485.6546763,3321.633094,628.4244604,660.9280576,139,15.90677883,11.53076536,0.688857991,0.95862069,0.620535714,-0.604438699
+3056,28356.37908,864.869281,564.1503268,1079.254902,25486.51634,644.3202614,538.6928105,1508.424837,14177.03922,502.9607843,691.2941176,1771.764706,19046.64706,1220.464052,2442.732026,2330.065359,6851.431373,1269.496732,305.3071895,2439.065359,14453.27451,420.5424837,227.3660131,700.869281,17632.14379,495,137.6470588,1569.019608,13030.53595,1544.27451,602.6143791,2823.437908,11497.9281,1139.673203,264.1895425,1709.738562,9012.875817,931.2679739,388.6666667,1307.509804,6856.424837,763.4836601,153.8562092,1852.143791,6199.104575,1323.052288,861.8823529,3273.045752,658.6928105,660,153,15.03201339,13.18270187,0.480535769,0.944444444,0.68,0.485750874
+3057,16515.61585,905.8109756,525.804878,1063.036585,20989.7378,1020.02439,882.1768293,1826.164634,9782.536585,494.9756098,1519.432927,1953.006098,14702.77439,1301.530488,4412.77439,2587.981707,5667.646341,1234.628049,309.152439,2381.573171,10448.53659,4748.896341,661.2621951,1083.280488,13315.60976,507.4573171,921.4878049,2725.189024,9847.969512,1969.957317,413.3597561,2793.75,8149.829268,1190.731707,251.597561,1312.518293,5804.786585,928.4268293,389.097561,1292.731707,3291.670732,751.3536585,151.5487805,3358.323171,3345.926829,1142.987805,538.2439024,3299.689024,1054.542683,660.4329268,164,16.68252988,13.84344058,0.558036177,0.886486486,0.569444444,0.240462426
+3058,31308.83803,773.4225352,488.9647887,1078.471831,30179.02113,636.1126761,677.2535211,1541.514085,16524.91549,509.7042254,1057.711268,1806,20430.62676,1192.823944,7504.978873,3999.267606,7729.577465,1297.84507,309.1690141,2864.190141,16224.94366,641.3450704,195.9929577,690.3098592,18947.47183,445.1478873,124.5211268,3797.985915,14704.28873,1892.823944,588.3380282,2804.070423,12662.20423,588.5985915,274.3802817,1645.739437,8624.605634,915.9507042,416.7042254,1298.070423,6625.697183,640.2887324,166.7394366,4545.077465,5852.042254,1287.56338,194.3521127,3293.852113,263.9859155,661.2887324,142,17.35837367,11.05672808,0.770890266,0.91025641,0.563492063,-0.427356336
+3059,26213.02807,915.4912281,569.0210526,1103.136842,24950.98596,719.0807018,510.1157895,1602.466667,14112.89825,569.3894737,568.6701754,1769.880702,17675.24211,1326.459649,5084.070175,3399.34386,6537.764912,1476.85614,351.277193,2373.975439,13909.20702,961.3964912,422.6912281,473.6491228,16322.79298,467.3719298,131.4421053,5648.035088,12759.95439,1737.845614,587.4807018,2810.796491,11102.70526,627.0807018,301.6666667,1494.284211,7898.568421,947.9894737,448.3368421,1317.024561,6124.803509,700.8526316,176.2666667,4934.526316,5344.105263,1364.059649,235.1333333,3254.62807,317.4736842,660.8666667,285,27.35050666,13.96404711,0.859842727,0.896226415,0.659722222,-1.304628559
+3060,37472.43519,1017.046296,560.462963,1121.342593,14768.52778,494.3240741,260.5185185,1279.388889,8573.342593,399.8888889,634.037037,1703.87963,11379.62963,967.7962963,4154.046296,2746.055556,4294.944444,1192.185185,257.6944444,2344.583333,8942.5,339.6111111,162.5185185,608.8981481,10306.58333,301.75,112.0833333,4202.018519,7820,1430.361111,552.2407407,2777.37037,6851.111111,494.5092593,227.0092593,1090.25,5213.37037,779.4907407,360.3703704,1273.037037,4004.962963,569.2037037,144.7314815,2688.148148,3735.574074,1125.027778,129.2222222,3334.092593,360.3703704,661.212963,108,13.57106652,10.41447407,0.641165334,0.972972973,0.593406593,-0.51292794
+3061,33765.11957,880.1956522,557.1630435,1097.891304,31658,696.0869565,830.9347826,1561.195652,18483.31522,559.9782609,1094.880435,1776.456522,23905.01087,1309.043478,4889.597826,5813.076087,8411.793478,1406.478261,339.7934783,2460.173913,18056.94565,443.826087,133.9891304,765.1304348,21235.27174,880.423913,136.2934783,3859.826087,15405.05435,1641.543478,803.923913,2804.380435,13867.13043,631,303.8043478,1877.923913,10776.5,1162.804348,462.2282609,1308.913043,8140.728261,638.0108696,173.6630435,3559.869565,7438.565217,1401.673913,489.326087,3276.652174,487.5326087,660.8913043,92,17.40229828,7.156454082,0.911528843,0.836363636,0.479166667,-1.037106773
+3062,31887.20872,873.1433022,538.2834891,1090.529595,29005.08411,713.8504673,711.894081,1513.426791,16984.24299,547.3457944,772.5140187,1759.364486,22004.69159,1335.386293,3700.788162,4545.775701,7633.383178,1442.168224,336.1433022,2387.080997,16758.94393,454.8629283,643.2024922,579.046729,19615.53583,734.728972,131.5015576,3169.844237,14619.06854,1520.099688,767.8691589,2807.485981,13063.21495,646.1090343,291.6760125,1824.719626,10196.28349,947.4672897,449.2087227,1343.82866,7576.563863,771.105919,172.2087227,3825.277259,6991.495327,1414.255452,349.2336449,3229.909657,495.6542056,669.3925234,321,23.81087398,18.44897941,0.632190247,0.881868132,0.583636364,-0.687330956
+3063,21171.965,1040.245,584.045,1049.8,18209.295,730.785,760.075,1476.005,10308.385,860.525,924.25,1749.03,13375.255,1287.045,4362.73,2258.69,4643.37,1317.715,319.845,2454.245,9945.85,432.46,695.74,1160.45,11805.53,766.29,213.41,1590.66,8818.025,1876.71,744.855,2792.225,7777.015,892.745,251.16,1508.125,5959.09,996.455,384.435,1377.18,4572.675,754.39,151.485,3827.495,3888.76,1258.925,510.01,3310.905,612.555,662.335,200,17.38524195,15.02495798,0.503086014,0.947867299,0.694444444,1.324841696
+3064,34841.77301,873.1104294,515.3680982,1086.920245,30554.40491,693.2515337,701.006135,1545.282209,18041.7546,527.7668712,1245.546012,1749.797546,24112.66258,1279.196319,5292.865031,4022.907975,8614.460123,1298.110429,325.5214724,2446.625767,18038.49693,530.2699387,229.7177914,931.3251534,22812.79141,1151.257669,122.1165644,2552.693252,16759.96933,1559.613497,663.4539877,2783.723926,14926.3681,628.5766871,275.7423313,1664.711656,11523.52761,1321.177914,404.2944785,1310.809816,8423.92638,661.6748466,155.6257669,2572.411043,7794.257669,1341.07362,452.3251534,3264.306748,721.4907975,665.6134969,163,24.74713231,9.295962971,0.926766477,0.827411168,0.56993007,-0.271858836
+3065,32789.89552,903.238806,922.8059701,1147.11194,28814.85075,718.1268657,938.8432836,1687.11194,16872.26119,545.761194,1206.410448,1796.619403,23041,1327.455224,1945.634328,2421.761194,8147.955224,1340.022388,340.1940299,2477.731343,16717.55224,478.6044776,274.8880597,1106.507463,20451.12687,484.4253731,124.3358209,1236.522388,15638.97761,1837.171642,521.6940299,2821.410448,13873.03731,684.3656716,281.9701493,1934.328358,10606.72388,1203.91791,435.2014925,1333.589552,7651.947761,666.1641791,165.5522388,2714.358209,6747.537313,1391.097015,254.3731343,3290.873134,793.6119403,662.4328358,134,18.02701598,9.94951428,0.833895463,0.893333333,0.598214286,-0.572108566
+3066,34099.37288,818.7372881,574.0254237,1069.483051,31446.92373,694.7372881,697.9491525,1517.983051,17536.45763,537.7542373,872.6525424,1757.70339,24505.64407,1261.305085,3690.220339,2998.262712,8666.313559,1289.457627,325.6610169,2426.855932,17892.10169,423.6186441,816.0084746,996.7118644,22139.85593,522.0762712,129.0338983,1950.228814,16455.18644,1659.576271,554.3389831,2789.322034,14543.54237,660.5,272.3898305,1958.745763,11290.44915,1057.822034,418.3220339,1326.70339,8284.169492,811.9830508,159.4745763,4564.491525,7085.627119,1329.5,242.779661,3204.847458,804.7966102,661.9576271,118,17.51376795,9.614662381,0.835837209,0.797297297,0.462745098,-0.577735086
+3067,40709.55455,1015.745455,510.6090909,1098.263636,38521.63636,784.0636364,787.8727273,1589.836364,21928.70909,584.9363636,1937.790909,1806.245455,29856.37273,1376.481818,4067.972727,2898.3,10520.28182,1470.018182,357.5272727,2425.872727,21480.75455,443.5818182,520.7818182,1201.627273,26248.77273,470.9727273,561.7909091,1308.681818,20139.50909,2391.454545,485.3454545,2814.327273,17684.60909,757.4272727,293.8727273,1316.172727,13600.99091,1536.572727,436.4363636,1324.936364,9180.463636,761.9454545,168.2181818,2165.9,8082.509091,1401.490909,700.3545455,3325.472727,868.3363636,662.0181818,110,17.89522542,8.169783952,0.88970582,0.887096774,0.431372549,-0.891951464
+3068,20704.42574,839.3564356,502.1584158,1040.336634,19502.24752,689.4653465,576.6039604,1443.980198,10847.19802,524.5247525,510.0990099,1749.158416,14248.09901,1255.920792,3659.950495,2717.831683,5399.564356,1335.891089,330.2178218,2354.247525,11233.9505,407.5742574,1966.158416,512.5940594,13169.75248,442.8316832,124.6930693,2815.485149,10106.64356,1610.564356,598.2079208,2812.485149,9029.910891,748.950495,283.2772277,1766.415842,6974.059406,835.1683168,438.980198,1416.50495,5531.009901,1067.732673,173.2376238,4749.831683,4953.50495,1401.970297,450.4455446,3188.693069,407.0891089,661.6237624,101,12.71959048,11.6490894,0.401547038,0.808,0.647435897,-0.682950631
+3069,34940.09302,941.2403101,538.4496124,1084.937984,32479.24031,744.5891473,589.6821705,1544.248062,17976.93023,570.255814,518.7984496,1758.054264,23630.96899,1383.75969,2998.689922,2449.596899,8374.27907,1417.209302,348.9844961,2393.899225,18120.06202,455.7984496,181.1162791,478.9922481,20970.35659,434.8217054,133.9612403,3054.023256,15689.49612,1531.674419,756.0465116,2808.736434,13992.70543,1081.682171,304.6821705,1995.922481,11077.50388,934.5348837,455.8914729,1315.232558,8413.627907,672.3953488,174.6124031,4038.031008,7640.75969,1393.147287,577.6744186,3349.852713,457.3953488,661.1627907,129,14.12113244,11.87377883,0.541265504,0.962686567,0.826923077,-1.527638883
+3070,33067.14625,856.7905138,534.7944664,1094.387352,31184.58498,702.6837945,712.2885375,1585.940711,17105.8498,569.8774704,960.513834,1755.185771,23445.32016,1291.652174,3573.26087,3341.181818,8364.818182,1301.324111,326.458498,2588.671937,17651.18972,436.3873518,644.1343874,727.3043478,22346.5336,582.8577075,150.1541502,2587.517787,16059.34387,1706.335968,660.5770751,2837.474308,14127.27273,1111.648221,279.3992095,1796.545455,11245.04348,1154.312253,414.3517787,1336.130435,8289.667984,784.2213439,159.9209486,3172.87747,7381.727273,1384.233202,1402.612648,3257.296443,744.284585,663.5059289,253,28.06784919,12.17422338,0.901036798,0.866438356,0.608173077,-1.315363093
+3071,12629.19231,812.8269231,458.5,1039.807692,15643.67308,704.4230769,593.5961538,1464.269231,6277.288462,495.8076923,832.0384615,1784.980769,10174.92308,1241.653846,3825.057692,2765.153846,3599.5,1396.230769,313.5192308,2337.711538,7614.173077,378.5769231,1924.230769,904.9230769,10070.23077,404.6538462,173.5,1418.884615,6396.557692,1828.153846,572.9423077,2794.057692,5628.192308,841.6923077,243.2307692,1558.826923,4642.288462,1185.461538,404.7307692,1347.807692,3689.346154,1175.865385,154.8076923,5375.153846,2940.923077,1293.846154,384.0961538,3171.75,858,659.2884615,52,11.12952028,6.028339658,0.840602088,0.962962963,0.590909091,1.04132774
+3072,18374.91781,802.8630137,1349.260274,1095.931507,17406.47945,596.4931507,556.0273973,1535.383562,8907.958904,453.9452055,554.5068493,1829.041096,13657.72603,1148.410959,5695.30137,2314.452055,5023.90411,1172.424658,292.7534247,2365.342466,9660.479452,372.1917808,3609.986301,605.7123288,11815.42466,397.5890411,119.8082192,1661.260274,9098.972603,2759.534247,5042.739726,2815.232877,7987.808219,666.2054795,256.6027397,1464.479452,6236.876712,1134.876712,395.9041096,1349.438356,4362.561644,1396.808219,170.9178082,14319.89041,3882.712329,1193.136986,134.7945205,3167.712329,893.9863014,662.9452055,73,12.17452776,9.50866783,0.624493874,0.858823529,0.474025974,-0.236423192
+3073,30702.17164,760.0074627,455.7537313,1054.141791,27413.82836,633.4029851,1141.470149,1533.634328,15755.81343,481.0820896,2512.268657,1796.649254,21958.23881,1165.925373,6041.164179,4093.865672,8040.455224,1240.865672,307.4850746,3086.358209,15441.09701,507.3208955,412.2686567,1973.932836,19101.00746,563.619403,126.3283582,1324.171642,15053.73134,2433.410448,515.1716418,2803.626866,12994.93284,709.2089552,321.9104478,1317.074627,9642.873134,1763,407.358209,1307.320896,6572.141791,685.3731343,160.119403,3734.268657,6040.052239,1223.80597,408.5671642,3159.462687,912.4701493,662.2014925,134,15.76817619,11.64970815,0.673912258,0.905405405,0.644230769,-0.583154321
+3074,25756.50685,795.8767123,641.0182648,1086.127854,24206.53881,660.4931507,890.4383562,1627.127854,12354.91781,475.456621,1628.43379,1781.812785,17688.09589,1165.799087,5571.118721,3639.83105,6620.237443,1231.479452,302.5616438,2839.858447,12664.77626,1847.283105,1520.639269,860.9041096,16074.72146,463.9634703,126.0410959,2605.287671,12247.11416,1965.945205,460.3287671,2791.689498,10178.42009,779.369863,260.1506849,1493.552511,7450.3379,1305.56621,396.7214612,1319.328767,4521.712329,964.0045662,158.1872146,4727.420091,4426.415525,1209.958904,805.9269406,3172.593607,1007.150685,665.6438356,219,21.55673911,13.16911046,0.791704241,0.960526316,0.744897959,0.105568745
+3075,30374.22566,823.0530973,544.5884956,1076.314159,29060.52212,692.7743363,598.9513274,1638.199115,14382.92035,484.0265487,493.8584071,1728.814159,20821.0354,1199.035398,6082.526549,3208.964602,7828.106195,1260.80531,320.8938053,2357.955752,14785.0885,494.659292,1236.561947,526.6858407,18948.47345,431.3584071,141.0884956,3890.730088,14311.26106,1543.597345,450.3495575,2808.787611,11697.39823,699.8716814,266.6460177,1728.738938,8410.371681,853.6460177,402.8672566,1305.672566,4763.747788,929.3628319,160.1769912,4792.553097,4969.641593,1240.115044,1419.150442,3180.00885,1041.482301,666.4424779,226,19.43678591,15.10767673,0.629164253,0.949579832,0.664705882,-0.417000925
+3076,36214.47748,836.1441441,538.0990991,1094.009009,20567.22523,502.4234234,410.1801802,1325.351351,9306.846847,389.2342342,566.2702703,1637.342342,14178.99099,973.8288288,5952.756757,1794.405405,5507.666667,1015,258.2522523,2348.612613,9926.153153,325.5675676,447.3783784,637.1981982,12484.25225,321.2072072,114.1261261,3155.459459,9724.468468,1574.369369,400.9459459,2766.162162,7823.981982,517.981982,208.0630631,1010.927928,5346.702703,716.1981982,336.009009,1264.036036,2740.756757,625.990991,138.3153153,3093.486486,2933.414414,960.2972973,1205.414414,3007.36036,1073.765766,662.7027027,111,13.8230176,10.54555543,0.646518612,0.925,0.616666667,0.25919996
+3077,32578.25862,859,606.7068966,1089.086207,30404.7069,683.2413793,664.6896552,1637.456897,16428.43966,540.5517241,520.5517241,1773.112069,21174.62069,1249.767241,7890.456897,5313.336207,7956.706897,1321.258621,326.1034483,2327.594828,16324.5,417.5862069,166.6551724,429.9224138,19193.32759,412.2844828,126.0086207,6461.060345,14557.12931,1456.232759,651.5948276,2814.836207,12748.49138,599.8189655,292.7672414,2692.62069,8396.931034,806.3017241,434.8706897,1290.284483,6453.689655,631.0603448,168.637931,4194.637931,5542.051724,1286.267241,246.4224138,3323.560345,236.362069,663.637931,116,22.18541052,7.383028226,0.94300183,0.811188811,0.469635628,-1.178589023
+3078,36108.8875,972.5125,539.4,1073.8125,32276.725,743.6125,590.3625,1530.1875,19110.425,568.025,535.9375,1754.45,24327.1125,1373.1,6067.9875,2683.1375,8650.7125,1399.8,343.375,2348.7875,17137.5,433.25,244.4625,486.975,20443.8875,433.2875,128.225,2880.0625,16163.7625,1529.2125,609.9125,2797.35,14051.85,640.125,303.275,1381.8125,10622.5625,892.9875,454.075,1359.9,8070.275,680.9,176.7,4811.5625,7321.4,1408.45,190.2875,3276.7625,396.6625,663.5,80,14.50010528,7.329696241,0.862830927,0.909090909,0.615384615,-0.520057229
+3079,29870.8125,980.6875,521.125,1077.78125,26622.375,754.9270833,734.3958333,1474.427083,15842.47917,600.1145833,729.6458333,1730.729167,21229.5,1391.135417,3258.75,2797.104167,7109.291667,1550.447917,344.875,2401.104167,15337.91667,473.8854167,296.2083333,878.4479167,18577.77083,510.40625,138.0833333,1669.114583,14276.72917,1651.979167,706.40625,2816.125,12773.86458,922.96875,297.5,1600.375,9886.833333,1003.28125,450.1458333,1329.15625,7297.614583,672.1666667,189.1041667,2880.666667,6869.364583,1414.270833,363.2604167,3288.572917,553.09375,662.40625,96,13.99448694,9.020703145,0.76452863,0.95049505,0.623376623,-0.980298294
+3080,40563.61333,1035.906667,472.2133333,1082.96,34074.38667,796.7866667,812.4933333,1542.546667,20399.77333,573.6,1612.48,1764.12,26542.97333,1356.093333,2244,2993.96,9332.373333,1300.653333,323.0933333,2417.013333,19598.45333,454.24,100.8933333,1443.813333,24117.16,673.9733333,167.8533333,975.5066667,18490.06667,1904.466667,556.1466667,2833.453333,16425.24,608.6266667,281.6533333,1342.2,12861.73333,1272.96,404.9466667,1300.133333,9231.72,621.8933333,151.8666667,1582.866667,8260.066667,1343.386667,587.44,3363.133333,690.3466667,662.7066667,75,13.26457092,7.64231222,0.817347714,0.872093023,0.535714286,-0.240319577
+3081,34994.64286,880.9428571,547.1,1092.571429,32415.51429,720.9571429,816.65,1535.328571,18147.42143,537.7142857,1642.407143,1788.585714,24894.51429,1281.264286,3117.285714,3570.142857,8820.714286,1291.271429,317.5214286,2835.514286,18443.25714,546.3714286,177.1571429,1545.035714,22928.90714,463.0928571,129.2428571,1743.657143,16997.96429,2160.064286,543.3428571,2802.878571,15108.00714,710.6857143,282.2428571,1767.321429,11725.61429,1514.085714,415.7214286,1314.264286,8533.471429,639.7214286,162.0642857,3664.035714,7554.642857,1353.028571,308.7642857,3244.107143,782.45,664.0571429,140,18.03340364,10.81089898,0.80038001,0.886075949,0.583333333,-0.659291702
+3082,41152.19853,891.7647059,534.3235294,1120.397059,37529.58824,723.1838235,782.1985294,1623.132353,21732.07353,544.4779412,1155.933824,1797.139706,29344.22059,1334.720588,2957.485294,3581.985294,10681.125,1342.742647,366.3088235,2475.985294,21883.52941,447.7794118,614.6470588,938.6029412,26943.13971,692.6102941,129.1617647,1914.691176,20167.52206,1803.610294,576.4632353,2803.816176,17774.43382,683.3676471,293.3970588,1650.661765,13723.82353,1339.779412,439.6397059,1320.698529,9539.610294,786.4632353,172.375,2439.727941,8548.897059,1399.919118,255.6323529,3301.713235,829.5147059,667.1617647,136,22.47163359,8.332290687,0.928716138,0.860759494,0.68,-0.149234864
+3083,13233.31818,772.2954545,541.5909091,1048,16739.86364,698.6136364,1042.772727,1474.045455,5909.181818,482.7954545,2379.340909,1850.159091,10992.97727,1178.227273,7375.931818,4305.090909,3785.090909,1206.75,308.4772727,2723.75,7829,446.6590909,3863.795455,2236.522727,10096.90909,424.1363636,190.1363636,2384,6476.204545,2415.159091,480.4545455,2798.363636,5449.431818,909.5681818,247.0227273,1518.954545,4393.318182,1421.727273,387.4318182,1350.818182,3568.090909,1606.363636,154.5227273,7118.772727,2735.977273,1186.909091,681.5909091,3102.931818,935.6363636,660.0454545,44,8.564203441,6.616523737,0.634918646,0.916666667,0.698412698,-1.150808458
+3084,40534.07031,863.5390625,587.75,1141.164063,37832.88281,711.3046875,618.4296875,1716.164063,18428.71875,552.15625,622.4296875,1770.132813,24995.27344,1277.242188,6730.53125,6672.554688,9181.78125,1355.75,346.4453125,2566.40625,18863.48438,435.421875,127.9140625,524.625,22709.60938,439.609375,130.4921875,5304.09375,16745.03125,1674.414063,767.0546875,2813.03125,14392.59375,615.78125,302.484375,5419.328125,8452.320313,899.4140625,439.5390625,1313.671875,5829.9375,614.359375,168.609375,3230.632813,5245.617188,1328.296875,255.8984375,3235.960938,161.78125,665,128,14.87248106,11.52361411,0.632172158,0.876712329,0.703296703,-0.594012567
+3085,11703.58683,736.9101796,424.5628743,1074.191617,11597.72455,574.8562874,392.9520958,1385.622754,6449.814371,629.9580838,487.742515,1725.730539,8099.718563,1117.449102,3010.437126,1196.167665,3099.862275,1778.766467,331.1556886,2335.898204,6552.760479,339.9520958,254.502994,434.4550898,7644.598802,347.005988,111.6047904,1233.922156,5867.91018,1429.05988,512.6167665,2832.125749,5259.047904,737.6047904,246.1616766,1051.60479,3843.874251,707.4491018,380.5988024,1307.269461,3020.838323,604.742515,152.4431138,1771.083832,2782.071856,1185.634731,260.7245509,3135.365269,336.0898204,665.994012,167,16.75105541,13.02933244,0.62848515,0.943502825,0.662698413,-0.038860755
+3086,36358.96154,916.6538462,545.474359,1114.576923,33925.11538,745.3589744,825.2692308,1627.5,19162.07692,568.0641026,1387.294872,1877.897436,24215.83333,1350.217949,5656.910256,4214.410256,8878.358974,1422.576923,345.9871795,2517.602564,18291.01282,452.6282051,229.8846154,662.9871795,21385.4359,472.4615385,133.7051282,3407.75641,16396,1979.641026,613.5897436,2812.653846,14479.97436,686.8846154,327.0897436,1543.538462,10843.46154,1378.179487,459.7435897,1329.461538,8319.75641,679.5512821,175.9230769,3422.846154,7491.179487,1416.333333,171,3251.128205,386.5641026,662.9487179,78,11.07138343,9.319608721,0.53982925,0.906976744,0.590909091,-1.300940112
+3087,26563.175,799.7375,512.425,1088.2625,25110.1375,691.1,932.225,1536.3,13831.8625,484.125,1671.6375,1868.8,19457.7875,1578.8375,4216.875,4439.2625,7226.475,1241.0875,316.475,2757.1125,14429.3375,1179.2,287.5375,1383.875,17677.6125,458.9875,122.15,2015.0625,13035.9375,2131.675,583.9375,2788.4875,11451.4125,706.25,267.5125,1699.5375,8884.0125,1310.5125,409.05,1322.9375,6448.4,679.6625,161.4625,5399.8,5589.35,1280.25,182.325,3268.4,822.1875,663.275,80,12.7551543,8.445918474,0.749364875,0.879120879,0.740740741,-0.128658375
+3088,33132.06383,850.0851064,448.3829787,1083.93617,28559.82979,705.0425532,839.9148936,1614.276596,17504.21277,551.4042553,592.1702128,1748.191489,23847,1323.659574,3160.106383,2333.276596,8783.191489,1468.744681,371.2978723,2365.765957,17354.87234,476.4042553,667.7234043,726.3404255,21568.10638,435.2553191,135.5106383,1091.531915,16719.74468,1762.021277,506.1276596,2826,14659.04255,684.5106383,292.2765957,1541.06383,11396.82979,997.3617021,438.1276596,1306.553191,7532.085106,1229,178.8723404,4025.234043,7095.851064,1384.212766,174.787234,3285.93617,851.7659574,662.0638298,47,10.07963174,6.412409527,0.77154481,0.903846154,0.522222222,0.544308225
+3089,38562.88028,902.0422535,532.9788732,1090.147887,34571.3169,701.2816901,711.3239437,1574.795775,19702.59155,542.4225352,1686.598592,1809.133803,27601.61972,1301.161972,3473.823944,3428.65493,9769.457746,1342.570423,355.8169014,2350.704225,19670.79577,430.084507,1100.288732,1168.06338,23793.61972,466.2605634,138.2957746,1984.021127,18382.56338,2310.971831,518.8521127,2816.295775,15985.99296,759.4859155,290.6126761,1425.049296,12236.35211,1777.633803,428.028169,1327.929577,8255.429577,929.8873239,171.1830986,3703.387324,7430.288732,1340.598592,335.1126761,3265.591549,876.028169,667.7816901,142,18.17887594,11.25972449,0.785087336,0.922077922,0.622807018,-0.265761894
+3090,40182.26136,903.7954545,559.4886364,1141.295455,34936.61364,703.2159091,596.4431818,1736.755682,16801.55114,485.9147727,1113.159091,1760.340909,24345.67614,1211.755682,6753.284091,2560.573864,9212.443182,1289.5,322.8011364,2458.147727,17357.80114,634.1420455,582.7784091,864.3522727,21601.11364,500.9659091,132.7897727,3595.875,16842.86932,1604.164773,420.3295455,2792.0625,13748.81818,773.7954545,277.1363636,1296.295455,9154.261364,1038.005682,404.4545455,1312.732955,4833.494318,729.4943182,158.75,3469.568182,5146.926136,1199.028409,981.7784091,3234.823864,1064.102273,668.5056818,176,17.52130818,14.45744465,0.564935597,0.888888889,0.543209877,-0.227793364
+3091,37848.553,842.9032258,565.5253456,1107.870968,22280.53917,555.4792627,546.6912442,1477.520737,9332.470046,412.3732719,2030.585253,1705.138249,14854.83871,1004.658986,8712.502304,3975.866359,5550.327189,1054.511521,270.9677419,2876.728111,10368.67742,325.9585253,918.8847926,1534.345622,12682.17972,477.0322581,108.8847926,2680.576037,9826.801843,3290.050691,356.7235023,2812,7684.451613,513.8986175,219.281106,907.7880184,4673.138249,1479.400922,339.6866359,1278.907834,2326.857143,707.3824885,135.7880184,2425.640553,2565.751152,957.0414747,286.9308756,3035.728111,1109.585253,664.3364055,217,20.84464021,13.61544846,0.757196615,0.947598253,0.657575758,1.562722832
+3092,35526.65152,857.3484848,723.4469697,1133.348485,32019.50758,734.8409091,962.8636364,1624.189394,18095.35606,523.8257576,1353.159091,1819.681818,25101.85606,1279.128788,3392.643939,3445.075758,9077.583333,1277.840909,317.4090909,2671.583333,18968.31818,738.2424242,169.5378788,1080.371212,24090.92424,494.3787879,264.5227273,2820.840909,17158.26515,1971.484848,621.8939394,2802.007576,15332.57576,774.7272727,277.3030303,2320.045455,11968.18182,1044.189394,427.9393939,1315.651515,8608.825758,646.4015152,160.4469697,4399.69697,7828.659091,1380.80303,846.0909091,3419.94697,768.2424242,665.6742424,132,16.75988363,10.79765311,0.76481004,0.88590604,0.554621849,-1.060719102
+3093,14384.39823,744.920354,425.3274336,1044.699115,13215.17699,615.1946903,535.8141593,1484.061947,6876.876106,457.0619469,419.3362832,1697.362832,9806.769912,1127.938053,1487.654867,925.7964602,3779.035398,1163.053097,295.8318584,2311,7062.849558,398.9292035,275.6371681,510.7876106,8808.628319,421.7876106,120.5575221,1242.442478,6988.221239,1361.221239,392.7433628,2809.380531,5851.663717,819.6106195,246.2566372,1439.495575,4342.495575,732.4247788,378.4070796,1295.044248,2505.061947,633.9026549,153.0442478,2744.044248,2670.433628,1226.053097,6794.123894,3075.247788,1021.946903,665.4867257,113,13.05966051,11.17119371,0.517973035,0.949579832,0.668639053,1.114044039
+3094,27188.20833,1043.236111,673.5555556,1098.263889,22265.625,658.5694444,519.0972222,1523.638889,12610.875,499.2916667,1153.638889,1779.666667,15984.48611,1189.472222,9754.319444,4837.291667,5949.486111,1318.027778,306.625,2349.736111,11874.5,416.1388889,499.9583333,863.4861111,13811.63889,396.1805556,205.625,5057.944444,10544.08333,1777.611111,585.125,2810.027778,9236.930556,575.8472222,264.5555556,1560.75,6781.027778,1100.833333,409.0972222,1305.680556,5212.847222,716.8055556,159.5416667,4212.472222,4754.75,1266.5,198.5277778,3275.875,369.3333333,664.0972222,72,16.82632582,6.114751968,0.9316317,0.847058824,0.45,-1.129105541
+3095,39018.08846,867.8846154,538.6538462,1097.723077,34315.00385,765.1807692,994.2384615,1575.715385,20495.13462,559.0576923,1782.773077,1834.011538,27521.27308,1354.965385,3831.276923,4005.457692,9781.015385,1318.273077,338.0307692,2579.088462,20024.38077,448.5230769,643.8153846,1631.234615,24360.36923,700.0769231,313.0230769,2294.061538,18769.4,2129.034615,577.7346154,2790.711538,16346.88462,680.8423077,284.8307692,1709.565385,12536.11154,1352.873077,430.6269231,1323.392308,8824.134615,769.1307692,166.5192308,4971.192308,7881.084615,1381.903846,260.6538462,3226.265385,812.6884615,671.0576923,260,21.26997781,18.19924887,0.517586586,0.838709677,0.538302277,-0.812227839
+3096,38565.61053,817.3473684,491.4736842,1082.768421,35934.14737,744.7578947,1219.221053,1649,19812.31579,514.9684211,2641.410526,1872.042105,27336.30526,1246.336842,5543.673684,3385.757895,9914.684211,1285.178947,333.8210526,2571.957895,19809.05263,1104.242105,403.2,2407.831579,23994.82105,430.1368421,332.7157895,2372.231579,18622.10526,2341.273684,487.9578947,2800.631579,15784.55789,854.0842105,275.6421053,1449.894737,11737.32632,1231.705263,416.5473684,1312.305263,7765.231579,693.6736842,161.3263158,5057.042105,7075.831579,1269.715789,635.5157895,3228.357895,943.3473684,664.3894737,95,16.15052922,9.115781356,0.825483554,0.778688525,0.521978022,-0.837107289
+3097,39458.31111,864.1444444,468.9444444,1095.688889,36352.64444,722.0444444,638.2888889,1552.044444,20247.48889,531.0555556,950.7777778,1746.3,28874.36667,1321.055556,2525.877778,4540.955556,10569.71111,1327.244444,346.9666667,2395.688889,20998.93333,437.8444444,649.9777778,906.6,26296.77778,491.9888889,224.0666667,2180.022222,19234.78889,1714.9,686.9666667,2793.277778,16824.46667,700.8333333,293.2888889,1908.233333,13151,1143.1,433.8444444,1323.233333,9238.677778,773.7666667,167.3888889,3032.5,8276.055556,1396.055556,626.0333333,3228.044444,837.8777778,667.5666667,90,12.94062843,9.777923614,0.655034669,0.825688073,0.642857143,-0.311061113
+3098,46839.79661,950.7288136,539.6610169,1118.338983,39975.98305,767.2711864,858.7457627,1653.830508,24054.45763,567.6440678,737.6440678,1759.271186,32465.94915,1414.864407,3778.237288,4046.491525,11730.0339,1450.610169,372.779661,2357.728814,23723.54237,458.9661017,381.7627119,732.7966102,29749.05085,480.4915254,191.220339,2357.067797,22706.37288,2160.627119,581.7288136,2791.271186,19836.45763,687.6779661,306.8813559,1760.40678,15443.15254,1225.576271,462.1186441,1334.440678,10341.47458,817.8135593,176.3898305,4643.372881,9612.864407,1462.220339,266.2033898,3295.016949,846.3728814,666.9661017,59,11.23919405,7.062447273,0.777909228,0.907692308,0.614583333,-0.144824177
+3099,42914.78226,831.5,575.8709677,1125.104839,40546.07258,692.8064516,678.3467742,1662.556452,20927.15323,553.6370968,654.6370968,1752.862903,26742.54839,1258.774194,6701.774194,7515.483871,10030.19355,1353.564516,339.6048387,2574,20418.23387,427.3629032,136.2177419,551.8629032,25045.12097,428.0322581,134.2822581,5665.387097,18699.15323,1585.717742,726.0483871,2821.693548,16071.09677,608.9677419,306.0887097,2916.766129,9843,868.8790323,442.1612903,1303.016129,7062.104839,615.5887097,166.2983871,3564.298387,6160.685484,1322.080645,173.1854839,3267.483871,187.2983871,668.0241935,124,17.20521758,9.630166835,0.828679346,0.911764706,0.553571429,-0.846176906
+3100,34988.10465,831.5697674,514.627907,1073.906977,33391.68605,670.8372093,579.2906977,1547.406977,18056.5814,538.3837209,648.9302326,1779.918605,22540.65116,1209.465116,5404.465116,4677.511628,8446.372093,1296.837209,316.5348837,2394.918605,17608.06977,421.4302326,153.7790698,502.0697674,20807.74419,417.3023256,124.0116279,3492.5,16198.12791,1511.546512,695.9186047,2814.918605,13987.09302,584.6627907,278.127907,1673.523256,9294.895349,867.5813953,427.4302326,1292.72093,7144.77907,618.7906977,156.2325581,3061.651163,6233.081395,1339.104651,306.3255814,3298.953488,254.2209302,666.744186,86,13.63736805,8.81377046,0.763087181,0.851485149,0.597222222,0.830495707
+3101,19743.936,844.464,442.336,1053.264,18334.736,682.88,544.336,1545.304,10252.4,522.304,537.16,1802.864,13142.776,1272.408,1526.48,1803.48,4639.208,1290.12,317.992,2345.8,10054.752,457.808,296.616,536.208,11397.448,432.256,123.936,1009.968,8681.352,1402.176,602.336,2817.48,7689.448,735.656,283.336,1610.912,5961.76,1078,431.528,1309.76,4700.624,2409.672,168.576,2059.752,4054.768,1776.016,4540.808,3209.696,430.504,667.736,125,13.55902956,11.89408783,0.480110718,0.961538462,0.73964497,-0.762676649
+3102,20869.57143,800.6134454,509.8235294,1072.806723,19073.47059,677.4369748,504.5378151,1478.109244,10764.19328,511.7310924,472.6722689,1801.109244,14436.03361,1240.983193,3972.159664,2456.697479,5113.092437,1339.941176,337.2941176,2362.764706,11248.71429,450.4117647,1057.579832,481.2268908,13233.84034,408.1932773,128.1176471,1982.117647,9570.218487,1621.563025,760.9411765,2875.193277,8729.714286,1235.453782,275,2152.957983,6843.235294,878.6218487,425.0840336,1339.042017,5285.94958,876.2605042,166.9495798,3381.352941,4885.731092,1343.352941,530.0672269,3226.033613,524.2016807,667.1596639,119,15.96514812,9.997725891,0.77964485,0.944444444,0.61025641,-0.982793723
+3103,38257.72024,918.5535714,459.6011905,1084.392857,33722.91071,728.0892857,758.2440476,1556.958333,19912.33929,554.2083333,1318.113095,1763.892857,26172.10119,1362.238095,2719.005952,3147.285714,9185.60119,1331.678571,331.5,2449.488095,19727.45833,1268.60119,171.2916667,700.3333333,24106.91667,1164.535714,128.3333333,2183.684524,18595.54167,1595.196429,573.3511905,2800.291667,16661.79167,610.5059524,293.4583333,1536.672619,12805.04762,1306.52381,428.7142857,1303.119048,9447.964286,666.9107143,169.3809524,3275.047619,8474.839286,1414.517857,579.827381,3263.577381,698.125,671.922619,168,20.52149581,10.61214601,0.855910844,0.913043478,0.646153846,0.191944592
+3104,21882.97895,793.7368421,462.8210526,1083.031579,20692.81053,655.4736842,896.5052632,1591.242105,10656.84211,482.1789474,1873.684211,1779.8,15490.65263,1228.663158,3832.968421,2274.136842,5694.031579,1213.221053,304.2736842,2618.463158,10913.05263,12040.94737,155.4631579,967.7684211,13316.10526,557.5473684,122.5789474,1217.210526,10143.49474,1935.873684,455.7263158,2792.378947,8754.336842,1113.505263,293.2631579,1451.736842,6658.568421,1524.042105,402.3157895,1309.242105,4580.831579,637.6315789,157.2315789,4122.536842,4139.863158,1217.673684,702.3684211,3176.621053,918.9263158,670.7473684,95,14.65652249,9.167126588,0.780253059,0.871559633,0.539772727,0.08440851
+3105,41038.54,836.18,577.2,1118.06,39113,701.0733333,695.9066667,1669.533333,20250.8,557.44,562.58,1782.44,25996.11333,1274.68,8263.626667,6221.92,9918.493333,1373.506667,350.96,2414.206667,19615.68667,438.7,1094.28,469.1933333,24267.73333,418.84,131.8066667,6480.96,18121.46,1593.166667,752.5933333,2812.393333,15626.58667,591.7666667,299.2666667,2562.08,9641.7,851.0066667,447.1933333,1308.713333,6934.52,837.08,169.3066667,3455.88,6121.213333,1331.82,266.2933333,3262.12,196.9133333,671.66,150,17.49510983,11.09495474,0.773189849,0.967741935,0.595238095,-0.475737387
+3106,40965.85075,919.0074627,533.4029851,1106.776119,39581.36567,732.238806,728.2089552,1654.425373,20794.88806,578.7910448,595.8059701,1783.686567,26459.74627,1288.447761,7126.313433,3717.970149,9735.335821,1378.626866,346.5447761,2352.402985,20601.49254,430.4104478,171.1865672,515.5970149,24408.72388,412.9477612,130.1119403,3800.514925,18831.08955,1614.014925,497.0671642,2812.141791,16426.27612,600.3731343,301.5895522,1612.813433,10684.98507,923.4477612,449.380597,1290.119403,8093.604478,736.5074627,172.6567164,2441.656716,7078.126866,1435.649254,176.238806,3371.179104,238.1119403,671.1865672,134,22.51451095,8.784942253,0.920734263,0.797619048,0.437908497,-0.953450515
+3107,29862.20635,875.6825397,531.1216931,1059.952381,29005.49206,688.015873,617.7619048,1526.37037,15483.21164,548.7195767,773.4814815,1750.206349,19529.53968,1242.481481,5804.746032,4172.650794,7115.994709,1339.322751,318.7671958,2414.253968,15124.55026,400.1164021,685.4656085,532.2222222,17547.60317,415.6931217,123.968254,3571.57672,13754.06878,1606.640212,556.6031746,2812.492063,11861.53968,603.9365079,286.8359788,1693.613757,8000.592593,970.3650794,422.1798942,1309.650794,6105.455026,755.5714286,167.989418,5166.248677,5477.78836,1296.867725,499.5185185,3331.502646,282.8095238,670.3597884,189,18.51455211,13.19126356,0.70169157,0.926470588,0.65625,1.179463382
+3108,27044.23026,904.0394737,763.0592105,1116.559211,23560.44737,674.25,720.6513158,1586.453947,13350.07895,531.6578947,489.7631579,1756.552632,18238.35526,1277,1805.598684,1281.776316,6404.098684,1291.743421,311.25,2365.375,13868.82237,482.5263158,253.1578947,482.5263158,16942.76974,433.4605263,118.9736842,958.75,12369.46711,1514.881579,580.7828947,2794.539474,11200.84211,906.625,261.7302632,1561.585526,8564.796053,831.8223684,393.4671053,1315.980263,6581.815789,733.4342105,155.5263158,1641.940789,5965.328947,1351.203947,841.0460526,3271.434211,648.7171053,670.9407895,152,17.4591989,11.82093674,0.735927212,0.88372093,0.678571429,-0.375892432
+3109,26933.38095,927.9365079,667.3015873,1128.174603,24614.04762,740.2698413,628.7142857,1665.047619,13568.04762,540,1053.079365,1785.063492,18908.26984,1342.333333,4193.301587,4202.15873,6724.380952,1286.555556,323.4761905,2598.936508,13846.55556,475.2063492,125.4444444,852.4603175,17306.34921,1863.365079,126.6507937,2443.428571,12534.44444,1510.412698,599.7619048,2784.52381,10944.63492,742.3968254,292.7301587,2018.428571,8633.380952,1209.222222,435.5079365,1303.15873,6402.888889,630.6666667,170.031746,3737.825397,5649.444444,1415.238095,765.4603175,3265.079365,727.7619048,669.3650794,63,13.95051741,5.91425635,0.905687793,0.9,0.692307692,-0.177975531
+3110,38793.23529,817.8941176,491.1294118,1095.070588,34119.28235,692.8,688.1529412,1610.129412,19353.85882,492.9764706,1519.458824,1743.976471,27077.45882,1256.870588,5586.152941,3062.164706,10095.57647,1303.517647,319.2823529,2457.258824,19639.02353,3061.376471,178.7647059,1777.482353,23801.36471,705.9058824,311.2588235,2804.188235,19259.42353,1995.611765,465.0823529,2840.870588,15956.04706,751.2352941,278.5647059,1278.447059,11739.95294,1264.670588,409.0352941,1302.305882,7111.717647,649.8117647,161.2705882,3321.435294,6876.317647,1274.294118,343.0705882,3209.376471,991.5176471,667.5529412,85,12.31594994,9.001138333,0.682535826,0.95505618,0.702479339,0.793672233
+3111,32721.79245,1019.641509,724.4779874,1113.660377,26886.81761,751.754717,725.836478,1568.974843,16227.13836,565.9559748,653.7169811,1751.446541,20738.64151,1379.36478,2114.283019,2006.616352,7603.685535,1369.893082,321.6037736,2433.503145,16153.32075,484.7987421,446.836478,602.7924528,19730.83648,573.1194969,125.2515723,1593.981132,14217.81761,1542.006289,682.6918239,2819.402516,12655.45912,876.0314465,289.7484277,1816.779874,9745.522013,923.7924528,430.591195,1350.616352,7579.698113,719.5534591,162.3836478,2026.72327,6627.320755,1437.503145,1575.742138,3235.484277,597.5408805,672.3522013,159,16.79502072,12.23938725,0.684778838,0.946428571,0.709821429,-0.523785304
+3112,40322.61333,937.72,459.7733333,1083.106667,34376.94667,758.4266667,836.68,1574.573333,21230.69333,582.24,585.8933333,1723.853333,28468.14667,1422.72,2327.84,1453.786667,10239.88,2256,360.0533333,2425.146667,20767.74667,462.3466667,578.2533333,638.6133333,25521.73333,470.5866667,138.32,1067.186667,20184.44,1665.933333,467,2846.8,17653.2,691.84,307,1351.266667,13520.30667,956.5066667,444.3466667,1331.986667,8988.186667,853.7466667,176.3466667,4113.093333,8413.973333,1449.346667,195.9466667,3204.746667,858.24,669.3466667,75,11.75288578,8.380049604,0.70114309,0.914634146,0.619834711,0.643204538
+3113,46381.40816,862.5306122,503.5714286,1117.714286,39109.97959,791.5918367,884.8979592,1654.530612,24287.61224,527.244898,1540.979592,1770.530612,31254.91837,1285.979592,3723.102041,2836.510204,11590.81633,1362.265306,335.4897959,2426.693878,23017,475.0816327,267.7959184,1666,27232.18367,455.4693878,375.244898,2318.755102,22338.10204,1801.653061,493.0612245,2789.346939,19044.28571,652.6938776,302.3673469,1313.163265,14196.53061,1233.326531,433.9387755,1326.632653,8845.306122,710.877551,172.9795918,6458.693878,8422.489796,1342.183673,297.0816327,3261.265306,933.6530612,667.244898,49,9.204142238,7.107795034,0.635332478,0.907407407,0.680555556,0.961065671
+3114,43219.77,878.77,597.27,1131.4,41214.52,721.11,634.75,1743.12,21432.11,568.53,506.1,1766.84,27896.18,1295.24,7746.49,7475.57,10596.36,1447.96,344.46,2346.38,21404.91,464.44,149.19,419.1,25833.26,434.27,139.07,6762.72,19496.94,1499.54,746.57,2824.09,16988.33,628.01,312.59,2461.06,10814.7,839.38,454.89,1312.31,7895.53,632.78,174.6,3049.14,6881.62,1354.43,156.02,3344.49,209.51,671.21,100,13.67167654,9.494106619,0.719554316,0.961538462,0.649350649,-0.558091996
+3115,44291.70504,875.0935252,540.0071942,1090.57554,41032.82734,715.4460432,531.057554,1663.841727,22618.2518,568.3021583,564.8776978,1766.798561,28695.20144,1277.460432,6472.618705,4067.517986,10964.4964,1395.971223,345.7338129,2375.776978,21353.56115,484.352518,141.8992806,437.6690647,25792.7482,420.8633094,131.1870504,4436.928058,20141.66187,1509.18705,575.3956835,2804.165468,17470.10072,610.6330935,299.5899281,2067.654676,10945.13669,852.8561151,432.676259,1304.71223,7904.676259,632.3453237,176.5683453,2924.057554,7143.359712,1314.690647,247.6690647,3348.158273,221.5899281,671.4100719,139,15.08279985,12.31212786,0.577624584,0.874213836,0.661904762,1.105595094
+3116,34214.70732,903.7195122,514.5731707,1095.04878,31667.21951,724.9390244,731.3292683,1593.097561,17772.06098,553.1097561,1526.52439,1852.829268,22657.60976,1314.646341,5264.890244,5022.073171,8419.317073,1394.731707,338.4268293,2416.256098,17782.73171,597.695122,355.8658537,888.402439,20541.36585,1096.768293,133.804878,2593.52439,15841.81707,1705.243902,608.5365854,2834.707317,13996.62195,635.8414634,306.695122,1449.865854,10353.47561,1453.621951,455.4146341,1316.060976,8033.780488,687.3170732,178.9146341,3667.378049,7170.45122,1399.768293,166.6463415,3280.817073,379.6463415,670.304878,82,10.79395171,10.00498714,0.375291622,0.901098901,0.621212121,-1.028960859
+3117,30230.07584,964.1629213,544.6011236,1101.488764,27765.66854,744.9522472,739.1516854,1571.379213,15858.5618,576.1601124,780.255618,1766.070225,21078.17135,1379.075843,2758.244382,3165.879213,7196.070225,1599.646067,358.6713483,2491.067416,15565.10112,480.3286517,634.0365169,693.9016854,18938.54494,507.2303371,131.2106742,1772.769663,14293.28371,1658.674157,758.6713483,2940.410112,12726.50843,1045.13764,304.4522472,1887.308989,9731.699438,1000.514045,460.3286517,1337.775281,7465.963483,833.0196629,175.7893258,4026.966292,6680.825843,1433.662921,343.4382022,3272.516854,552.5224719,674.1994382,356,29.34796869,17.03883527,0.814203412,0.86407767,0.605442177,-1.174473535
+3118,16764.68702,856.2748092,618.3969466,1100.427481,15098.12214,681.0076336,966.870229,1546.29771,8330.145038,871.9465649,875.3816794,1810.480916,11365.9084,1230.412214,2790.083969,2348.770992,4025.122137,1381.007634,333.0381679,2380.068702,8676.358779,488.6641221,748.8244275,1015.282443,10430.67939,466.3740458,112.9389313,1302.48855,7724.236641,1776.503817,610.9312977,2788.709924,7018.465649,989.7175573,264.7938931,1733.083969,5487.954198,1054.854962,404.9541985,1423.221374,4264.847328,788.6870229,157.8396947,4190.740458,3908.274809,1356.503817,392.3435115,3263.274809,637.3358779,671.6335878,131,15.27638992,11.22120326,0.678559451,0.929078014,0.668367347,-0.788131372
+3119,31961.11712,954.5315315,815.6936937,1188.135135,28128.66667,734.2162162,882.027027,1683.846847,16149.54054,552.6666667,679.8558559,1772.072072,21697.59459,1360.684685,1179.792793,1434.918919,7632.630631,1331,328.7837838,2400.333333,16379.62162,1831.216216,171.3783784,601.1351351,20043.27027,457.3693694,119.7477477,1338.081081,14650.56757,1543.054054,583.5315315,2815.702703,13026.28829,1049.603604,277.6396396,1547.297297,10166.00901,956.2882883,426.5585586,1333.369369,7549.810811,658.6846847,161.981982,1487.963964,6813.477477,1412.846847,630.6486486,3255.765766,664.5855856,670.954955,111,13.31476836,11.21010167,0.539586911,0.925,0.60989011,-1.351383874
+3120,25978.4902,794.3921569,516.3137255,1062.169935,26042.30719,644.4836601,564.7320261,1539.045752,13283.05882,516.875817,597.379085,1778.69281,16719.45098,1175.111111,7878.973856,4392.986928,6256.941176,1274.679739,308.1633987,2336.986928,13421.72549,386.9215686,222.875817,469.4836601,15435.99346,447.1503268,123.3464052,5033.555556,11910.22222,1428.163399,560.4248366,2803.954248,10451.53595,570.3660131,274.0849673,2516.098039,8461.79085,884.7189542,485.8366013,1370.052288,5540.228758,652.4901961,166.4379085,5180.444444,4790.281046,1274.849673,168.2679739,3296.882353,265.751634,674.8104575,153,21.2054429,9.560749013,0.892593177,0.889534884,0.566666667,-0.637150752
+3121,30550.95833,882.1770833,460.2083333,1040.125,28731.59375,684.09375,547.0833333,1477.510417,16363.41667,596.84375,865.0104167,1737.166667,20709.94792,1281.197917,2975.072917,3118.614583,7545.864583,1632.322917,326.9583333,2412.145833,16080.23958,436.8229167,231.8125,574.03125,19446.07292,853.375,128.40625,2542.8125,15283.8125,1532.020833,530.4270833,2819.40625,13245.94792,630.8541667,290.8020833,1278.822917,9336.479167,957.0833333,429.1354167,1302.40625,7087.416667,639.4791667,169.8333333,3644.395833,6503.9375,1303.510417,227.5,3352.1875,322.78125,670.5416667,96,12.22333967,11.08887872,0.420723429,0.872727273,0.527472527,-0.45485067
+3122,25572.51111,837.9555556,476.2111111,1039.477778,23035.44444,740.6888889,676.9555556,1468.444444,13442.95556,523.7333333,1314.433333,1763.3,17227.95556,1282.3,2743.644444,3455.1,6108.155556,1343.522222,330.8888889,2350.444444,13251.46667,427,1856.144444,958.6111111,15752.63333,679.6888889,126.5777778,1982.044444,12214.97778,1511.5,578.4222222,2819.344444,10784.04444,651.2888889,288.2,1605.7,8364.533333,1120.3,440.3333333,1403.544444,6317.811111,1034.9,173.1333333,3103.844444,5873.322222,1428.355556,483.2444444,3179.4,404.8666667,670.9111111,90,13.0637445,8.961333235,0.727630081,0.918367347,0.692307692,1.406658002
+3123,31604.8843,839.661157,538.661157,1088.710744,29317.65289,679.8595041,658.4793388,1511.07438,16553.7438,525.8016529,486.1404959,1753.090909,21617.20661,1267.504132,4535.206612,3902.165289,7860.165289,1390.528926,329.8429752,2367.884298,16965.41322,512.1322314,180.6363636,459.9256198,19851.61157,409.6694215,128.4132231,3385,14297.81818,1421.884298,791.8512397,2821.545455,12960.97521,840.2396694,297.6280992,2019.14876,9988.057851,827.1983471,451.1735537,1311.512397,7671.809917,657.4793388,171.1983471,3460.214876,6967.322314,1390.727273,1162.528926,3235.371901,478.107438,671.6528926,121,15.9287153,11.41978715,0.697144303,0.876811594,0.547511312,1.461062938
+3124,19935.27749,884.7382199,653.3926702,1063.82199,17653.62304,651.8795812,538.9790576,1465.120419,9926.502618,653.539267,510.8638743,1751.842932,13476.72251,1193.706806,4678.633508,2167.08377,4813.905759,1271.397906,294.1204188,2372.335079,10098.78534,3462.612565,622.6544503,519.3193717,12299.32461,475.921466,112.591623,1835.942408,9257.638743,1742.225131,764.565445,2789.08377,8167.670157,1251.534031,247.2041885,1593.366492,6452.78534,978.052356,379.6544503,1329.34555,4915.910995,762.8743455,154.1518325,4124.86911,4471.167539,1239.958115,199.9581152,3331.125654,624.3717277,676.1518325,191,19.53122416,12.62730815,0.762897857,0.945544554,0.606349206,0.407968912
+3125,38145.55882,890.9901961,495.7156863,1084.431373,34935.31373,740.9215686,843.1078431,1511.254902,19766.90196,553.7843137,2015.117647,1948.352941,26660.5,1338.039216,2365.098039,4577.627451,9526.647059,1335.058824,320.8823529,2522.803922,19933.01961,483.0196078,136.1960784,2218.441176,24432.70588,466.4803922,222.5392157,1202.362745,18199.79412,2362.245098,581.2156863,2815.470588,16348.2549,645.0784314,275.5098039,1478.264706,12945.7451,2064.078431,420.0980392,1310.098039,9528.254902,642.8431373,165.7647059,2656.107843,8447.205882,1394.382353,589.3333333,3281.04902,682.9411765,670.627451,102,12.63180138,11.41227311,0.428681439,0.902654867,0.607142857,1.397414534
+3126,35336.6044,824.3186813,624.2967033,1089.505495,31012.76923,688.967033,957.3296703,1577.725275,17895.74725,506.4395604,1238.758242,1797.747253,24199.71429,1214.527473,5975.879121,3720.703297,8869.472527,1274.714286,322.5274725,2487.758242,17485.52747,417.0879121,992.1868132,1017.472527,20875.58242,850.0769231,144.6923077,2832.384615,16956.48352,2303.428571,1091.10989,2811.857143,14660.84615,661.2637363,273.5274725,1677.956044,10883.6044,1268.791209,420.7032967,1318.901099,7244.065934,871.6813187,166.6703297,6655.857143,6571.21978,1271.461538,198.043956,3192.56044,897.043956,670.5934066,91,14.72513151,8.307946149,0.825636902,0.91,0.65,-1.208869026
+3127,35534.14815,824.4074074,503.1851852,1095.462963,32715.61111,704.9814815,899.962963,1644.814815,18058.14815,506.8888889,2105.888889,1869.296296,25081.46296,1229.888889,5272.259259,3717.796296,8915.851852,1255.481481,339.1851852,2393.037037,17785.03704,5582.462963,481.9814815,1357.055556,21656.05556,543.8518519,134.8148148,2628.703704,16562.92593,1886.092593,494.7222222,2783.166667,13879.01852,770.5,303.8148148,1464.833333,10544,2612.611111,412.9444444,1282.925926,7183.351852,765.4259259,166.1296296,6238.555556,6416.388889,1259.944444,400.8333333,3249.685185,926.5740741,669.2962963,54,10.68265565,6.695734258,0.779191804,0.931034483,0.675,0.806667823
+3128,32303.53968,775.2698413,499.5952381,1073.706349,28801.96032,730.4047619,850.1428571,1637.246032,16359.26984,482.0079365,957.968254,1787.857143,22460.95238,1237.34127,5378.952381,2841.714286,8359.888889,1250.722222,304.6269841,2460.444444,16708.80159,787.2301587,320.6428571,787.1349206,19753.42063,427.6190476,142.3095238,3924.301587,15905.00794,1817.365079,526.7301587,2788.436508,13734.12698,1929.571429,266.1587302,1575.126984,9958.873016,1060.84127,400.5396825,1298.928571,6550,674.2142857,165.3571429,5068.650794,6194.253968,1216.761905,194.1507937,3214.031746,949.5634921,671.5793651,126,15.0015879,10.99176172,0.680544717,0.954545455,0.7,1.434027912
+3129,35922.36,853.07,556.04,1105.79,32137.11,720.91,801.69,1678.75,17835.01,502.32,1380.27,1839.27,24289.15,1274.8,6932.04,3630.28,8942.94,1301.06,329.26,2620.94,17412.81,533.04,205.62,1140.78,20836.21,447.67,140.42,3253.33,16628.05,2293.24,614.59,2801.3,13933.81,866,282.1,1440.87,10320.76,1178.87,411.19,1316.69,6540.18,635.98,165.98,5171.69,6181.76,1285.77,838.9,3239.73,969.8,671.05,100,12.34586619,10.79349749,0.485457908,0.917431193,0.641025641,1.39812331
+3130,24513.19512,823.9918699,475.7723577,1058.804878,23807.21951,651.5447154,581.9105691,1521.065041,12874.44715,521.9674797,542,1746.333333,16095.74797,1200.422764,6618.739837,2515.829268,6043.788618,1309.634146,314.7479675,2321.365854,12969.72358,498.4471545,828.0406504,484.4634146,14863.68293,433.9105691,120.7804878,2676.95935,11551.6748,1608.512195,572.398374,2796.235772,9984.691057,634.8373984,267.2520325,1450.813008,7090.235772,885.4552846,418.6422764,1308.97561,5439.772358,811.9268293,162.9512195,2695.528455,4743.715447,1291.463415,177.5447154,3363.894309,304.504065,673.9430894,123,14.77165832,10.91532863,0.673774247,0.953488372,0.745454545,0.233662032
+3131,27369.61321,996.6698113,588.0377358,1096.603774,22885.42453,728.3207547,510.3773585,1606.877358,12899.81132,556.7641509,540.745283,1782.509434,16362.99057,1245.924528,9642.349057,3920.132075,6130.801887,1340.566038,315.0471698,2369.839623,12662.49057,428.8396226,555.745283,499.2075472,14601.60377,416.0660377,128.5566038,4107.45283,11354.69811,1859.04717,725.745283,2866.122642,10040.86792,640.990566,284.9150943,1590.669811,7382.764151,973.9245283,427.8584906,1304.254717,5702.311321,718.5283019,169.8113208,3310.018868,5148.792453,1294.5,144.7641509,3373.311321,366.3584906,672.3301887,106,18.89443504,7.930813132,0.907642845,0.883333333,0.509615385,-0.996647628
+3132,35704.82178,896.039604,564.2673267,1115.356436,31364.86139,731.5049505,673.6138614,1640.90099,18784.08911,560.970297,498.9207921,1801.217822,24357.87129,1325.39604,4254.415842,3291.029703,8481.108911,1410.990099,349.9207921,2367.455446,18078.13861,474.5346535,307.2673267,471.2673267,22048.38614,424.7128713,144.3366337,3164.306931,16605.70297,1526.287129,764.6336634,2814.594059,14694.19802,684.5841584,305.2277228,2056.524752,11341.9802,884.8217822,460.4356436,1318.049505,8563.316832,700.009901,173.8613861,3436.732673,8025.851485,1438.762376,208.8811881,3288.217822,531.2475248,672.8910891,101,14.38338635,9.656865252,0.741104002,0.935185185,0.561111111,-1.198043676
+3133,51680.64706,959.1960784,524,1126.745098,46126.23529,803.9019608,619.6862745,1648.647059,27003.03922,585.5294118,899.4901961,1748.215686,34780.41176,1394.411765,3109.235294,2650.686275,12643.4902,1379.666667,348.1372549,2331.196078,26364.07843,498.7843137,251.254902,691.372549,32634.17647,479.3333333,204.9411765,2232.215686,23856.56863,1816.117647,641.0196078,2800.019608,21436.4902,646.7647059,308.3333333,1596.823529,16551.70588,939.7254902,439.9803922,1295.45098,11760.54902,708,176.4509804,2529.529412,10525.68627,1462.784314,225.3921569,3313.392157,759.7843137,672.5490196,51,9.317842462,7.970714579,0.517926846,0.894736842,0.566666667,-0.039925524
+3134,36195.69014,815.7887324,501.2816901,1074.366197,32634.33803,682.1267606,889.6338028,1608.661972,18263.28169,505.2535211,2366.549296,1755.042254,25415.05634,1200.408451,7997.84507,4977.830986,9043.816901,1304.676056,332.3521127,3162.394366,18188.60563,508.7464789,1012.140845,1075.788732,22272.08451,569.7746479,276.3239437,2013.507042,17347.73239,2635.197183,588.8732394,2810.873239,14946.85915,613.8591549,282.2535211,1485.873239,11155.98592,1752.802817,406.3802817,1308.830986,7540.901408,872.7746479,154.8169014,4581.309859,6751.788732,1262.929577,273.5774648,3205.549296,907.6056338,672.3802817,71,11.37067687,8.491329038,0.66507757,0.934210526,0.645454545,1.041157548
+3135,25077.1,810.4,495.3538462,1056.869231,23415.69231,665.9846154,724.5,1507.976923,13113.46923,508.1384615,911.4538462,1778.015385,17100.37692,1224.846154,3446.230769,2977.746154,6187.615385,1313.584615,318.8461538,2427.807692,12979.51538,4519.923077,293.0769231,531.3076923,14981.46154,798.5384615,127.0384615,3127.930769,11679.23077,1583.061538,595.4076923,2813.323077,10312.06923,693.7769231,273.3615385,1441.4,7753.823077,1207.476923,434.7769231,1385.8,5994.776923,686.8923077,171.0307692,5217.776923,5394.269231,1358.092308,504.2461538,3223.915385,389.3384615,675.2538462,130,15.08198266,11.13590388,0.674408878,0.928571429,0.677083333,-0.24011347
+3136,33234.85294,955.625,528.7573529,1103.647059,30772.93382,741.0735294,610.9044118,1517.985294,17446.90441,582.1102941,628.3970588,1756.522059,22708.69118,1375.183824,2807.801471,3824.691176,7885.786765,1416.911765,350.0367647,2363.088235,17663.80147,505.7132353,242.4705882,527.6985294,20244.83088,434.3308824,140.9264706,2585.036765,15314.13971,1574.147059,763.3676471,2846.235294,13679.13235,644.1029412,310.7941176,1829.323529,10767.41912,973.6544118,459.9632353,1305.713235,8309.889706,709.9632353,182.8014706,2925.007353,7350.007353,1510.919118,4851.477941,3229.779412,440.4411765,674.6617647,136,15.56333352,11.55611939,0.669821545,0.912751678,0.607142857,-1.250953018
+3137,34330.35211,966.6619718,558.5352113,1079.774648,31493.78873,740.9577465,622.6056338,1569.478873,17426.56338,564.0704225,906.1126761,1796.915493,23799.23944,1291.408451,3717.901408,3399.549296,8390.225352,1283.873239,323.6760563,2361.760563,17359.83099,475.2112676,169.9295775,890.2253521,21754.94366,479.7323944,124.1267606,3003.253521,15780.76056,1743.704225,605.6056338,2800.591549,13789.76056,743.8450704,270.2394366,1887.112676,10764.26761,1210.070423,413.8732394,1308.901408,8014.126761,651.0140845,164.971831,3518.971831,7104.15493,1354.183099,431.4225352,3351.225352,744.0985915,673.4225352,71,13.91746513,6.647817095,0.878544749,0.898734177,0.591666667,-0.651914632
+3138,41472.43478,879.4347826,493.0217391,1087.152174,36701.45652,744.4347826,738.3478261,1638.26087,21844.43478,543.173913,1270.326087,1812.478261,28413.78261,1316.173913,3657.652174,3751.478261,10392.5,1332.108696,328.9565217,2354.195652,21317.3913,529.9347826,116.1956522,1164.347826,26452.1087,494,132.2173913,2094.891304,19724.21739,1910.717391,682.0869565,2785.086957,17524.15217,770.8043478,294.5434783,1763.869565,13585.8913,1457.652174,421.6086957,1301.76087,9595.108696,653.5652174,163.5652174,3313.608696,8733.826087,1399.173913,353.8043478,3295.347826,752.9782609,671.4782609,46,8.623811334,7.14185267,0.560499116,0.93877551,0.821428571,-0.480220774
+3139,33574.40244,900.6219512,737.1829268,1155.146341,29108.45122,754.0853659,1079.402439,1691.353659,17494.23171,560.7073171,610.5121951,1749.878049,22995.5,1349.45122,1973.012195,1491.792683,8111.939024,1376.109756,339.7926829,2355.695122,16917.12195,533.9146341,287.4268293,653.4634146,20301.35366,487.0487805,141.6463415,1564.768293,16031.34146,1535.731707,493.902439,2805.987805,14158.65854,929.4878049,297.3902439,1571.95122,10708.81707,932.9512195,440.6707317,1334.378049,7615.353659,679.3658537,167.2195122,2136.792683,6918.134146,1420.256098,202.304878,3349.560976,796.8536585,672.7682927,82,11.50297678,9.273190102,0.591703485,0.964705882,0.621212121,-1.3451174
+3140,38080.2069,848.8390805,528.6206897,1104.701149,35703.89655,715.816092,844.1954023,1656.609195,18764.45977,512.2758621,1512.586207,1811.712644,26196.28736,1229.735632,5546.735632,3678.195402,9548.367816,1378.747126,334.4252874,2392.448276,18860.51724,443.3678161,149.7356322,1457.850575,22666.70115,444.2183908,156.8390805,4639.114943,17896.21839,2095.356322,653.0229885,2791.103448,14850.55172,623.0689655,278.2183908,1338.321839,10875.74713,1311.252874,415.6091954,1305.896552,6884.16092,634,163.7816092,3461.103448,6422.045977,1273.908046,266.4482759,3224.931034,985.1149425,673.091954,87,13.30823099,8.588521491,0.763883551,0.97752809,0.608391608,1.068648251
+3141,16187.75,1335.361111,571.2777778,1028.305556,19193.61111,793.8611111,721.0555556,1349.444444,7234.611111,645.0555556,475.9722222,1701.444444,12194.22222,1290.027778,2886.305556,2008.305556,3931.777778,1338.75,297.9722222,2314.972222,8087.083333,363.5,310.7777778,454.3055556,10987.94444,401.9444444,114.4722222,1747.666667,6882.666667,1431.333333,468.75,2766.722222,5790.583333,566.1111111,235.3611111,1268.916667,4540.638889,756.1111111,354.2777778,1279.361111,3971.888889,647.4166667,141.1944444,2083.361111,2925.722222,1076.444444,142.9444444,3570.111111,851.5833333,672.7777778,36,7.743572758,6.255864958,0.589349247,0.923076923,0.5625,0.498055462
+3142,21179.07609,716.9673913,547.5869565,1060.206522,20183.28261,619.576087,447.6086957,1537.521739,9910.73913,461.1304348,559.4347826,1727.804348,13915.92391,1067.543478,3782.565217,2304.956522,5452.597826,1378.76087,297.1956522,2318.086957,10356.32609,479.7065217,2857.271739,623.0217391,12963.36957,421.1956522,128.923913,2117.858696,10106.02174,1776.554348,523.6521739,2806.293478,8341.76087,692.2717391,242.6521739,1258.402174,5849.402174,878.9456522,377.076087,1303.23913,3189.402174,1326.771739,152.5652174,3147.021739,3318.673913,1130.097826,765.923913,3162.065217,1051.804348,675.0217391,92,11.80075836,10.48146911,0.459451205,0.92,0.638888889,0.703754135
+3143,29510.10667,892.08,515.68,1066.56,28234.06667,677.6266667,659.1733333,1553.16,15109.94667,558.3333333,598.0133333,1740.773333,19183.98667,1210.666667,5714.186667,5348.213333,6930.786667,1309.346667,320.9466667,2349.16,14702.21333,387.1866667,210.6266667,452.72,17092.09333,412.76,123.4933333,3954.666667,13264.82667,1506.453333,535.6,2789.013333,11483.68,579.7733333,269.4266667,1796.32,9035.693333,998.1866667,518.3333333,1410,5781.426667,1197.426667,155.5066667,2858.92,5053.693333,1932.306667,177.8266667,3347.32,249.3733333,673.2133333,75,14.25729925,6.902018735,0.875010345,0.9375,0.625,1.446103917
+3144,28726.38462,989.5076923,608.0615385,1111.230769,25413.66154,738.8,617.2615385,1543.307692,14889.82308,570.6076923,532.8692308,1745.315385,19589.78462,1342.738462,3036.976923,2828.707692,6543.330769,1506.061538,332.6307692,2346.361538,14643.59231,634.2,363.4076923,471.3230769,17155.53077,425.7615385,126.9846154,3180.492308,12694.20769,1527.753846,680.5692308,2814.4,11306.12308,1254.176923,287.6923077,1576.246154,8650.069231,883.8307692,440.5076923,1314.853846,6631.069231,707.2461538,168.4,3760.392308,5928.530769,1371.553846,633.6076923,3292.623077,469.2,677.1,130,16.09621773,10.79833703,0.741582425,0.955882353,0.577777778,0.690283307
+3145,29993.40833,786.8375,480.7833333,1078.125,27675.98333,957.9666667,1009.458333,1665.4125,14808.44583,495.85,2826.083333,1906.145833,20479,1213.6625,5021.654167,3409.666667,7652.1625,1253.733333,306.725,2974.5125,15088.28333,2957.045833,296.3958333,2391.466667,18185.65833,458.8833333,1174.545833,2384.445833,14249.05417,2478.004167,481.0416667,2814.395833,12080.73333,1615.2875,266.5041667,1315.425,8813.545833,1346.0875,409.0875,1314.05,5861.9375,660.5958333,158.7833333,4278.525,5455.579167,1235.6625,529.6416667,3207.1125,958.0958333,681.2166667,240,21.35661917,15.36652516,0.694471209,0.882352941,0.634920635,-0.619642486
+3146,40872.17986,899.3597122,596.6690647,1141.043165,22494.28777,548.0143885,413.4964029,1485.381295,10428.8777,407.5827338,554.057554,1654.856115,15492.93525,1020.776978,6111.330935,2659.956835,5917.05036,1046.553957,279.8633094,2398.079137,11152.71942,338.0215827,206.1942446,521.4604317,13627.33813,361.0791367,114.5467626,4632.043165,10590.7482,1583.42446,439.0647482,2781.417266,8482.942446,530.1079137,241.6690647,1159.143885,5497.28777,737.028777,361.5899281,1260.928058,2760.47482,568.5323741,144.4388489,2720.748201,2947.136691,996.1366906,607.8417266,3134.517986,1079.76259,675.7338129,139,14.62012468,12.44443374,0.524865465,0.932885906,0.620535714,1.108470685
+3147,44282.31452,879.3709677,624.7903226,1130.064516,38757.03226,704.5725806,577.2983871,1710.08871,19121.26613,538.1532258,474.6612903,1780.782258,25637.75,1278.959677,8827.870968,5421.153226,9595.556452,1352.483871,338.6209677,2319.677419,19222.50806,423.9758065,214.016129,437.6612903,23322.30645,447.1451613,134.2580645,8578.862903,17288.57258,1494.153226,737.1370968,2804.854839,14732.68548,594.9919355,302.3145161,5089.532258,8022.080645,824.7822581,433.6451613,1312.177419,5578.959677,627.0806452,168.6854839,3490,5188.112903,1273.887097,267.6129032,3229.298387,159.1612903,676.5967742,124,14.8483763,11.07124868,0.666371203,0.918518519,0.688888889,-1.52071452
+3148,47366.74167,1153.483333,560.7333333,1093.55,43945.79167,829.8916667,917.7416667,1667.158333,24901.80833,680.9416667,1038.275,1753.341667,31001.3,1452.083333,5893.925,3555.541667,10490.10833,1482.791667,358.1583333,2450.4,23434.175,471.7083333,217.4083333,530.1,27640.14167,1069.85,140.5083333,3008.191667,22051.36667,1669.55,596.3416667,2825.083333,19077.70833,652.9083333,332.575,1511.5,13305.475,1085.841667,476.85,1312.625,9970.133333,684.1166667,181.1666667,3157.941667,8939.75,1440.683333,208.125,3549.241667,315.2583333,677.5416667,120,15.27692863,10.22675719,0.742879691,0.909090909,0.659340659,0.449779154
+3149,19298.52033,1083.195122,505.7560976,1034.300813,18122.65041,738.1463415,456.9186992,1451.056911,9942.447154,602.6666667,506.0081301,1738.626016,12464.07317,1280.325203,2123.634146,1415.829268,4485.845528,1611.544715,301.7723577,2319.056911,9756.878049,384.4471545,269.5772358,429.4796748,11368.50407,414.2520325,118.8536585,2179.195122,8959.569106,1430,473.3902439,2847.081301,7824.585366,590.1869919,269.1544715,1163.837398,5554.097561,781.9837398,405.0081301,1310.406504,4263.373984,626.1869919,169.3658537,2206.276423,3871.414634,1209.357724,163.4878049,3418.878049,330.7154472,677.6747967,123,15.34657932,10.68387898,0.717873747,0.938931298,0.602941176,-1.530688859
+3150,34390.12,984.3066667,583.68,1093.36,30501.4,734.16,734.82,1526.306667,17287.31333,585.9533333,641.4266667,1745.36,22826,1396.04,4231.74,3075.453333,8238.16,1435.166667,347.4133333,2419.533333,17433.86,766.24,316.96,531.0466667,20671.66667,452.7666667,176.2,3698.946667,15516.14,1601.56,721.04,2800.58,13836.55333,1053.673333,302.1466667,1773.686667,10919.87333,909.3733333,448.6866667,1311.173333,8365.793333,784.2266667,174.5133333,3913.96,7549.706667,1441.84,788.1866667,3360.68,457.6133333,678.4133333,150,15.62088252,12.89272433,0.564618738,0.920245399,0.625,0.556133575
+3151,43523.62338,1080.87013,671.5844156,1217.831169,38487.53247,863.1948052,606.4025974,1734.844156,22536.75325,618.8311688,731.7142857,1752.25974,30098.80519,1630.311688,3559.61039,2669.116883,10238.05195,1489.909091,417.7532468,2412.584416,21858.49351,543.974026,139.2337662,753.5974026,27878.46753,809.7272727,138.5844156,2435.584416,20412.46753,1869.623377,574.974026,2796.649351,17786.46753,669.1298701,348.7142857,1759.883117,13660.22078,1220.623377,473.2597403,1333.714286,10065.92208,709.2337662,190.3766234,2559,9022.597403,1643.337662,181.4935065,3299.103896,734.5584416,675.8181818,77,11.53179696,9.007518265,0.624402515,0.895348837,0.583333333,0.425552281
+3152,38806.34722,913.3055556,486.2361111,1092.861111,34545.29167,726.3194444,911.0972222,1612.652778,20567.625,556.9027778,1981.680556,1738.583333,27147.55556,1327.805556,6011.555556,4003.111111,9740.986111,1377.277778,352.3055556,3023,19960.27778,433.3472222,761.3611111,1877.152778,24346.80556,466.4166667,135.1666667,2235.347222,18915.84722,2463.180556,557.7222222,2792.708333,16782.16667,647.8888889,292.9583333,1561.486111,12683.79167,2071.805556,433.4305556,1350.861111,8373.680556,833.1527778,170.8472222,4871.055556,7683.333333,1390.805556,316.6527778,3200.555556,867.4444444,675.5138889,72,10.57582277,9.073132084,0.513795576,0.947368421,0.654545455,1.365186657
+3153,44457.84783,853.7826087,482.4565217,1128.217391,37849.1087,750.6521739,753.2826087,1641.565217,23128.56522,525.0434783,2192.543478,1815.978261,30012.06522,1284.826087,4364.565217,3673.521739,11251.78261,1329.847826,351.0869565,2445.891304,22742.21739,462.5652174,379.5869565,1807.956522,26783.04348,479.9130435,176.1956522,1599.76087,21715.73913,2167,544.6956522,2781.369565,18744.08696,651.5869565,294.3695652,1290.847826,13940.54348,1640.717391,426.5652174,1333.717391,8663.043478,700.7608696,167.9130435,4408.695652,8400.434783,1358.326087,310.9782609,3315.695652,935.326087,675.1304348,46,8.345055265,7.005866815,0.543323968,0.978723404,0.821428571,-1.380884645
+3154,35348.19231,922.7788462,634.7884615,1110.769231,35053.13462,715.5192308,716.1538462,1659.192308,18270.60577,576.1826923,774.4134615,1736.365385,23223.29808,1287.480769,9184.509615,5922.365385,8451.884615,1373.576923,332.9038462,2388.730769,18361.67308,423.8846154,454.0961538,506.7019231,21893.84615,436.2596154,133.6826923,6471.971154,17050.52885,1618.134615,615.1634615,2850.634615,14807.33654,649.0769231,309.2403846,2235.259615,9967.759615,936.5096154,447.0480769,1315.240385,7722.836538,721.9038462,177.4038462,7326.788462,6779.125,1398.240385,193.4423077,3306.894231,273,679.8846154,104,15.46783634,9.076297425,0.809742632,0.920353982,0.495238095,-0.756640434
+3155,26689.70714,1104.457143,660.0571429,1113.092857,19519.21429,724.0357143,637.9357143,1563.85,11204.77143,571.6642857,1172.371429,1784.221429,13774.71429,1297.292857,4710.964286,2747.407143,4875.035714,1414.414286,316.7428571,2488.407143,9174.064286,379.15,622.4928571,813.4142857,10714.86429,474.8785714,124.0285714,4650.321429,8396.778571,1899.628571,576.3071429,2823.3,7461.192857,865.1214286,270.5,1627.471429,5362.228571,1224.878571,424.0142857,1379.95,4149.721429,725.6857143,170.3285714,4724.742857,3561.892857,1245.757143,164.0214286,3391.157143,353.6071429,680.3785714,140,14.41220272,12.99165526,0.43291573,0.903225806,0.549019608,-1.071524269
+3156,38743.0597,1015.597015,590.1044776,1102.253731,35044.44776,759.6567164,504.5223881,1638.283582,19563.53731,585.5074627,743.6268657,1739.238806,24336.32836,1370.149254,8579.477612,4125.731343,8695.328358,1426.477612,342.2835821,2353.940299,18557.1791,449.3432836,497.7164179,629.9253731,21494.08955,792,133.7910448,3741.597015,16967.62687,1715.820896,610.0447761,2807.119403,14963.97015,649.4029851,314.0746269,1458.044776,10936.20896,1089.895522,446.5970149,1329.791045,8310.477612,737.880597,176.6716418,3520.134328,7458.149254,1386.850746,150.8656716,3426.895522,370.7910448,677.8059701,67,13.13433213,7.067499955,0.842885097,0.848101266,0.468531469,-0.950696965
+3157,15500.77551,776.3877551,441.6285714,1058.706122,13994.53469,625.8938776,620.555102,1462.35102,7968.420408,489.2285714,540.7632653,1785.277551,10296.54286,1186.693878,1265.922449,1421.926531,3771.518367,1272.408163,300.1591837,2348.620408,8331.636735,433.5142857,234.244898,776.9428571,9483.228571,440.1346939,116.5591837,980.3142857,7272.685714,1404.910204,567.3306122,2818.938776,6608.269388,690.8653061,266.0530612,1618.02449,5111.934694,868.3306122,414.9469388,1324.832653,3953.734694,1302.179592,162.5959184,2384.012245,3659.910204,1344.873469,1491.326531,3202.914286,419.877551,682.5265306,245,23.29297365,14.0933655,0.796189049,0.907407407,0.618686869,-0.701386379
+3158,34173.42623,952.6065574,509.6557377,1071.901639,29784.68852,740.9344262,700.7377049,1530.639344,17560.93443,599.2459016,1725.95082,1820.704918,23959.16393,1352.655738,5009.737705,3710.688525,8343.377049,1331.803279,309.9016393,2348.688525,17354.59016,898.5901639,748.1967213,1549.918033,21833.18033,488.9344262,122.7213115,1448.672131,16526.90164,2207.737705,660.9836066,2791.016393,14829.21311,652.3278689,273.6393443,1423.901639,11493.08197,2139.47541,422.147541,1288,8398.262295,912.852459,165,2763.885246,7670.704918,1391.131148,294.8360656,3261.606557,689.4262295,677.3606557,61,9.870734784,8.37680442,0.528953928,0.924242424,0.61,0.936097237
+3159,33344.15888,831.5046729,481.0093458,1067.037383,30804.08411,673.1308411,746.3551402,1529.878505,17468.20561,553.3738318,965.2897196,1762.028037,23686.51402,1260.46729,3222.570093,4095.700935,8418.439252,1347.383178,318.0186916,2350.570093,17887.59813,437.953271,438.9813084,942.5700935,22171.46729,844.728972,135.317757,2123.299065,16269.84112,1516.196262,650.0373832,2789.700935,14483.5514,647.3925234,272.8037383,1746.663551,11238.11215,1252.981308,401.1121495,1312.046729,8409.616822,795.046729,160.5700935,3274.728972,7531.299065,1356.551402,577.9065421,3205.635514,708.7009346,679.2429907,107,14.66089271,9.508984663,0.761133539,0.955357143,0.713333333,0.208682564
+3160,39335.76966,859.494382,570.4606742,1098.353933,34046.95506,700.6516854,890.0561798,1564.247191,20755.65169,562.6067416,1026.876404,1785.595506,27357.67416,1272.393258,3632.870787,3484.882022,9924.842697,1307.735955,322.6797753,2508.938202,20540.8427,441.2359551,833.9550562,1352.185393,25150.34831,434.5955056,343.3876404,2267.337079,18884.92697,1876.235955,573.5730337,2790.634831,16791.51124,689.6348315,274.8258427,1636.258427,12872.00562,1115.539326,418.8089888,1335.05618,9079.140449,827.0898876,165.3651685,3599.404494,8217.955056,1339.820225,236.7752809,3272.207865,770.7921348,680.2303371,178,18.83713964,12.71748089,0.737700583,0.912820513,0.615916955,0.622337197
+3161,40501.3875,905.275,489.1875,1087.55,36385.93125,742.51875,702.5,1595.1,20631.85625,550.13125,1039.3125,1782.01875,28975.59375,1352.44375,2967.71875,3654.1625,10576.63125,1450.0625,351.69375,2448.8875,21221.78125,445.55625,425.8,961.45,26339.05,481.125,366.90625,2480.8375,20063.1625,1792.84375,561.15,2814.70625,17497.3875,678.50625,296.7375,1827.00625,13564.85,1131.91875,434.675,1322.36875,9368.23125,744.875,175.68125,3219.6625,8514.48125,1411.99375,379.08125,3219.73125,842.88125,678.61875,160,20.26295677,11.66453312,0.817690571,0.837696335,0.647773279,-1.496488692
+3162,27853.80049,899.8077859,750.2189781,1120.990268,25694.94891,797.3260341,980.5036496,1641.678832,14445.70316,563.6836983,877.1265207,1802.776156,19093.3528,1353.605839,3820.043796,2848.863747,6711.311436,1390.479319,335.7201946,2481.250608,14544.79562,595.3600973,608.6861314,748.7226277,17571.86375,467.729927,735.8734793,2206.012165,12849.68127,1780.420925,703.2408759,2825.447689,11624.72506,786.8126521,297.7177616,1893.340633,9030.462287,1012.184915,458.9586375,1352.038929,6931.951338,800.0948905,177.3381995,3642.832117,6166.313869,1455.274939,564.6301703,3289.768856,518.7688564,683.5182482,411,29.15395113,19.33642755,0.748395802,0.870762712,0.611607143,-1.567626181
+3163,27784.90299,899.2350746,526.4626866,1066.75,24697.44403,698.7723881,483.6753731,1472.634328,14043.14552,565.2164179,521.4552239,1701.44403,19011.6194,1319.791045,2014.91791,2341.223881,6805.873134,1330.828358,328.4365672,2338.261194,14662.27985,460.4141791,464.1791045,518.7425373,17748.90672,489.6679104,120.2761194,2066.735075,13178.06343,1495.343284,679.9440299,2812.264925,11768.03731,1034.597015,273.488806,2007.813433,9110.817164,871.7910448,407.011194,1319.902985,6899.958955,742.358209,161.8880597,2406.227612,6237.44403,1356.048507,773.4850746,3202.044776,606.8880597,685.1455224,268,22.85002592,15.99327228,0.714217727,0.848101266,0.641148325,-0.04300902
+3164,32288.87368,987.6526316,831.4421053,1161.873684,27771.84211,748.1894737,855.0421053,1671.052632,16335.22105,583.9684211,455.1473684,1758.526316,21379.87368,1378.378947,1729.494737,1559.831579,7583.115789,1346.031579,328.0421053,2368.557895,16372.17895,572.2631579,224.6526316,463.5157895,19981.76842,459.6315789,124.9368421,1144.705263,14823.29474,1540.094737,583.7368421,2789.526316,13271.41053,721.8,282.0842105,1523.221053,10059.83158,872.5578947,417.2947368,1338.463158,7511.526316,697.3368421,157.3052632,1643.6,6764.768421,1395.410526,374.3157895,3350.821053,658.6105263,679.9578947,95,12.43366724,9.938817643,0.600869357,0.95,0.608974359,0.548446406
+3165,22777.28866,828.2268041,522.3195876,1055.896907,21246.16495,700.628866,1088.721649,1543.257732,11283.23711,503.2886598,2061.164948,1771.113402,15982.10309,1221.185567,5368.484536,4186.494845,5755.134021,1223.463918,299.742268,2732.268041,11584.38144,557.6701031,493.5670103,2424.670103,14374.15464,1483.43299,128.0515464,1789.412371,10858.50515,1862.185567,450.4639175,2792.670103,9302.525773,706.6907216,265.3917526,1351.721649,7183.010309,3117.206186,410.9175258,1313.298969,4986.381443,691.7525773,161.628866,5510.309278,4589.876289,1244.103093,542.2783505,3337.742268,927.0309278,680.1134021,97,12.30153797,10.23625886,0.554607444,0.932692308,0.678321678,0.077060718
+3166,29799.8481,806.278481,517.2278481,1085.607595,27356.44304,839.6582278,870.1898734,1653.518987,15010.13924,496.7088608,1370.341772,1843.696203,20511.50633,1182.367089,6380.924051,2310.417722,7542.632911,1297.962025,313.443038,2626.594937,15362.18987,705.4936709,762.9113924,735.9873418,18468.16456,450.1139241,258.6455696,1862.886076,14329.70886,2137.012658,704.6962025,2831.721519,12443.59494,1698.886076,271.0886076,1324.303797,9218.088608,1341.253165,405.6835443,1391.582278,6184.126582,751.4177215,170.3291139,5869.78481,5741.860759,1269.253165,209.4683544,3261.594937,944.3924051,680.5949367,79,14.04784874,7.917255953,0.826053264,0.831578947,0.564285714,0.303374378
+3167,34149.6092,804.045977,511.7816092,1091.471264,31809.11494,694.816092,848.7011494,1635.034483,17002.85057,500.2988506,2695.137931,1827.747126,23524.29885,1290.586207,7624.425287,3317.103448,8721.91954,1268.62069,319.9655172,2760.264368,17010.02299,984.7701149,190.6436782,1584.068966,20152.98851,468.1494253,134.4482759,1927.045977,16193.71264,2685.022989,618.1724138,2813.655172,13490.98851,726.6091954,288.137931,1273.91954,9927.666667,1526.068966,413.6091954,1311.482759,6370.528736,606.8275862,166.8505747,4473.310345,6078.356322,1240.609195,251.9655172,3227.758621,971.7471264,680.7126437,87,13.13694294,8.808074606,0.741926427,0.925531915,0.669230769,-0.723894115
+3168,35362.76623,801.8506494,538.9285714,1066.876623,32629.43506,667.9675325,762.0064935,1606.75974,17345.03896,490.7662338,2354.792208,1916.551948,24503.74675,1191.616883,6117.318182,3964.551948,9107.136364,1277.006494,308.512987,2475.941558,17692.2013,412.4220779,293.8051948,1612.357143,21065.01299,441.6688312,125.961039,2598.415584,16777.92208,2318.142857,652.0194805,2821.311688,13956.81818,595.3116883,265.487013,1414.590909,10230.59091,2043.701299,399.6558442,1317.519481,6406.038961,649.8376623,164.1688312,5816.097403,6057.376623,1229.25974,268.0194805,3181.506494,982.0649351,683.0584416,154,16.01599562,13.9345243,0.492984719,0.806282723,0.534722222,-1.371244287
+3169,44313.03684,881.7789474,608.7210526,1136.789474,35823.15789,676.4631579,561.2631579,1681.468421,17556.71579,525.7473684,547.2894737,1767.842105,23302.97895,1243.057895,7239.694737,5801.410526,8653.610526,1320.152632,328.3105263,2407.642105,18121.51579,404.5421053,162.7368421,496.3842105,21561.93684,432.4526316,127.8315789,6649.684211,16045.91053,1635.757895,512.6842105,2811.110526,13647.74211,617.6947368,295.5157895,3878.794737,7605.889474,819.2052632,416.7631579,1310.326316,5437.105263,641.2105263,162.0578947,3380.268421,4907.426316,1257.326316,227.4736842,3231.147368,167.1105263,683.1315789,190,24.55460859,10.61720526,0.901685947,0.844444444,0.532212885,-0.973159783
+3170,38125.79333,836.0466667,550.3333333,1111.393333,36091.42,693.0666667,454.2866667,1696.973333,18845.65333,548.7466667,508.7933333,1759.52,24262.38,1244.193333,6556.853333,5124.626667,9222.92,1347.713333,334.4733333,2338.466667,18621.47333,466.9466667,441.5866667,423.7266667,22374.59333,430.2,129.42,4382.66,17056.10667,1494.513333,746.36,2798.32,14648.4,593.16,292.4666667,2151.166667,8822.866667,802.0533333,426.7333333,1308.626667,6453.213333,703.36,161.9466667,3815.033333,5608.306667,1310.86,178.32,3266.64,200.66,683.6933333,150,20.82597568,9.607866175,0.887223161,0.931677019,0.462962963,-0.730262419
+3171,19408.0283,878.6509434,556.3962264,1028.735849,18740.62264,643.5943396,510.5943396,1526.132075,9913.981132,544.990566,586.0377358,1759.783019,12621.9717,1169.971698,6505.056604,3621.509434,4815.679245,1258.830189,289.6415094,2328.971698,9945.716981,370.0754717,252.8679245,459.0471698,11589.04717,399.5566038,117.7075472,4854.150943,9002.113208,1496.584906,448.1226415,2799.792453,7931.198113,562.3773585,250.3207547,1709.084906,5412.90566,967.6603774,421.509434,1327.188679,3977.09434,1328.179245,156.7641509,3724.528302,3558.669811,2138.849057,176.6698113,3384.556604,243.5754717,680.7264151,106,12.36408705,11.47396868,0.372560873,0.905982906,0.630952381,-1.347856741
+3172,19481.2243,916.0841121,609.0747664,1085.056075,17795.15888,718.588785,633.9439252,1495.158879,9952.439252,539.2523364,596.5327103,1781.542056,12527.79439,1265.373832,2252.018692,2784.28972,4459.056075,1319.214953,326.4953271,2363.579439,9707.934579,415.9439252,1478.046729,580,11087.85981,500.8504673,127.3364486,2105.953271,8582.336449,1497.280374,564.2897196,2818.392523,7580.682243,647.1775701,280.4579439,1734.411215,5733.121495,1058.429907,423.3831776,1397.149533,4354.065421,950.3457944,175.7009346,5047.775701,3978.719626,1355.831776,582.0654206,3221.82243,402.3831776,680.1028037,107,13.46713295,10.77407297,0.599963702,0.922413793,0.685897436,-1.510604916
+3173,21452.64964,1018.788321,670.9124088,1104.781022,19825.08759,756.8832117,711.1532847,1564.773723,11548.06569,582.1021898,587.7226277,1756,15370.40876,1376.277372,1632.532847,2023.051095,5050.379562,1405.343066,317.8759124,2383.781022,11630.63504,481.8613139,189.8905109,555.9781022,13224.08759,512.7007299,122.7810219,1154.474453,10737.15328,1510.328467,680.8759124,2840.605839,9399.313869,697.5182482,289.0948905,1544.007299,7026.912409,956.3868613,429.8905109,1320.255474,5386.40146,641.8175182,168.919708,2545.467153,4791.270073,1372.087591,398.919708,3186.846715,572.5693431,681.8540146,137,15.08497496,11.78998343,0.623815926,0.901315789,0.611607143,-0.532408057
+3174,30856.84946,896.7311828,779.5483871,1115.741935,29547.06452,685.4731183,758.0107527,1603.505376,15794.04301,527.8064516,776.8924731,1775.870968,21222.49462,1247.236559,2736.268817,1964.376344,7583.172043,1272,302.688172,2370.333333,15711.88172,6856.731183,116.7419355,934.1182796,19725.08602,536.5806452,124.2795699,1625.333333,14032.26882,1664.032258,550.9892473,2805.462366,12435.78495,2357.806452,256.5053763,1570.795699,9493.010753,1019.010753,407.0215054,1304.806452,7336.698925,610.6129032,160.2258065,3356.83871,6344.946237,1289.215054,138.0967742,3390.204301,753.4408602,680.2473118,93,13.72857105,10.5319454,0.64146147,0.830357143,0.476923077,1.188994426
+3175,37194.90217,907.9782609,556.9021739,1088.108696,34600.81522,736.4891304,727.4673913,1646.793478,19486.75,556.7282609,870.1630435,1743.336957,27191.88043,1362.423913,4069.793478,4392.913043,9730.358696,1823.173913,353.4021739,2463.402174,19866.63043,446.2391304,386.3152174,816.6304348,25011.32609,960,129.673913,3294.032609,18912.56522,1708.315217,597.8369565,2795.163043,16694.80435,708.2717391,295.8695652,1913.73913,12764.42391,1538.456522,445.6304348,1312.75,8889.021739,758.423913,175.5652174,5868.652174,7976.141304,1434.25,188.673913,3219.521739,858.2391304,680.5434783,92,11.71564615,10.40352047,0.459839052,0.901960784,0.638888889,0.197074906
+3176,38914.47414,848.4827586,508.5,1097.163793,35161.74138,719.1982759,728.6034483,1664.887931,19583.07759,521.3448276,829.5086207,1763.62069,27837.76724,1262.663793,6225.241379,3686.146552,9906.456897,1314.534483,339.7931034,2375.543103,19749.18966,448.0086207,538.7068966,704.8103448,24074.75,543.612069,149.0086207,3865.551724,18812.7931,1812.62069,537.3448276,2795.612069,16232.94828,625.0086207,286.6206897,1969.362069,12160.22414,1097.258621,424.6724138,1308.594828,8209.293103,754.5172414,172.3706897,5276.775862,7415.758621,1314,186.1637931,3252.534483,905.2586207,681.2931034,116,15.36020539,11.69580247,0.648240925,0.763157895,0.552380952,-0.942541487
+3177,31033.64815,807.5231481,511.25,1093.402778,28827.28704,674.1944444,908.2638889,1630.319444,15121.87963,487.5092593,1912.347222,1863.277778,21357.59722,1194.782407,5516.736111,3596.296296,7925.87963,1265.972222,321.162037,3124.402778,15484.48148,525.9768519,387.9907407,792.2546296,19657.38889,696.6574074,140.3564815,1867.277778,15051.3287,2076.078704,619.6388889,2848.009259,12615.03704,867.5462963,274.7546296,1291.62963,8985.967593,1287.537037,415.3425926,1314.435185,5503.800926,675.0416667,161.7962963,4924.189815,5370.203704,1245.851852,686.4861111,3192.768519,1000.291667,684.0601852,216,20.36308889,13.74636609,0.737760167,0.935064935,0.675,-0.227976258
+3178,34433.71111,802.1888889,516.5,1113.6,32897.84444,679.3666667,747.0555556,1695.933333,16840.43333,528.6555556,516.3444444,1745.1,21825.85556,1229.377778,8467.688889,3948.233333,8427.577778,1426.788889,349.0555556,2372.433333,17014.96667,1023,493.6,433.6666667,20338.76667,446.2333333,131.8666667,5882.777778,15397.81111,1493.844444,598.3111111,2810.822222,13142.7,598.3444444,295.4111111,3023.922222,7839.155556,796.8444444,432.9666667,1315.211111,5719.555556,714.7444444,171.8888889,4161.844444,4994.444444,1286.411111,202.9444444,3273.822222,189.7666667,682.5777778,90,12.35360598,9.555595587,0.633788262,0.967741935,0.584415584,0.258214175
+3179,27140.15294,788.0117647,542.8588235,1091.988235,27110.63529,634.3529412,430.5647059,1616.294118,13242.8,510.7529412,509.4705882,1788.635294,17452.91765,1163.917647,7973.8,4823.882353,6574.552941,1277.752941,305.7294118,2344.423529,14085.58824,5433.364706,138.6117647,417.9294118,16335.87059,419.8470588,121.3294118,6433.105882,12141.92941,1400.823529,775.4235294,2820.611765,10655.14118,584.3176471,266.5529412,2555.494118,6786.223529,818.9294118,416.1529412,1296,5148.482353,613.5058824,165.6823529,6866.376471,4347.211765,1226.941176,190.0352941,3309.270588,217.3764706,680.5058824,85,14.05219965,9.246133203,0.753031245,0.817307692,0.505952381,1.123954696
+3180,33850.55422,821.3975904,538.5542169,1062.915663,32900.10843,652.939759,1004.096386,1575.036145,17488.85542,538.1807229,1326.228916,1794.915663,22367.10843,1210.710843,5665.168675,5298.39759,8399.240964,1312.060241,321.0481928,2461.843373,17224.75904,579.5421687,160.1686747,690.4819277,20908.3253,420.8313253,158.5060241,4926.638554,16016.16867,2000.987952,450.3012048,2831.313253,13942.80723,591.060241,285.6626506,2190.927711,8665.554217,1340.012048,418.6385542,1301.963855,6592.686747,629.9036145,166.7590361,4277.036145,5801.831325,1269.879518,282.4337349,3302.26506,229.6024096,681.746988,83,10.72451113,10.04016254,0.351498712,0.965116279,0.576388889,0.732343741
+3181,31355.61364,859.7272727,502.7272727,1054.034091,29731.39773,692.0113636,931.3636364,1520.784091,16453.67045,561.9204545,1402.818182,1796.113636,20551.71591,1213.034091,6933.534091,4624.011364,7640.602273,1311.875,313.8409091,2593.125,15828.51136,392.5795455,378.3977273,648.3068182,19003.63636,1473.522727,127.0227273,4056.090909,14863.17045,1517.715909,465.9318182,2810.715909,12966.73864,576.4318182,283.8522727,1664.988636,16837.43182,1412.772727,764.6818182,1571.727273,6486.102273,673.0340909,168.9545455,4564.011364,5859.272727,1290.068182,241.6363636,3488.238636,253.7386364,682.6931818,88,13.42739628,8.613754392,0.767118072,0.888888889,0.571428571,-0.586805724
+3182,28529.24324,1243.945946,655.2702703,1097.689189,26212.2027,795.6621622,746.1621622,1617.486486,15018.16216,639.5945946,896.472973,1796.013514,19163.68919,1395.486486,8184.77027,4117.337838,6408.297297,1358.27027,320.7567568,2330.094595,14371.44595,630.3378378,254.2432432,616.0405405,16753.58108,912.7162162,129.7432432,6346.297297,13184.40541,1601.216216,573.2297297,2802.432432,11779.81081,612.8378378,315.6891892,1586.175676,8541.959459,1069.689189,428.8108108,1305.851351,6736.527027,643.0810811,174.2837838,3638.243243,6041.932432,1313.067568,184.527027,3459.891892,376.8918919,681.1891892,74,14.89655613,6.512604553,0.899369849,0.948717949,0.569230769,-0.990973291
+3183,35802.18812,822.980198,466.6633663,1096.861386,33591.61386,691.029703,850.7227723,1603.079208,18367.13861,510.950495,1167.534653,1753.415842,25409.44554,1233.356436,4434.069307,2499.584158,9127.29703,1284.673267,334.5544554,2686.148515,18504.78218,427.8514851,1166.712871,1508.871287,22737.55446,445.8514851,749.5445545,2147.386139,17414.38614,2102.366337,497.0990099,2783.920792,15084.33663,811.2376238,277.6336634,1458.19802,11316.40594,1058.425743,429.2871287,1339.287129,7750.267327,931.7722772,164.4158416,3777.128713,6852.29703,1276.405941,273.5742574,3197.752475,894.019802,680.6633663,101,11.8163218,10.99507814,0.366293889,0.943925234,0.834710744,-0.867821095
+3184,38930.42194,909.1265823,522.978903,1110.924051,35882.49367,797.4008439,822.8649789,1622.535865,20838.54008,551.649789,1653.886076,1842.746835,27302.1097,1358.337553,3596.797468,4269.818565,9752.649789,1364.485232,335.1476793,2523.995781,20435.22363,463.1687764,148.1434599,1488.447257,25671.96624,1142.654008,215.4514768,1903.232068,18622.18143,2147.767932,569.3459916,2800.468354,16665.4135,632.4219409,299.8396624,1705.303797,12719.87342,1795.240506,433,1303.367089,9265.586498,649.0295359,165.9409283,3607.966245,8317.42616,1414.333333,187.0042194,3265.696203,722.5991561,685.5527426,237,24.81478842,12.46189061,0.864753752,0.948,0.572463768,-0.929626472
+3185,17418.90741,841.7962963,603,1062.185185,19932.35185,712.6481481,763.8148148,1499.592593,9188.425926,604.537037,918.0555556,1780.925926,13604.57407,1204.037037,5601.833333,4641.222222,4745.166667,1207.166667,314.4074074,2395.351852,9915.833333,418.962963,1839.759259,1195.277778,12264.90741,434.5925926,174.0925926,3464.037037,8393.092593,1785.685185,659.2777778,2787.388889,7360.611111,823.6481481,247.9814815,2004.685185,5764,867.7962963,404.3518519,1353.37037,4586.222222,1037.203704,159.2962963,6039.703704,3652.12963,1250.425926,264.3703704,3250.722222,800.6851852,681.2407407,54,12.02409634,6.612328679,0.835215273,0.830769231,0.490909091,0.802702085
+3186,29090.53191,811.3829787,480.8723404,1061.010638,24552.17021,645.6595745,714.1595745,1545.340426,14730.89362,488,788.0531915,1744.117021,20190.93617,1259,2943.265957,2930.978723,7504.542553,1251.457447,325.1808511,2618.457447,14391.8617,674.787234,151.6382979,662,17276.04255,548.0425532,124.5106383,1979.021277,14019.08511,1769.021277,469.893617,2782.425532,12141.65957,762.0531915,263.9787234,1594.840426,9081.425532,1161.680851,404.8723404,1297.117021,5985.5,618.6914894,163.5531915,5157.893617,5639.510638,1249.478723,194.3723404,3277.212766,916.6382979,682.9468085,94,11.47121093,10.75334821,0.348199393,0.921568627,0.602564103,0.458335784
+3187,30996.32407,829.0277778,614.3055556,1094.777778,27267.31481,684,591.6666667,1710.12963,13472.72222,488.5555556,721.712963,1778.074074,19779.0463,1210.87037,8561.962963,5115.138889,7681.324074,1312.990741,322.4537037,2432.712963,14666.7037,419.1944444,1333.712963,726.8055556,18004.62037,482.5277778,157.4537037,7481.453704,14241.18519,1722.833333,457.9537037,2784.055556,11705.88889,656.0462963,266.7037037,1704.259259,7847.601852,878.5925926,390.0092593,1295.342593,4154.148148,919.962963,160.8425926,7617.453704,4418.824074,1196.240741,716.3148148,3191.712963,1062.259259,682.2222222,108,12.52425473,11.05288936,0.470277252,0.990825688,0.755244755,0.133001174
+3188,36258.97619,830.8452381,528.9880952,1115.095238,25678.14286,589.8809524,848.0119048,1500.297619,12358.36905,431.4761905,1639.904762,1776.321429,17976.33333,1099.428571,7268.25,3457.5,7010.880952,1105.511905,297.5119048,2994.309524,13282.72619,360.8095238,297.3571429,1155.059524,16931.70238,647.0952381,127.7857143,3876.72619,12895.2381,2047.678571,386.7619048,2806.297619,10397.36905,555.8214286,248.5119048,1125.511905,6872.916667,1275.404762,381.2857143,1284.607143,3555.404762,632.3214286,156.4761905,5890.964286,3781.047619,1066.916667,582.5952381,3220.166667,1073.130952,683.3571429,84,12.32426622,8.959545737,0.68665428,0.954545455,0.587412587,0.606420485
+3189,32009.54495,827.7082569,563.7504587,1089.869725,14252.89908,474.3706422,400.4678899,1321.566972,5637.293578,367.0477064,1134.411009,1647.809174,9323.504587,902.946789,5135.372477,1868.40367,3509.833028,934.3394495,230.2605505,2399.776147,6362.255046,327.1743119,324.7724771,931.0275229,7423.684404,317.5394495,163.2183486,1197.449541,5691.662385,2017.574312,372.906422,2792.440367,4502.99633,456.612844,191.8495413,731.5027523,2422.051376,789.2495413,312.3229358,1259.831193,1244.115596,535.2238532,124.6917431,1598.370642,1348.456881,849.9834862,115.9504587,2913.427523,1115.820183,694.146789,545,32.67746087,21.96921086,0.740274528,0.936426117,0.660606061,-0.360204778
+3190,25919.03175,945.3068783,596.4814815,1079.074074,23514.12169,726.2116402,609.5608466,1512.169312,13214.48677,560.4708995,702.4497354,1744.037037,17165.98413,1311.851852,4554.417989,2896.285714,6239.232804,2559.470899,327.037037,2370.645503,13170.95767,418.6560847,526.4126984,531.6719577,15616.94709,441.4867725,126.1375661,3389.719577,11521.47619,1595.486772,714.968254,2815.280423,10195.56614,907.973545,291.0634921,1880.322751,7959.058201,919.3492063,449.2857143,1331.047619,6134.444444,737.9100529,179.973545,5505.285714,5557.68254,1376.470899,271.2698413,3277.174603,482.9153439,685.8465608,189,20.23007327,12.49714758,0.786373783,0.908653846,0.555882353,-0.974180933
+3191,20077.32759,903.2068966,585.2241379,1085.517241,18736.7069,739.4482759,718.6724138,1491.465517,10642.36207,527.6034483,1327.172414,1783.344828,14384.43103,1350.206897,1900.913793,5222.224138,5211.413793,1556.206897,320.8793103,2447.051724,10776.41379,451.7758621,817.0862069,1008.206897,13086.17241,518.4137931,179.4827586,2571.206897,9952.896552,1841.5,1028.965517,2802.637931,8937.362069,920.0689655,292.8965517,2294.37931,6823.844828,1212.327586,434.9482759,1329.327586,5331.862069,833.5689655,177.2931034,4578.396552,4813.034483,1412.517241,489.8103448,3235.051724,560.6896552,681.1724138,58,10.82021989,7.320918651,0.736354336,0.878787879,0.659090909,-1.360892999
+3192,38213.04667,1070.526667,635.9266667,1120.413333,34595.36667,790.6066667,666.26,1617.06,20072.68667,608.3333333,1025.786667,1805.986667,26985.10667,1434.68,4776.06,3188.826667,9115.226667,1352.486667,331.6066667,2333.806667,20289.39333,484.1466667,250.1933333,606.3266667,24800.23333,473.0133333,221.5,3708.76,18382.78,1844.76,688.4,2786.753333,16476.48,698.3933333,294.44,1710.606667,12529.92667,1211.526667,423.8066667,1324.14,9447.026667,686.9533333,163.6,2261.793333,8323.4,1414.613333,456.96,3354.66,681.3933333,684.36,150,16.33118399,12.14125688,0.668802537,0.903614458,0.669642857,1.52265389
+3193,36894.97701,873.2030651,496.8735632,1088.735632,34299.83142,718.48659,732.210728,1619.781609,19091.82759,521.1877395,1092.678161,1801.766284,26777.3295,1259.988506,4796.900383,3205.835249,9681.478927,1299.923372,329.1494253,2450.590038,19544.08812,1118.409962,779.2605364,1390.409962,23810.29502,466.183908,724.9923372,2625.145594,18364.64751,1940.007663,542.5938697,2791.421456,16053.66667,758.5019157,285.6206897,1655.302682,12121.61686,1095.812261,428.0957854,1325.770115,8225.210728,820.137931,163.7547893,4247.287356,7423.609195,1338.716475,203.2375479,3261.084291,881.9118774,689.0268199,261,24.61230625,14.66506529,0.803101094,0.831210191,0.614117647,0.071734005
+3194,32459.41912,803.625,536.1654412,1088.341912,24418.74632,561.2169118,681.9448529,1445.297794,11135.78676,419.9044118,712.1948529,1674.150735,17386.86029,1040.577206,7873.746324,2512.547794,6569.775735,1087.150735,288.0698529,2384.382353,12339.93382,337.2169118,917.6360294,719.0404412,14761.36029,360.5,111.5147059,3091.014706,11654.65441,1799.305147,433.2830882,2790.264706,9260.389706,546.3566176,232.8897059,947.3602941,5624.569853,855.2794118,343.9411765,1276.007353,2799.194853,696.8382353,138.3529412,1705.430147,3078.169118,985.5514706,379.5735294,3178.327206,1088.595588,689.7132353,272,22.52483926,15.99978775,0.703881406,0.900662252,0.544,0.180438985
+3195,27548.2,1081.748148,583.2740741,1094.503704,26839.36296,719.7185185,524.9111111,1564.02963,14698.25185,576.3333333,581.7185185,1758.325926,18417.11852,1296.607407,7079.555556,3184.748148,6552.207407,1340.851852,319.7703704,2359.6,14149.58519,468.6148148,729.8962963,468.6296296,16633.86667,447.7777778,127.1185185,3377.792593,12841.28889,1722.940741,556.0888889,2814.918519,11180.4,669.6814815,288.9703704,1393.903704,7713.348148,893.8296296,429.5037037,1322.97037,5853.103704,764.2074074,171.0444444,3299.244444,5038.57037,1314.555556,162.1925926,3434.4,299.362963,686.0074074,135,13.70797785,12.86616287,0.345036107,0.9375,0.741758242,-1.117062477
+3196,29020.23333,1042.7,531.9555556,1049.088889,25832.32222,732.8333333,932.4222222,1465.188889,14610.53333,558.4111111,1317.622222,1743.444444,19715.71111,1291.644444,3010.744444,1681.666667,6748.655556,1609.1,291.3444444,2341.3,14917.12222,1062.177778,222.2,989.6777778,18075.25556,450.9,239.2333333,1253.5,13725.54444,1976.977778,629.4555556,2780.044444,12087.04444,839.4888889,264.5555556,1371.366667,9288.777778,982.8777778,377.6111111,1290.222222,6987.855556,632.0666667,150.9666667,2371.044444,6292.888889,1228.266667,446.3888889,3330.577778,618.4555556,685.4444444,90,12.77909005,10.06603104,0.616064838,0.927835052,0.576923077,0.572663366
+3197,31915.91262,927.6116505,680.961165,1121.601942,28453.43689,735.9029126,753.7961165,1642.825243,16057.51456,551.9902913,1038.990291,1787.300971,21610.56311,1341.660194,3338.514563,3995.38835,7645.825243,1339.038835,323.1165049,2401.631068,16419.36893,532.3300971,301.3300971,731.8834951,20277.8932,479,123.9029126,2300.796117,14837.47573,1893.126214,656.8640777,2794.174757,13273.85437,697.2330097,283.7669903,1797.417476,10072.32039,1411.854369,414.368932,1314.660194,7622.912621,779.2815534,160.5145631,3161.854369,6756.126214,1412.660194,222.5339806,3347.980583,668.2038835,684.8737864,103,12.95328782,10.67758436,0.566131988,0.887931034,0.66025641,-0.047297708
+3198,40650.09412,856.4588235,555.0352941,1074.764706,36706.56471,709.1882353,993.3058824,1573.988235,21499.88235,537.4352941,1773.870588,1763.329412,28377.74118,1307.188235,4376.835294,3986.505882,10044.22353,1320.976471,317.5176471,2679.941176,21181.67059,1033.6,117.1882353,1013.941176,26623.91765,635.8235294,169.3294118,1642.470588,19714.75294,2067.447059,554.3058824,2816.670588,17357.77647,1207.882353,289.0352941,1474.458824,13410.10588,1423.988235,427.6,1320.529412,9730.858824,635.0470588,164.6941176,3008.376471,8733.6,1400.752941,203.8705882,3237.294118,742.1647059,683.6,85,13.68550856,7.942135292,0.814380161,0.95505618,0.653846154,-1.071472884
+3199,36319.95062,853.7530864,632.7654321,1110.246914,31307.44444,697.0123457,769.617284,1613.345679,19075.79012,537.1604938,534.0123457,1783.617284,25511.02469,1311.259259,3944.160494,3258.148148,8963.728395,1306.481481,332.0617284,2386.37037,18860.37037,429.9382716,599.8148148,594.8395062,22708.71605,606.8148148,135.5432099,3228.703704,17716.85185,1470.728395,701.9506173,2790.160494,15432.11111,773.6296296,291.2592593,1852.234568,11841.09877,932.654321,426.9876543,1330.493827,8260.925926,755.7160494,164.3580247,2730.037037,7525.45679,1381.703704,210.382716,3255.888889,810.9382716,683.654321,81,11.08586273,9.644030316,0.49315839,0.931034483,0.613636364,-0.706995425
+3200,24851.90833,814.5333333,510.675,1086.033333,23602.58333,675.6583333,542.8583333,1578.658333,12305.55833,484.8333333,887.55,1737.275,17163.21667,1196.333333,4235.775,2627.283333,6288.483333,1332.466667,321.95,2419.758333,12682.8,458.3166667,477.9333333,812.8666667,15456.60833,449.1583333,130.3083333,3407.65,11697.7,1707.083333,571.0666667,2799.675,10174.99167,1043.05,268.1333333,1335.683333,7534.408333,1670.025,408.3166667,1332.825,5192.266667,718.2083333,159.5916667,5843.733333,4678.766667,1268.483333,871.875,3233.433333,936.3833333,686.0333333,120,14.9710923,10.413013,0.718486117,0.888888889,0.666666667,-0.171024903
+3201,43953.51323,903.3862434,673.4391534,1170.830688,26784.49206,585.8835979,451.1746032,1525.195767,12376.0582,466.3650794,460.5661376,1761.010582,16285.87302,1079.26455,7747.47619,3715.650794,6041.439153,1126.936508,280.8359788,2448.571429,12287.88889,332.8783069,193.1269841,516.1005291,13973.91005,360.6084656,115.031746,7558.957672,10335.8254,1431.169312,404.7037037,2849.068783,8739.677249,520.026455,242.0740741,3045.148148,4242.349206,696.978836,368.957672,1286.78836,3005.910053,568.0740741,146.962963,2494.603175,2847.587302,1056.89418,189.6296296,3106.68254,147.8677249,687.8201058,189,17.34822362,13.96738917,0.593112939,0.964285714,0.741176471,-0.533295767
+3202,28923.67717,1066.267717,566.0944882,1095.874016,26037.14173,750.1811024,783.488189,1600.165354,15138.32283,605.503937,1071.76378,1821.952756,18808.19685,1356.370079,6775.23622,4061.330709,6663.503937,1509.204724,339.1102362,2348.23622,13920.33071,412.2362205,1257.850394,1180.905512,16542.88976,845.2677165,135.1023622,4075.133858,12831.11024,1907.15748,533.5433071,2833.716535,11247.66142,826.5433071,297.4566929,1577.181102,8208.795276,1478.834646,455.1181102,1382.086614,6164.716535,875.503937,180.9606299,4433.007874,5544.448819,1356.472441,164.8425197,3377.519685,343.023622,687.2283465,127,13.16971493,12.55220804,0.302619036,0.976923077,0.604761905,0.367958063
+3203,33718.88312,935.987013,524.4545455,1108.753247,30579.07792,742.6493506,757.961039,1547.974026,17585.42857,575.9090909,656.5454545,1743.649351,22788.14286,1349.844156,2827.012987,3270.883117,8293.25974,1406.311688,349.8831169,2399.168831,17777.76623,888.961039,291.4155844,607.8311688,21042.79221,450.6103896,241.1558442,2308.961039,15868.24675,1597.324675,695.7532468,2807.506494,14381.46753,642.0909091,320.6103896,2010.142857,11585.92208,988.7792208,494.012987,1324.662338,9622.38961,753.7532468,213.6883117,3721.038961,7691.87013,1507.766234,1739.701299,3297.818182,442.3896104,684.6883117,77,11.44829601,9.670822785,0.535178404,0.846153846,0.583333333,0.035182522
+3204,35180.00426,1058.93617,608.2085106,1173.438298,32109.24255,850.0510638,660.0468085,1670.931915,18337.37872,621.6808511,940.7021277,1756.821277,24163.97447,1589.821277,2278.842553,2750.33617,8476.625532,1620.268085,405.3319149,2422.629787,18511.31489,2097.017021,428.4,759.9659574,22220.91915,517.5531915,480.0595745,1990.965957,16895.74468,1865.26383,671.3191489,2820.080851,14981.18723,916.9489362,357.2893617,1856.323404,11667.71489,1168.502128,530.1489362,1348.293617,9022.859574,826.3829787,210.7446809,3369.446809,8290.093617,1705.851064,2088.987234,3470.417021,451.7106383,691.4851064,235,19.76703688,16.26187813,0.568509682,0.907335907,0.621693122,-0.422767249
+3205,25164.54074,888.1555556,586.7185185,1087.42963,23059.04444,715.5185185,661.8148148,1529.748148,13122.59259,533.4444444,1162.007407,1732.681481,18089.26667,1344.548148,2509.933333,3231.940741,6139.044444,1360.651852,316.8814815,2431.148148,13839.47407,497.1777778,469.6666667,875.762963,16730.28148,527.3925926,197.562963,1478.888889,12684.54815,1665.140741,757.8222222,2813.57037,11545.94074,747.1111111,292.3407407,2207.637037,8874.8,1404.222222,439.1185185,1327.311111,6671.207407,801.7037037,164.5777778,4104.992593,6489.125926,1451.503704,2168.637037,3222.933333,592.8148148,686.4814815,135,15.2309426,11.6172501,0.646705186,0.931034483,0.68877551,-0.598228348
+3206,24616.91837,962.0340136,854.0748299,1139.802721,22048.72109,724.2312925,817.7959184,1676.768707,12304.04082,538.877551,463.3537415,1768.897959,16311.72789,1327.721088,1915.687075,1503.340136,5862.482993,1338.034014,319.6734694,2413.884354,12602.35374,5217.639456,196.047619,462.6530612,15004.10884,491.7414966,120.7687075,1549.52381,11262.28571,1431.789116,574.1768707,2798.414966,10186.57143,3576.108844,272.8979592,1854.462585,7582.346939,853.7891156,420.122449,1333.047619,5903.312925,668.9387755,160.7823129,2274.727891,5265.70068,1430.816327,557.1496599,3291.931973,643.877551,687.2040816,147,18.83823415,10.86827525,0.816796113,0.864705882,0.628205128,-0.016243227
+3207,35164.10345,856.8189655,464.2672414,1062.491379,32648.64655,697.2672414,652.8362069,1535.974138,18140.40517,526.0948276,588.5689655,1730.810345,25217.37069,1284.982759,2987.456897,2933.758621,9043.637931,1460.5,334.0344828,2332.163793,18384.53448,425.5344828,206.6637931,614.25,22520.31034,427.2931034,130.6034483,2617.508621,17205.43966,1521.284483,636.2758621,2787.698276,15184.5431,703.3362069,286.7155172,1923.327586,11411.2069,937.7844828,428.4568966,1303.12069,7920.758621,690.7844828,168.6465517,5339.422414,7081.87931,1357.25,313.0862069,3188.801724,867.2931034,686.1810345,116,16.37799589,9.281065821,0.823938679,0.950819672,0.594871795,-0.653140054
+3208,26814.715,794.58,483.12,1072.865,24257.74,691.54,1085.17,1573.115,12599.95,475.455,2339.165,1789.505,18283.845,1184.11,5731.445,3691.25,6830.45,1238.04,314.66,2812.075,13210.29,4356.08,812.41,1267.835,16732.52,1196.41,530.295,2692.425,12854.275,1948.16,458.815,2835.945,10618.235,690.845,253.92,1187.475,7754.755,1289.49,400.195,1321.715,4586.16,797.865,162.6,6190.625,4611.155,1237.905,1875.855,3186.18,1015.745,687.845,200,18.59282491,14.00293047,0.657864565,0.925925926,0.619195046,-1.2197349
+3209,28560.3348,822.3920705,603.8502203,1093.453744,24209.7489,623.3039648,579.3171806,1560.105727,11359.02203,452.907489,948.9515419,1723.797357,16656.31718,1127.114537,6906.929515,3068.436123,6402.837004,1212.035242,298.1189427,2496.907489,12485.3348,412.7621145,1051.46696,1067.330396,15422.23789,402.0881057,126.3303965,3962.193833,11888.29515,1729.325991,479.1365639,2787.154185,9627.162996,714.5814978,249.9603524,1372.427313,6661.806167,878.4933921,372.6255507,1287.026432,3683.14978,865.8722467,150.9295154,3312.995595,3770.612335,1148.497797,1675.828194,3135.348018,1052.202643,689.3568282,227,21.07681191,14.08403684,0.743959912,0.91902834,0.66374269,0.603163666
+3210,48227.94406,887.7902098,564.6783217,1148.468531,41400.33566,733.2447552,602.3636364,1774.573427,21335.18881,555.3776224,516.5384615,1769.104895,28309.66434,1291.678322,7068.251748,5093.328671,10626.41958,1400.13986,365.7342657,2315.902098,21673.55245,521.993007,665.8811189,448.020979,26164.90909,453.5524476,136.7972028,6224.468531,19641.93007,1561.545455,531.006993,2817.258741,16724.56643,615.958042,317.1748252,2638.027972,9313.839161,819.7832168,444.3146853,1305.111888,6760.454545,761.7762238,171.006993,4538.664336,6039.020979,1331.286713,170.7552448,3282.076923,180.7062937,688.4125874,143,15.52990682,12.07340371,0.628970406,0.928571429,0.680952381,0.30082944
+3211,6806.434783,915.115942,512.0434783,1032.507246,7176.115942,652.4347826,476.7391304,1330.26087,3466.855072,540.6521739,434.5217391,1713.115942,4434.101449,1218.855072,1291.492754,1730.231884,1907.521739,1222.768116,289.3768116,2310.666667,4120.695652,377.7971014,276.7826087,440.942029,4238.434783,372.4782609,116.9130435,1386.333333,3131.115942,1297.84058,559.9565217,2791.347826,2962.42029,587.0289855,249.2608696,1360.072464,2474.101449,777.1594203,392.4347826,1323.84058,10075.62319,1181.434783,387.2028986,2991.782609,3253.884058,1722.536232,9356.42029,3677.594203,433.0144928,685.9855072,69,11.80776349,7.952148563,0.739216555,0.92,0.638888889,-0.209998959
+3212,29380.4386,960.9649123,638.2192982,1100.052632,26127.65789,726.5087719,726.1315789,1593.175439,14409.7807,596.8508772,496.3947368,1742.149123,19750.51754,1306.482456,2820.692982,2988.008772,7000.596491,1290.842105,309.0964912,2365.807018,15417.02632,519.2017544,469.5614035,527.6929825,18595.50877,618.0614035,115.5087719,1938.675439,13530.50877,1501.631579,612.1315789,2777.324561,11994.82456,865.8333333,263.7368421,1937.280702,9062.140351,911.5087719,407.0175439,1323.95614,6952.201754,723.0087719,159.5087719,3965.192982,6205.464912,1334.026316,467.2719298,3306.807018,652.9736842,689.4122807,114,15.35534335,9.686775596,0.775912371,0.95,0.609625668,-0.048287848
+3213,48552.95556,905.7111111,522.6444444,1098.155556,42878.6,765.5333333,692.6666667,1599.222222,25075.46667,555.1777778,1495.911111,1763.177778,32678.62222,1337.244444,2669.622222,4103.6,11758.04444,1368.666667,337.8222222,2477.511111,24897.48889,521.5333333,339.6444444,1968.333333,30530.82222,614.8888889,134.0444444,1954.133333,22794.04444,2077.711111,565.7777778,2849.555556,20341.82222,769.3333333,291.4666667,1724.177778,15672.55556,1364.088889,430.8888889,1317.844444,10999.22222,708.5555556,171.4444444,3389.111111,9901.311111,1445.511111,512.8666667,3303.155556,761.6222222,684,45,9.687692423,5.981326762,0.786637591,0.918367347,0.642857143,-1.328810825
+3214,28937.66038,832.6132075,652.2924528,1069.273585,25824.86792,656.0377358,672.0754717,1518.603774,14739.5283,515.509434,502.3867925,1733.311321,19436.9434,1211.528302,3505.09434,2975.349057,6877.367925,1255.556604,308.7735849,2345.528302,14572.20755,470.2641509,704.4056604,597.5471698,17682.87736,422.8301887,128.3490566,2733.311321,13261.39623,1484.396226,637.7830189,2778.169811,11718.28302,823.1981132,267.9433962,1833.066038,8905.018868,824.8113208,402.2735849,1327.056604,6425.754717,780.2358491,153.3396226,2811.943396,5779.839623,1266.5,210.0471698,3166.801887,795.1509434,687.3962264,106,12.76476539,10.83301008,0.528930673,0.905982906,0.679487179,0.392168953
+3215,37001.08163,901.1734694,693.0612245,1139.94898,31220.18367,718.3367347,772.3877551,1657.561224,19065.70408,538.6632653,494.2857143,1774.418367,26042.32653,1370.44898,2475.785714,1860.816327,9333.244898,1357.061224,348.6020408,2402.632653,19168,453.1428571,135.3877551,490.6836735,22661.85714,531.377551,127.4081633,3195.326531,18024.5,1502.571429,513.2142857,2811.418367,15712.02041,778.1734694,286.4693878,1677.010204,12076.42857,1094.938776,447.1632653,1314.112245,8322.795918,652.2755102,165.7040816,1950.520408,7656.908163,1407.081633,179.4795918,3254.428571,827.0102041,687.4693878,98,12.95367765,9.728029357,0.660318232,0.960784314,0.753846154,0.240159251
+3216,13106.63953,763.9302326,456.8197674,1080.418605,12082.20349,619.255814,643.372093,1549.337209,5914.732558,450.1802326,413.9186047,1734.80814,8411.953488,1135.569767,1800.552326,819.8953488,3352.656977,1150.325581,295.4127907,2303.738372,6397.331395,391.1511628,251.2790698,488.0232558,7923.965116,473.5232558,120.627907,1167.703488,6161.947674,1316.22093,377.7093023,2843.19186,5102.383721,651.3546512,244.1395349,1351.319767,3772.273256,725.2093023,387.5697674,1301.726744,2139.976744,640.8895349,157.4418605,2983.069767,2261.145349,1199.924419,3349.965116,3151.831395,1035.662791,688.9127907,172,17.04380237,12.86550582,0.655898027,0.960893855,0.722689076,0.519490599
+3217,39225.52258,924.1677419,564.7032258,1119.483871,36437.82581,723.2451613,499.3096774,1736.419355,19224.6129,564.5677419,501.1096774,1789.432258,24568.14839,1303.716129,10120.61935,4998.367742,9207.064516,1388.516129,406.7032258,2342.96129,18803.01935,531.4516129,172.2193548,421.4709677,22740.40645,447.0645161,153.9032258,7175.883871,17581.42581,1501.825806,653.7548387,2839.419355,15260.92903,603.3419355,412.1032258,1924.548387,8915.070968,849.2709677,550.1806452,1302.148387,6630.354839,632.0516129,215.716129,3796.23871,5804.470968,1311.341935,169.0193548,3391.832258,209.1612903,689.1806452,155,17.98996724,11.6315816,0.762863685,0.928143713,0.691964286,-0.970464094
+3218,34210.53744,1249.748899,590.6299559,1097.709251,32492.11894,828.3171806,898.0748899,1623.374449,18089.80176,690.9823789,1374.709251,1783.070485,22379.4978,1419.207048,5222.726872,3536.638767,7695.740088,1448.378855,339.4052863,2654.69163,17197.35242,427.1806167,396.4493392,598.1806167,20413.18502,969.5947137,136.1453744,3754.973568,15793.45815,1803.506608,531.2070485,2823.757709,13690.06608,626.5154185,315.154185,1483.044053,9460.629956,1082.330396,452.6123348,1321.370044,7315.665198,686.6740088,172.8061674,3050.0837,6183.325991,1322.488987,222.969163,3569.431718,316.30837,689.5770925,227,21.2675775,15.2619857,0.696437456,0.869731801,0.635854342,-1.4453397
+3219,37940.35714,932.6666667,527.6428571,1069.97619,33508.11905,759.4285714,626.8571429,1591.690476,19756.09524,600.0952381,567.8095238,1772.738095,25351.04762,1382.357143,4310.595238,3708.452381,9024.666667,1457.619048,351,2385.642857,18875.7619,919.7380952,431.047619,564.5714286,22131.64286,443.4047619,132.9047619,3177.547619,17874.92857,1671.904762,660.2619048,2814.047619,15798.40476,671.1428571,323.3571429,1560.761905,11778.21429,983.0952381,460.3809524,1416.952381,8834.047619,748.9285714,195.4047619,5232.571429,8195.380952,1444.571429,219.6666667,3318.857143,384.3095238,685.1190476,42,8.529065151,7.209133161,0.534382038,0.875,0.518518519,0.100667285
+3220,28315.08377,853.6230366,486.0366492,1070.565445,26341.58639,695.5549738,950.408377,1535.424084,14978.45026,598.4188482,1278.272251,1793.298429,19653.27225,1288.827225,5119.439791,3641.565445,6978.376963,1379.481675,319.6806283,2585.513089,15005.0733,470.0157068,842.1937173,865.2722513,18253.32461,803.3246073,145.7643979,1390.591623,13639.75393,1854.984293,613.9005236,2801.712042,12172.65969,626.617801,270.1099476,1527.816754,9326.617801,1593.753927,413.6910995,1304.031414,7087.314136,974.8376963,157.0471204,2987.089005,6332.497382,1373.60733,336.5863874,3192.596859,698.947644,689.1308901,191,19.42694368,13.07863734,0.739440823,0.931707317,0.670175439,-1.105559353
+3221,29647.63087,878.7516779,580.7114094,1103.221477,26946.10067,664.6644295,951.5436242,1521.087248,15567.02013,553.4362416,1144.268456,1808.85906,20843.51678,1214.114094,4238.543624,3386.919463,7477.268456,1261.073826,299.8120805,2492.691275,15697.16107,695.4228188,1077.550336,1541.919463,19182.18121,422.2751678,201.1543624,2398.087248,14190.41611,2147.348993,594.7583893,2784.194631,12511.04027,813.8657718,263.1409396,1650.677852,9692.731544,1128,403.5503356,1350.234899,6920.604027,892.2483221,157.9395973,3994.932886,6157.959732,1271.550336,224.4496644,3264.14094,782.8791946,689,149,15.02042849,12.71178456,0.532707019,0.955128205,0.70952381,-0.587222437
+3222,53345.31579,939.8947368,509.8421053,1121.842105,46826.18421,769.4210526,727,1655.236842,28944.44737,585.4210526,855.5789474,1728.842105,38378.84211,1441.815789,3093.657895,2618.421053,13911.23684,1463.026316,360.6315789,2570.763158,28426.15789,481.5526316,246.7105263,479,34789.71053,465.0263158,150.9736842,1814.289474,27804.07895,1775.526316,653.4473684,2804.657895,24478.60526,725.2105263,324.2894737,1765.921053,18497.05263,1251.868421,456.6578947,1333.368421,12610.39474,701.2894737,179.1842105,2029.289474,11773.21053,1527.342105,315.4210526,3268.368421,844.2105263,685.1052632,38,8.204549413,6.224653466,0.651459795,0.95,0.527777778,-0.820333426
+3223,26594.61261,933.0720721,520.7927928,1067.567568,24339.26126,707.5315315,656.4594595,1513.792793,13891.89189,562.6306306,950.1801802,1758.747748,17842.38739,1284.684685,3823.90991,2858.972973,6589.324324,1341.252252,326.2522523,2368.207207,13301.01802,1036.513514,308.4954955,1135.594595,15797.81982,425.3153153,123.6396396,3282.108108,12277.04505,1509.324324,568.3783784,2816.765766,10788.90991,605.1081081,290.6936937,1432.792793,8092.495495,1249.252252,433.5495495,1316.846847,6210.63964,713.2162162,168.4504505,2949.72973,5717.216216,1333.666667,678.027027,3430.756757,392.1261261,689.009009,111,14.33926934,10.59507704,0.673831089,0.925,0.660714286,-1.162259206
+3224,31516.69841,975.7857143,674.7301587,1120.071429,29460.13492,784.031746,757.547619,1621.079365,16269.38889,602.6666667,928.8492063,1785.888889,20846.72222,1452.087302,3464.063492,5409.150794,7343.761905,1474.97619,363.0634921,2497.436508,16039.02381,523.2142857,239.3095238,853.9285714,19032.21429,1159.126984,146.6825397,3330.753968,13665.8254,1611.222222,909.452381,2819.634921,12525.97619,815.1825397,318.2777778,2257.055556,9574.730159,1148.833333,475.5952381,1320.936508,7477.992063,726.7619048,186.6269841,4856.904762,6480.571429,1520.103175,510.1984127,3400.428571,502.2380952,690.4603175,126,16.51130162,10.0490983,0.793462311,0.90647482,0.570135747,-0.373121943
+3225,28607.66165,878.5639098,557.4360902,1090.511278,25861.2782,712.7593985,759.7969925,1549.744361,14960.08271,549.5864662,616.6616541,1781.270677,19568.40602,1299.894737,5326.781955,2469.699248,6881.315789,1375.067669,331.7593985,2368.962406,14297.16541,543.5338346,533.0075188,502.556391,17765.77444,497.3909774,136.481203,2306.165414,13431.73684,1744.015038,893.7293233,2823.526316,11828.42857,807.1578947,290.6766917,1904.774436,9245.421053,984.3609023,442.2556391,1309.150376,6930.518797,722.9548872,171.2781955,3558.150376,6351.293233,1383.195489,316.924812,3302.112782,536.0902256,689.2406015,133,18.5870836,9.879991069,0.847026012,0.904761905,0.492592593,-0.898628278
+3226,37855.50602,916.5662651,735.4939759,1190.072289,33668.79518,748.7710843,777.3253012,1762.686747,19953.01205,555.8313253,473.4698795,1806.73494,26557.40964,1374.86747,1784.698795,1538.26506,9274.036145,1369.807229,346.060241,2393.46988,19611.04819,458.5421687,158.3253012,504.313253,23198.71084,521.2289157,133.5180723,1783.746988,18243.87952,1480.650602,517.8674699,2803.710843,15922.53012,982.0120482,298.686747,1596.096386,12016.74699,986.2771084,443.4819277,1322.433735,8536.240964,656.6506024,167.2891566,1708.337349,7662.361446,1439.277108,163.6024096,3223.024096,817.4096386,689.5421687,83,13.47419304,8.153514498,0.796133667,0.93258427,0.658730159,-0.320390217
+3227,45744.7,972.6833333,538.5833333,1124.616667,41677.55,752.5333333,636.6666667,1715.433333,22733.55,609.15,579.7833333,1775.333333,29027.53333,1331.983333,6700.65,2896.466667,10444.41667,1439.166667,361.9666667,2328.466667,21876.66667,907.0666667,187.2,442.4333333,25650.86667,445.7166667,133.2833333,3964,20415.58333,1590.616667,491.2,2830.15,17818.01667,658.1333333,326.6,1704.35,10769.63333,905.1833333,456.8166667,1294.6,7894.1,643.9166667,183.0166667,4023.216667,7071.316667,1378.783333,234.6833333,3317.383333,222.8166667,688.4,60,10.40701131,7.646110418,0.678383908,0.983606557,0.606060606,-1.108611093
+3228,31150.53555,832.0189573,537.6066351,1078.417062,29923.05213,671.5592417,725.1753555,1611.156398,15462.46445,540.0947867,609.3886256,1779.393365,19981.46919,1219.511848,7098.540284,4010.672986,7489.241706,1310.388626,315.5924171,2337.412322,15734.72038,1311.881517,385.5402844,467.1469194,18645.19431,480.8957346,126.9004739,5203.398104,14483.81991,1482.507109,476.1848341,2810.725118,12620.36493,599.6398104,284.985782,1824.43128,7671.971564,816.7061611,419.3554502,1299.146919,5896.924171,695.7535545,167.1327014,7163.445498,5113.421801,1278.800948,199.8483412,3332.165877,231.1090047,693.1421801,211,24.44321846,12.29982349,0.864170079,0.82745098,0.488425926,-1.065520778
+3229,29214.47312,900.0430108,556.6129032,1099.860215,28152.74194,705.3010753,648.1827957,1669.784946,15363.39785,548.9032258,1799.688172,1824.860215,19352.10753,1296.526882,6363.806452,4247.473118,7045.849462,1384.989247,336.827957,2362.139785,14851.87097,511.3978495,402.5806452,2058.354839,17775.19355,518.3333333,183.9892473,4298.107527,13740.47312,1891.397849,573.3763441,2820.032258,12230.1828,689.3010753,300.2688172,1570.548387,8787.924731,2097.505376,456.4408602,1344.88172,6881.88172,780.2365591,179.1827957,5020.11828,6060.83871,1395.032258,259.9784946,3526.322581,357.6129032,690.9677419,93,14.13537535,10.42394994,0.675415836,0.801724138,0.510989011,-0.265531719
+3230,35850.37405,1000.465649,532.0305344,1102.282443,32600.57252,808.9770992,562.4961832,1546.931298,18251.87023,605.1908397,653.2366412,1741.610687,22895.8855,1402.641221,5015.145038,3341.59542,8037.007634,1396.900763,343.519084,2347.022901,14196.69466,451.9236641,1522.839695,537.5648855,16698.46565,409.7633588,128.4961832,3183.343511,12862.1145,1679.221374,579.5267176,2794.015267,11341.89313,603.5038168,287.3664122,1273.78626,8544.541985,945.3587786,443.9465649,1353.984733,6587.022901,997.6030534,166.8778626,2471,5908.610687,1383.770992,1374.977099,3227.793893,406.1832061,690.7862595,131,14.2291592,11.91267779,0.54689408,0.942446043,0.671794872,-0.238619877
+3231,27527.74,882.69,607.45,1068.9,25846.68,769.49,1055.5,1558.73,13787.67,531.82,1726.81,1832.2,19006.67,1222.89,4144.05,3768.14,6894.23,1243.41,291.97,2659.5,13999.4,1384.85,102.68,1806.29,17301.55,560.15,936.09,1927.59,12534.67,1929.1,537.42,2799.78,11026.21,1588.87,256.91,1528.11,8474.23,1685.85,390.21,1299.47,6531.25,595.63,154.91,5504.37,5583.17,1249.87,250.82,3254.79,746.06,690.17,100,17.31869638,8.496043532,0.871401441,0.826446281,0.568181818,-1.25778756
+3232,45484.17526,968.3608247,534.4020619,1139.061856,43298.48454,780.6701031,636.7628866,1728.948454,23697.39175,618.7216495,653.9896907,1759.814433,29029.15464,1364.123711,5978.515464,4824.762887,10384.94845,1430.010309,358.371134,2370.56701,22368.53608,453.5360825,261.742268,529.1649485,26669.24742,502.1752577,203.5773196,3969.298969,21095.52577,1633.773196,552.8041237,2813.412371,18025.12371,622.5463918,323.1340206,1633.742268,12036.69072,914.3298969,463.1752577,1307.319588,8929.515464,675.7835052,177.9072165,2281.463918,7957.329897,1396.948454,157.8556701,3437.072165,260.4948454,688.9896907,97,15.94993112,8.030203574,0.864016662,0.923809524,0.60625,-1.176330781
+3233,39369.85475,1038.631285,604.1731844,1105.407821,37652.65363,776.5027933,653.8156425,1657.569832,20293.6648,611.575419,845.3798883,1796.078212,25477.01117,1374.821229,6436.424581,5195.318436,9153.251397,1413.039106,341.8379888,2417.01676,19454.84916,554.2681564,517.1787709,542.9162011,23971.92737,687.9273743,184.7150838,5037.793296,18553.56983,1660.581006,611.2681564,2819.832402,15850.09497,647.0223464,310.4692737,1688.335196,10403.58101,945.9944134,460.9106145,1310.944134,7886.407821,693.0391061,172.0167598,3514.977654,6820.407821,1340.715084,204.9162011,3380.324022,268.3072626,693.4804469,179,27.88628861,9.160896515,0.944500843,0.821100917,0.457800512,-1.069581344
+3234,37403.43678,1036.850575,560.0689655,1087.022989,35059.31034,755.5172414,706.5402299,1561.586207,19847.35632,578.3908046,588.0804598,1772.701149,24825.77011,1360.218391,4610.701149,3329.91954,9198.402299,1470.712644,349.6436782,2365.885057,18962.2069,449.4482759,226.7816092,491.3448276,22616.70115,439.1494253,132.6206897,2941.83908,17609.4023,1750.988506,583.5862069,2803.597701,15728.96552,702.6896552,328.091954,1462.471264,11603.71264,930.7816092,460.1609195,1369.908046,8974.563218,679.4022989,178.4367816,3992.988506,8029.724138,1459.551724,171.5747126,3301.655172,377.0804598,690.0344828,87,12.28411613,9.500802164,0.633891829,0.896907216,0.608391608,1.395046653
+3235,35984.78261,919.6811594,560.1884058,1098.463768,32840.88406,751.3333333,665.057971,1611.507246,19210.13043,566.7681159,507.4202899,1778.173913,24978.78261,1367.202899,4270.623188,3553.391304,8549.855072,1448.057971,356.2898551,2371.318841,19252.23188,549.4057971,1427.84058,497.4637681,22748.84058,467.3043478,138.1449275,2867.014493,17397.02899,1785.246377,1011.666667,2817.217391,15151.05797,970.6811594,319.4927536,2178.130435,11702.65217,993.2318841,474.6811594,1352.391304,8839.405797,1074.014493,177.5072464,4445.405797,8077.26087,1457.072464,234.1304348,3293.144928,554.6956522,688.6376812,69,12.52001541,7.891480799,0.776344203,0.884615385,0.58974359,-1.222803225
+3236,32572.7651,901.9530201,575.6174497,1090.711409,29626.51678,735.295302,695.0805369,1545.268456,17161.25503,560.0536913,1148.979866,1761.510067,23173.5302,1351.637584,3915.295302,4784.302013,7905.993289,1524.912752,336.6241611,2472.637584,17876.54362,504.1208054,736.9865772,762.9127517,21204.46309,551.8926174,133.0067114,2839.671141,16259.7047,1640.496644,952.3624161,2795.657718,14308,768.3557047,309.9395973,2118.261745,11024.36913,1240.557047,458.2348993,1324.771812,8437.067114,877.0738255,180.6979866,5837.416107,7716.778523,1447.201342,447.3959732,3245.66443,563.8389262,693.261745,149,15.61408918,12.51486403,0.597980048,0.919753086,0.62605042,-0.244554135
+3237,26556.94595,878.8243243,628.9324324,1124.790541,24839.06081,706.5878378,901.777027,1635.52027,13484.73649,529.8986486,868.4256757,1801.472973,19524.2973,1303.02027,1612.716216,2262.824324,7088.364865,1517.790541,332.6891892,2571.837838,14163.5,822.3918919,380.6621622,486.2567568,17549.40541,474.1756757,141.472973,1302.141892,13240.7973,1610.513514,513.1013514,2814.540541,11540.27703,867.2972973,283.6081081,1850.216216,8885.22973,1623.459459,431.9797297,1324.337838,6336.202703,748.7837838,167.5135135,2958.351351,5690.783784,1379.222973,430.0810811,3232.486486,849.8513514,693.0810811,148,17.57476247,11.79412682,0.741382099,0.840909091,0.621848739,-0.062065426
+3238,31515.10811,1077.333333,560.2972973,1074.585586,29595.17117,736.4864865,612.6576577,1561.414414,16450.16216,564.7027027,934.9459459,1790.018018,20231.27027,1317.531532,4935.207207,2890.774775,7269.486486,1397.63964,332.4954955,2354.963964,15570.48649,416.972973,341.2162162,954.3333333,18103.07207,434.7747748,370.7657658,2777.387387,14370.24324,2072.261261,553.6666667,2840.477477,12816.07207,742.7837838,300.7477477,1296.54955,9173.18018,1053.09009,447.7657658,1387.81982,7026.630631,686.1981982,175.2522523,3949.369369,6330.387387,1391.873874,301.4594595,3311.441441,367.0990991,692.2432432,111,14.04965908,10.78490074,0.640896599,0.925,0.711538462,0.65914854
+3239,19671.40323,959.9112903,544.0564516,1094.306452,17453.00806,760.4596774,775.8145161,1707.169355,10161.45968,566.7741935,767.9032258,1885.540323,13136.52419,1356.556452,3017.475806,2119.806452,4636.677419,1405.201613,340.3064516,2341.91129,9502.782258,1362.032258,249.5645161,1041.145161,10677.97581,455.8709677,136.0483871,1011.975806,8221.741935,1866.241935,550.2903226,2840.040323,7393.862903,648.4354839,300.2822581,1515.943548,5731.927419,1363.491935,456.7096774,1333.354839,4854.782258,1941.556452,202.9193548,1894.580645,4505.830645,2046.887097,2867.330645,3406.072581,425.4516129,693.8709677,124,15.60618366,11.04308078,0.7066039,0.892086331,0.607843137,0.221781367
+3240,21064.27807,790.2085561,520.0588235,1083.064171,19461.39572,645.8663102,535.0962567,1513.647059,10737.49198,489.5668449,562.8930481,1804.128342,14340.81818,1185.042781,4519.13369,2867.994652,5183.593583,1320.080214,305.486631,2373.203209,11417.57754,1344.368984,608.1176471,502.459893,13042.19251,493.5080214,121.1176471,2779.705882,9971.828877,1574.064171,884.2620321,2806.97861,8887.930481,710.802139,266.6203209,2206.764706,6906.235294,910.144385,406.7058824,1321.770053,5311.668449,741.6898396,159.8181818,4247.828877,4711.839572,1304.877005,169.459893,3247.331551,541.9786096,696.9946524,187,21.26513301,12.69553914,0.802232321,0.877934272,0.492105263,-0.682798139
+3241,40943.30357,862.3035714,477.2857143,1099.446429,38186.58929,714,615.9821429,1559.375,21444.125,536.2142857,772.8928571,1719.625,28340.26786,1293.339286,3265.5,2909.875,10189.30357,1329.875,320.5892857,2387.892857,21838.76786,448.1607143,238.3035714,751.125,26657.375,563.5892857,145.0714286,1901.339286,19751.03571,1558.571429,576.0892857,2800.517857,17463.25,688.4285714,293.6071429,1662.946429,13564.44643,988.0714286,422,1319.785714,9750.446429,682.1428571,163.7321429,3845.089286,8582.410714,1395.339286,487.3392857,3192.375,765.8214286,690.4642857,56,9.115475957,8.094463724,0.459860171,0.888888889,0.622222222,-0.120799197
+3242,21053.60952,890.247619,473.8190476,1041.333333,19339.31429,677.6952381,449.5142857,1400.6,10262.3619,510.5619048,498.4761905,1671.561905,15073.67619,1214.542857,2070.2,1619.12381,5413.447619,1199.438095,317.847619,2349.590476,10761.90476,393.4952381,580.2,536.352381,13505.79048,405.9714286,124.7619048,1451.780952,10273.0381,1409.209524,447.1904762,2843.847619,8821.914286,618.4380952,252.7619048,1340.257143,6757.990476,805.9428571,396.1428571,1325.771429,4687.571429,696.8190476,154.4285714,3047,4262.390476,1215.971429,595.6285714,3189.609524,909.7047619,691.7428571,105,12.17169807,11.28450333,0.37478927,0.9375,0.673076923,0.828619321
+3243,48103.58442,907.7272727,570.974026,1162.818182,43426.84416,758.2857143,509.1168831,1874.311688,21702.02597,585.8181818,526.5584416,1763.324675,29200.97403,1340.584416,8113.883117,6315.545455,10774,1430.012987,360.9350649,2360.948052,22681.35065,449.1298701,178.0519481,455.974026,27062.48052,476.1948052,141.5324675,6377.831169,19970.5974,1628.155844,448.2597403,2829.441558,16956.28571,624.025974,309.4805195,1829.428571,9043.246753,853.8961039,449.9480519,1291.051948,6576.545455,652.2077922,164.9350649,2908.454545,5893.922078,1328.714286,137.4415584,3262.818182,170.9350649,692.0649351,77,10.80117518,9.538967062,0.469106518,0.93902439,0.636363636,1.193410718
+3244,22377.29697,1113.49697,585.1818182,1079.739394,20393.71515,714.3818182,523.1272727,1555.951515,11635.25455,573.3757576,868.8666667,1758.909091,14422.73333,1280.727273,4843.145455,2909.678788,5348.393939,1382.042424,401.9515152,2349.412121,11181.77576,398.4969697,487.6545455,1079.181818,13366.23636,482.7090909,127.1939394,3827.660606,10209.93333,1680.406061,529.8848485,2819.163636,8999.448485,629.9151515,282.8787879,1459.763636,6443.854545,1686.381818,432.7878788,1322.866667,4914.036364,701.2606061,178.369697,5780.048485,4374.151515,1299.89697,196.4363636,3344.563636,329.3878788,694.7030303,165,19.21788259,11.03136878,0.818844204,0.942857143,0.606617647,-0.803949153
+3245,32088,944.9318182,517.375,1125.670455,27583.85227,774.9659091,710.625,1616.636364,16212.52273,577.3977273,623.7159091,1766.545455,21193.64773,1370.25,2911.215909,3321.159091,7501.159091,1909.090909,351.9772727,2383.761364,15932.10227,813.8636364,842.0340909,2482.125,19043.44318,442.9545455,135.1022727,2077.022727,14268.38636,1628.75,691.3522727,2817.613636,12665.95455,824.5795455,317.0227273,1600.125,10010.29545,1195.25,477.7386364,1357.340909,7512.375,1031.897727,182.8409091,4611.465909,6735.397727,1483.579545,477.8977273,3440.443182,467.3409091,691.8636364,88,11.48151947,9.973576652,0.495402624,0.967032967,0.611111111,-0.86272302
+3246,32744.44444,937.1481481,626.0092593,1079.166667,28375.67593,716.6018519,672.6574074,1563.287037,16410.62963,534,944.9537037,1738.805556,21774.75,1330.666667,2782.814815,2653.842593,7525.361111,1293.25,304.3055556,2376.333333,16495.57407,538.4722222,114.6759259,591.3240741,19833.7963,840.2777778,123.7962963,1877.083333,15061.87037,1512.194444,593.3796296,2805.425926,13354.39815,1498.138889,268.6018519,1472.62037,10062.91667,1107.638889,403.25,1307.342593,7530.675926,624.9444444,162.537037,2202.537037,6739.166667,1377.37963,404.9259259,3230.481481,633.4722222,692.7037037,108,12.3864108,11.774604,0.310398245,0.864,0.75,0.919277046
+3247,34259.26271,882.8305085,622.779661,1117.415254,31016.16102,721.9152542,932.8813559,1594.70339,17554.02542,541.1779661,1086.491525,1731.483051,23022.33898,1328.440678,2448.762712,2982.042373,8322.194915,1342.864407,330.3474576,2374.177966,17567.24576,545.1271186,134.5338983,852.7881356,21407.61864,1513.813559,127.7627119,1802.491525,15904.52542,1512.618644,595.5508475,2809.508475,14055.42373,1203.110169,289.0847458,1743.508475,10511.08475,1152.889831,426.7627119,1306.644068,7928.983051,639.7457627,167.8559322,3585.050847,7059.29661,1417.855932,645.9661017,3252.288136,755.6440678,695.2033898,118,19.02677003,8.186693667,0.902699107,0.874074074,0.595959596,-0.342047473
+3248,30598.97273,889.3727273,631.0363636,1124.836364,28132.69091,719,760.8818182,1593.336364,16232.33636,545.8272727,1301.536364,1831.109091,21344.55455,1274.072727,3146.781818,3724.136364,7619.954545,1273.245455,310.8909091,2415.345455,15986.83636,434.9,752.4454545,1573.872727,18953.97273,443.4727273,417.0272727,1881.745455,14299.36364,1986.190909,564.4363636,2807.827273,12539.5,786.4818182,282.1545455,1703.472727,9489.527273,1204.009091,412.3909091,1332.827273,6967.645455,784.8181818,160.7909091,2446.890909,6012,1312.027273,372.6363636,3245.627273,804.9,693.4454545,110,13.60033252,10.6747658,0.61963505,0.93220339,0.564102564,-0.269012304
+3249,35885.35227,924.25,818.1931818,1157.556818,31568.21591,753.375,816.7272727,1726.977273,18375.03409,548.0227273,492.9431818,1792.045455,24650.73864,1366.454545,2478.443182,1895.647727,9078.772727,1390.125,356.5,2378.920455,18581.56818,628.4318182,151.1136364,479.3409091,22483.60227,496.5795455,135.0568182,2333.704545,17751.52273,1516.75,532.6590909,2808.272727,15554.89773,1609.5,297.625,1815.704545,11853.42045,969.9090909,452.3636364,1330.579545,8240.363636,660.4431818,173.3636364,2050.681818,7603.125,1472.079545,305.9545455,3244.840909,837.1704545,691.2386364,88,12.67767414,9.189450464,0.688903542,0.926315789,0.752136752,-1.342243221
+3250,38117.82301,931.0088496,486.0442478,1079.469027,35631.66372,746.1415929,610.7345133,1592.707965,19437.79646,551.3628319,918.9911504,1743.39823,26813.77876,1347.176991,3834.867257,3553.088496,9360.477876,1388.433628,341.3451327,2312.309735,19073.23009,440.1946903,171.7964602,833.7876106,23425.55752,441.7610619,136.0176991,2400.80531,17725.53097,1750.946903,515.4159292,2793.566372,15359.90265,679.2566372,294.3893805,1737.274336,11512.60177,1158.982301,433.7168142,1302.309735,7977.575221,655.1327434,165.7964602,4252.548673,6944.265487,1355.238938,342.3362832,3225.522124,871.3539823,695.3185841,113,15.04640404,9.909052752,0.752522819,0.941666667,0.642045455,-0.518503908
+3251,41756.93103,837.9655172,485.8103448,1098.051724,38724.56897,682.2241379,691.8103448,1610.086207,21983.58621,520.7758621,548.6896552,1688.862069,30833.87931,1281.913793,4938.62069,3040.775862,11197.46552,1324.241379,349.6724138,2350.344828,22459.77586,536.0862069,1271.431034,620.6724138,27787.2069,441.6034483,138.6896552,3758.275862,21240.27586,1734.862069,535.5517241,2794.396552,18467.81034,825.7413793,285.137931,1601.5,14153.5,893.0689655,438,1357.844828,9342.034483,975.6724138,162.9310345,3231.913793,8545.793103,1323.517241,189.862069,3256.706897,896.137931,689.7758621,58,11.66584416,6.467948534,0.832227246,0.966666667,0.878787879,-1.535040133
+3252,13308.98148,762.4074074,545.0740741,1063.425926,15912.53704,797.7592593,823.1296296,1554.888889,6038.148148,473.0185185,1749.759259,1871.888889,10394.62963,1148.814815,9471.703704,3326.166667,3759.12963,1262.685185,284.8148148,2889.925926,7618.037037,1111.888889,895.7592593,976.1481481,9612.722222,498.3518519,336.9444444,2319.685185,6506.666667,2578.444444,803.4259259,2786.351852,5738.018519,2167.62963,244.9814815,1389.703704,4380.666667,1284.944444,398.0185185,1394.222222,3327.5,762.3888889,155.6481481,7834.666667,2764.666667,1219.5,728.5,3200.185185,946.462963,690.5740741,54,11.82219146,6.369497168,0.84244992,0.818181818,0.5625,1.541960873
+3253,38619.65625,893.8333333,576.4583333,1132.989583,30433.44792,680.8645833,1013.677083,1683.916667,14460.26042,481.875,1684.552083,1874.083333,20864,1195.958333,7409.916667,3634.479167,7933.760417,1216.104167,311.53125,2532.739583,15399.71875,440.6875,818.0833333,1410.15625,19003.76042,492.1041667,1172.1875,3853.0625,14591.9375,2378.927083,397.96875,2806.9375,11617.625,592.1041667,258.5416667,1299.916667,7536.739583,1261.989583,388.1770833,1298.677083,3916.96875,743.4166667,151.6770833,3933.322917,4051.791667,1134.90625,758.5416667,3151.854167,1068.104167,692.8125,96,13.34723396,10.15456718,0.648987149,0.897196262,0.571428571,0.424198328
+3254,27781.7451,1066.980392,613.1764706,1227.421569,25969.62745,829.3333333,608.1764706,1765.480392,14492.08824,609.8235294,579.872549,1781.598039,18961.53922,1561.921569,1728.911765,3426.284314,6451.882353,1545.656863,401.254902,2412.058824,14189.20588,508.1470588,176.2745098,518.1666667,16909.62745,482.6078431,153.7352941,2570.431373,12929.56863,1638.235294,736.9411765,2818.637255,11534.04902,692.0588235,349.9411765,2269.147059,8804.088235,1126.647059,534.9019608,1347.460784,7088.343137,723.2843137,215.8627451,3988.666667,11536.32353,2305.362745,1382.676471,4264.156863,436.9803922,694.8627451,102,13.2009214,10.1988399,0.63491079,0.918918919,0.653846154,-0.724828168
+3255,24522.32609,984.6521739,643.8804348,1134.456522,21967.19565,755.1521739,511.4782609,1611.130435,12704.3587,583.2608696,614.173913,1761.054348,16375.70652,1435.804348,3384.630435,2329.195652,5984.858696,1890.478261,364.076087,2389.586957,12197.77174,459.7934783,807.9891304,525.9130435,14494.51087,611.7173913,135.7717391,1986.336957,10743.02174,1657.565217,661.576087,2873.75,9567.086957,941.6521739,308.1521739,1533.282609,7448.706522,1002.48913,470.8695652,1343.956522,5688.163043,899.3804348,184.7717391,3880.271739,5220.434783,1463.521739,282.7934783,3274.521739,491.3369565,693.1304348,92,11.76040531,10.4982244,0.450700175,0.893203883,0.638888889,1.05924864
+3256,25802.39844,969.640625,562.3125,1073.023438,22645.36719,732.6640625,743.21875,1504.09375,12969.79688,574.015625,1397.046875,1761.03125,16974.3125,1335.148438,3146.695313,3635.195313,6099.09375,1453.054688,314,2409.4375,13452.73438,455.7890625,310.453125,1147.960938,16138.96094,1339.757813,124.53125,1473.335938,12253.5625,1499.03125,678.453125,2812.398438,10796.75781,698.765625,282.015625,1660.539063,8216.460938,1591.265625,435.34375,1331.929688,6323.359375,815.3515625,168.8203125,4364.007813,5645.242188,1376.390625,767,3255.859375,576.3046875,694.5234375,128,13.98814122,11.69242338,0.54891049,0.948148148,0.703296703,-0.651486175
+3257,26333.49242,926.8484848,510.280303,1078.795455,23076.53788,733.2954545,951.5984848,1580.848485,13444.96212,527.7121212,2137.962121,1819.5,18140.38636,1302.310606,4449.242424,3422.825758,6650.893939,1318.212121,347.8333333,2508.113636,13448.34091,458.1136364,247.4469697,2241.856061,16463.46212,602.8863636,164.4848485,1283.886364,12997.99242,2554.136364,445.1590909,2810.477273,11282.19697,985.3333333,284.4545455,1299.984848,8408.219697,2596.234848,432.7727273,1303.560606,5560.727273,680.3484848,162.8863636,3522.310606,5227.780303,1327.113636,521.8484848,3213.181818,924.75,695.0227273,132,13.32712559,12.74638647,0.291980478,0.956521739,0.676923077,0.56993127
+3258,49944.49587,919.5785124,631.9421488,1166.272727,33532.10744,657.0991736,429.338843,1701.413223,16720.85124,507.0495868,583.338843,1742.280992,22557.42149,1186.057851,8220.867769,5386.14876,8297.595041,1256.702479,312.2644628,2437.239669,17242.87603,374.1818182,130.0826446,444.5619835,20081.71074,654.5702479,125.9669421,8331.082645,15379.86777,1454.595041,444.5206612,2816.991736,12937.57851,577.3471074,277.2561983,3153.041322,6384.305785,801.3801653,405.1900826,1292.768595,4499.77686,612.4049587,160.0826446,2737.636364,4336.719008,1172.884298,158.0330579,3163.702479,158.5619835,695.892562,121,14.86048771,10.89290063,0.680216809,0.889705882,0.540178571,1.26899331
+3259,37333.10526,1055.536842,606.5157895,1119.915789,34713.18947,795.1157895,642.7263158,1640.031579,19144.22105,626.4842105,948.4315789,1810.263158,23257.14737,1352.421053,9864.715789,5199.547368,8697.484211,1397.884211,345.2526316,2415.663158,17723.90526,429.0526316,850.0947368,819.6947368,21311.57895,482.0105263,340.2526316,7600.189474,16727.75789,1666.452632,495.9263158,2842.284211,14319.83158,613.7789474,299.1578947,1771.578947,9106.294737,930.3894737,439.0421053,1317.863158,6827.947368,783.8421053,170.9473684,4082.494737,5865.536842,1300.221053,198.9894737,3482,248.9789474,693.9052632,95,12.51375835,9.869271903,0.61481202,0.931372549,0.664335664,0.836433529
+3260,29198.19608,825.1078431,509.2712418,1083.245098,26301.44118,673.751634,620.0457516,1537.189542,14771.12745,537.4869281,507.0163399,1743.529412,20185.42157,1243.663399,3576.673203,2469.820261,7339.973856,1307.045752,334.1535948,2346.915033,15366.72876,2127.27451,426.6666667,511.5620915,18915.64052,510.7875817,117.6503268,1639.107843,13872.62745,1693.797386,792.7156863,2797.042484,12391.68954,827.8529412,260.496732,1639.150327,9482.732026,1078.009804,397.7810458,1319.434641,7087.415033,721.2908497,157.1339869,2985.372549,6402.055556,1337.816993,305.1960784,3240.356209,670.5915033,696.4771242,306,27.20066537,16.49899267,0.795033308,0.842975207,0.607142857,1.549139197
+3261,22862.21622,996.3648649,570.5540541,1069.364865,20479.43243,725.6081081,734.7837838,1485.675676,11669.75676,563.9864865,597.2162162,1707.932432,15787.97297,1321.418919,1342.337838,1740.594595,5375.621622,1533.310811,320.5945946,2333.972973,11541.32432,423.3108108,407.1486486,564.7837838,13799.72973,442.3783784,125.0540541,1302.027027,10884.55405,1488.189189,478.8108108,2826.310811,9471.891892,659.8513514,260.8108108,1609.202703,7131.581081,1015.364865,411.8378378,1329.054054,4968.094595,743.8243243,153.6486486,2815.081081,4259.148649,1256.567568,373.1891892,3294.081081,858.5540541,694.7972973,74,11.70529553,8.141369223,0.718498295,0.961038961,0.685185185,-0.154330567
+3262,37361.82353,827.1911765,494.6764706,1101.044118,28133.25,647.5294118,910.3088235,1609.470588,13243.77941,466.4117647,1629.794118,1803.294118,20924.85294,1180.147059,9690.205882,3934.602941,8031.382353,1189.308824,311.2941176,2684.852941,15076.29412,403.2352941,811.9558824,1697.279412,19349.83824,523.2205882,128.6911765,2064.808824,14223.02941,3133.117647,376.7352941,2834.235294,11294.02941,580.3088235,262.5735294,979.2941176,7575.25,1722.279412,392.8823529,1292.235294,3846.058824,732.7794118,152.0441176,3071.779412,4085.926471,1138.352941,248.0735294,3164.514706,1077.397059,693.75,68,10.36078678,8.981147903,0.498585831,0.85,0.68,-0.898923936
+3263,37022.63529,967.2,531.1470588,1083.776471,33072.62941,748.1294118,666.7764706,1551.882353,18879.90588,551.9176471,947.6235294,1723.747059,25112.95882,1359.682353,3670.794118,3018.764706,8740.417647,1341.358824,323.0588235,2343.652941,19351.83529,481.1529412,206.4235294,1096.247059,23214.30588,823.5529412,130.2823529,3288.005882,17666.97059,1574.288235,657.7058824,2792.435294,15897.21176,747.4941176,289.4058824,1461.635294,11903.21176,1172.152941,412.6235294,1302,8976.194118,658.7941176,162.6470588,2047.270588,8310.011765,1429.105882,413.8411765,3275.823529,621.0705882,697.7294118,170,17.7593936,12.56558412,0.706667503,0.899470899,0.62962963,-0.562220752
+3264,32979.37143,812.2571429,562.0285714,1073.671429,30652.41429,691.9,986.6857143,1552.171429,17182.74286,517.2857143,2226.042857,1776.2,23729.3,1247.042857,4171.7,3849.114286,8442.142857,1341.785714,303.6714286,2554.042857,17552.97143,698.4142857,134.5428571,1817.542857,21598.87143,791.4714286,507.7,2153.385714,15861.81429,2349.985714,522.3571429,2777.728571,14043.98571,673.2142857,274.5571429,1526.757143,10831.91429,1819,414.7285714,1301.242857,8023.8,627.0857143,163.1714286,5200.6,7192.271429,1330.557143,560.3428571,3228.257143,773.0285714,695.3571429,70,10.9643285,9.657767861,0.473422782,0.777777778,0.53030303,-1.564736752
+3265,39869.75229,930.3211009,532.4587156,1102.862385,35226.11009,762.8348624,879.7155963,1647.018349,19410.99083,533.9908257,1547.330275,1778.844037,25951.6422,1282.770642,6709.733945,3967.66055,9512.486239,1333.40367,342.9266055,2527.577982,19211.3945,548.0458716,723.0917431,1329.192661,23129.49541,480.3211009,143.9724771,2685.284404,18248.66055,2453.761468,546.0183486,2841.688073,15621.22018,763.6972477,284.7981651,1326.770642,11342.49541,1552.302752,432.8623853,1302.12844,7198.100917,784.9082569,160.3761468,5227.798165,6770.577982,1338.183486,328.6788991,3308.733945,955.3944954,695.7247706,109,17.20711676,8.859363232,0.857270536,0.879032258,0.558974359,-0.78144959
+3266,31306.12414,804.5103448,607.3724138,1086.006897,27159.51724,668.1241379,890.0965517,1603.724138,15145.94483,499.5655172,2096.082759,1899.8,20715.88966,1209.317241,9353.993103,3283.172414,7935.896552,1243.965517,320.1793103,2689.827586,15534.57241,415.0275862,761.3448276,1269.103448,18480.13793,600.262069,129.4896552,1594.889655,14963.52414,2964.531034,1060.075862,2831.910345,12554.96552,593.2,270.6275862,1195.544828,9102.103448,1878.655172,406.7103448,1360.848276,5539.524138,780.2,163.662069,7109.689655,5355.062069,1239.124138,338.3655172,3269.17931,985.4344828,696.5862069,145,14.12048384,13.14469363,0.365285821,0.960264901,0.739795918,1.081176502
+3267,21543.08219,867.1050228,513.5570776,1075.757991,21422.30594,712.2876712,547.0319635,1595.159817,11263.0137,558.4155251,573.8310502,1786.269406,14374.38813,1244.762557,5985.785388,3061.077626,5271.191781,1331.196347,316.8310502,2355.826484,11122.35616,739.0593607,1305.872146,488.4611872,13400.41096,442.3150685,127.8310502,4310.251142,10309.45205,1645.086758,510.1917808,2808.182648,9019.178082,726.0776256,277.0776256,1752.502283,6051.803653,879.8858447,434.56621,1379.30137,4575.739726,914.9269406,174.2054795,6917.369863,4100.694064,1313.630137,498.2785388,3271.050228,281.8767123,703.1917808,219,28.32949653,10.22333735,0.932615146,0.890243902,0.5475,-0.395044026
+3268,35678.74627,994.8656716,545,1091.358209,32291.56716,761.5671642,592.641791,1568.268657,19071.52239,594.5970149,592.3134328,1760.731343,23595.89552,1370.567164,3232.164179,3290.626866,8123.940299,1628,345.0298507,2381.686567,17145.02985,425.1044776,271.8955224,735.6716418,21148.01493,477.4925373,133.5373134,3237.701493,16606.92537,1659.865672,604.1044776,2803.731343,14371.59701,808.2985075,305.3283582,1637.41791,10390.28358,998.3731343,470.9701493,1376.671642,7839.223881,685.761194,180.6716418,4485.328358,7310.641791,1415.970149,148.1343284,3345.61194,348.2089552,695.6865672,67,13.03198123,7.575589981,0.813683877,0.848101266,0.515384615,-1.180674888
+3269,33043.14765,1087.087248,634.8389262,1111.416107,29568.36913,778.0402685,698.0939597,1545.711409,17022.24161,607.5838926,720.8724832,1739.885906,21797.10738,1378.966443,4038.932886,3201.825503,7877.744966,1478.013423,333.5973154,2420.879195,16477.28859,439.3422819,290.0604027,586.0536913,19500.48993,535.8456376,129.3825503,2938.342282,14838.30872,1706.503356,696.7718121,2809.436242,13032.89933,661.557047,301.4161074,1632.597315,10142.3557,1097.295302,450.6308725,1329.503356,7616.469799,688.7516779,168.4832215,3091.899329,6908.651007,1397.214765,167.5234899,3449.040268,475.7986577,699.4630872,149,14.40425479,13.51439862,0.346032068,0.925465839,0.620833333,0.843693243
+3270,39290.675,898.5875,653.325,1150.55,33637.9375,699.2125,745.7125,1645.075,19021.125,533.9375,459.1375,1756.55,26359.4,1285.8375,2639.4375,2994.3,9363.9375,1356.45,343.7125,2374.45,19387.8875,438.8375,473.15,533.4,23113.2375,449.7625,142.2375,2877.2125,18048.5125,1475.5375,555.5,2812.9,15784.325,841.0125,291.625,1843.2875,11991.1625,1077.45,438.825,1323.325,8653.45,742.1125,163.875,2595.975,7676.6375,1401.3125,211.95,3308.2125,824.8625,697.6375,80,11.91330917,9.801431764,0.568432978,0.816326531,0.519480519,0.62798799
+3271,30576.61856,800.1649485,496.0927835,1065.371134,26608.37113,656.8453608,809.6494845,1540.412371,15002.35052,491.8556701,2175.608247,1784.14433,20887.71134,1203.639175,6519.680412,3924.319588,7656.206186,1324.154639,326.1030928,2449.247423,15132.85567,1494.85567,934.5257732,2615.226804,18160.17526,474.1443299,129.742268,3284.164948,14539.50515,2230.164948,531.4845361,2828.329897,12223.35052,808.0824742,268.8659794,1309.71134,8967.701031,1635.443299,406.2268041,1320.793814,5710.030928,832.4742268,161.2061856,5379.381443,5493.175258,1288.783505,269.7938144,3213.28866,963.9381443,697.6494845,97,14.22784671,8.902399824,0.780061749,0.941747573,0.62987013,-0.514999009
+3272,26766.04255,801.9929078,609.035461,1073.93617,24877.46099,658.4680851,695.5673759,1596.48227,12470.87943,486.3617021,907.035461,1760.829787,17754.15603,1172.801418,7860.921986,3307.496454,6623.51773,1240.092199,305.9787234,2408.51773,13036.52482,469.9787234,1058.404255,679.5390071,16358.05674,787.0425532,125.3191489,2421.978723,12588.96454,2151.347518,1133.886525,2792.404255,10571.36879,657.9432624,263.2198582,1268.382979,7609.574468,1072.510638,396.8510638,1301.092199,4593.758865,850.5248227,165.0638298,8029.815603,4451.64539,1214.219858,666.4184397,3184.865248,1004.971631,698.3900709,141,14.75403232,12.59118084,0.521246648,0.946308725,0.671428571,-1.229375348
+3273,31879.01887,879.1698113,577.0754717,1101.830189,31112.71698,708.1320755,715.9245283,1649.90566,15927.83019,571.7169811,779.8867925,1792.415094,20524.39623,1253.377358,7199.584906,5218.981132,7649.09434,1368.490566,337.5283019,2397.018868,16117.77358,439.2264151,237.2264151,443.3962264,19441.69811,489.7924528,131.0377358,5387.188679,14780.16981,1547.433962,535.2075472,2814.603774,12834.83019,671.5660377,294.9811321,2119.377358,7990.584906,889.9056604,437.1132075,1315.169811,6201.566038,651.0377358,169.6603774,5273.169811,5299.320755,1341.415094,190.0566038,3428.773585,241.7358491,697.4339623,53,11.06424392,7.285297825,0.752620803,0.828125,0.438016529,0.577645484
+3274,24085.14884,1088.860465,559.7348837,1078.762791,23449.37674,765.8093023,684.3627907,1563.813953,12593.44651,614.4325581,639.1674419,1761.702326,15539.43721,1337.190698,4190.009302,4090.688372,5755.27907,1403.87907,325.8976744,2424.474419,12086.46512,447.7953488,1361.590698,523.8,14174.99535,553.544186,128.9581395,3399.460465,10728.0186,1658.846512,655.8418605,2826.702326,9427.237209,625.2744186,284.7302326,1876.116279,6517.32093,1019.660465,432.3813953,1324.525581,5135.502326,872.5162791,170.5302326,3711.586047,4417.074419,1329.609302,176.7209302,3458.813953,305.3953488,703.427907,215,20.89700229,13.65100473,0.757140715,0.888429752,0.568783069,-0.451853079
+3275,26467.72941,869.6470588,548.3764706,1106.211765,24236.51765,717.8705882,849.3176471,1544.705882,13550.89412,548.4470588,1363.811765,1779.6,18118.70588,1312.223529,2998.505882,4104.141176,6267.411765,1372.094118,330.0705882,2505.152941,13346.6,452.2117647,162.7882353,935.2352941,16169.76471,1015.435294,135.8823529,2003.247059,12275.62353,1651.611765,687.2823529,2827.647059,10861.28235,823.9764706,289.3647059,1997.329412,8438.505882,1462.847059,446.2941176,1327.176471,6297.835294,639.6470588,171.6705882,3475.529412,5744.882353,1406.058824,822.6117647,3275.988235,526.6235294,698.0588235,85,12.13714726,9.265471619,0.645928623,0.988372093,0.653846154,-0.337888168
+3276,19607.98077,831.2211538,469.4903846,1100.759615,18371.66346,696.8173077,657.7788462,1572.721154,10115.07692,507.8269231,518.3173077,1821.134615,13557.35577,1230.932692,2661.692308,1901.375,4759.701923,1297.855769,338.7884615,2367.951923,10667.23077,453.8461538,1383.951923,504.9134615,12430.53846,442.0480769,128.9903846,1518.615385,9572.625,1652.682692,735.5480769,2822.653846,8619.355769,1410.605769,279.7980769,1941.894231,6687.365385,834.8365385,424.8846154,1354.557692,5158.355769,1059.076923,163.4903846,3387.432692,4646.076923,1343.778846,177.8076923,3317.605769,553.25,699.7788462,104,13.3907634,10.91140492,0.579678025,0.852459016,0.533333333,0.187567922
+3277,28524.83836,855.1506849,524.6520548,1108.112329,23780.93973,670.7287671,691.6684932,1646.476712,11801.95342,484.7671233,1527.824658,1751.671233,17067.41096,1215.30137,5448.6,3721.315068,6478.194521,1251.180822,318.3068493,2895.167123,12710.3726,698.6438356,890.6958904,930.5424658,15771.59452,1626.441096,130.060274,3124.205479,12105.56438,1711.254795,455.4438356,2808.50411,9946.539726,949.8136986,264.539726,1247.268493,7280.583562,1534.375342,398.0739726,1316.317808,4235.068493,811.6493151,158.3890411,4767.986301,4198.2,1241.649315,1335.736986,3196.843836,1023.838356,702.5589041,365,23.34510611,20.37970672,0.487763978,0.953002611,0.633680556,-0.906160189
+3278,38653.66917,962.9699248,579.2030075,1117.285714,37800.58647,782.1503759,756.3759398,1704.827068,20962.50376,600.406015,868.2030075,1783.481203,26471.66165,1386.496241,5630.924812,4756.443609,9789.135338,1476.984962,366.0827068,2372.932331,20775.63158,476.7293233,429.1879699,716.0150376,24795.08271,485.2932331,140.5037594,3763.781955,19162.2782,2082.112782,570.9097744,2848.323308,16873.54887,716.2857143,339.4887218,1693.135338,11647.04511,1161.533835,480.8947368,1325.827068,8677.601504,751.2781955,188.6992481,4150.804511,7777.924812,1482.496241,194.3684211,3439.954887,295.3759398,698.9398496,133,18.17389715,9.6693094,0.846716829,0.936619718,0.633333333,-0.717028049
+3279,21827.1547,845.9834254,549.5856354,1054.828729,19430.22099,669.4254144,574.878453,1454.392265,10793.32597,506.6187845,494.1049724,1737.430939,14432.72376,1240.624309,3638.756906,3554.099448,5228.790055,1285.469613,301.7071823,2364.651934,11290.44199,435.5414365,1084.546961,523.0441989,13579.74033,429.8121547,114.9116022,2110.712707,10176.39779,1559.187845,719.2375691,2807.607735,9116.232044,849.5745856,263.6464088,1785.220994,6871.359116,879.3646409,394.7237569,1349.348066,5294.939227,1146.674033,154.6077348,4149.121547,4866.077348,1327.453039,1067.78453,3160.790055,594.718232,698.7071823,181,20.5550416,11.89444967,0.815566492,0.900497512,0.632867133,-1.497580843
+3280,42540.97761,937.8855721,521.5646766,1097.328358,37954.9403,744.0223881,882.7512438,1661.738806,21397.31343,551,1802.211443,1791.121891,30050.68159,1325.0199,5285.380597,3974.751244,10696.68657,1353.350746,371.2810945,2552.937811,21386.44279,478.6691542,509.0273632,1629.90796,26342.72388,574.721393,135.5597015,2892.106965,20198.67662,2329.995025,517.8308458,2809.146766,17535.85572,669.4651741,297.420398,1543.512438,13122.10199,1300.741294,437.9129353,1318.415423,8702.664179,764.0248756,168.2985075,3814.378109,7989.542289,1364.975124,268.0970149,3307.539801,897.3507463,702.2164179,402,30.32597528,18.22265706,0.799329699,0.860813704,0.617511521,-1.445918778
+3281,30450.03448,878.2068966,468.045977,1099.793103,28502.68966,706.7126437,801.3333333,1635.114943,14904.68966,531.2643678,1108.206897,1777.448276,20841.17241,1291.08046,3085.114943,2575.195402,7677.264368,1619.931034,363.5747126,2386.62069,15540.78161,494.9195402,539.0344828,760.1724138,19256.17241,483.4137931,157.5172414,1444.367816,14579.45977,1815.701149,479.0804598,2935.057471,12716.62069,1019.045977,292.0574713,1327.114943,9256.298851,1261.804598,426.7471264,1308.45977,6300.586207,832.8275862,169.3908046,2421.206897,5733.448276,1356.126437,954.7586207,3204.287356,936.2068966,699.5057471,87,15.45334023,8.198871382,0.847649522,0.798165138,0.58,-0.215749569
+3282,28994.07216,932.9896907,679.0206186,1136.917526,25358.10309,734.7835052,601.2886598,1692.010309,14012.80412,519.2989691,1344.329897,1778.113402,19567.65979,1357.56701,5469.154639,3645.237113,7318.412371,1366.969072,476.3195876,2470.814433,14531.05155,450.1752577,163.3608247,1075.886598,17508.36082,691.5773196,143.5463918,4731.690722,14084.13402,2430.041237,485.1546392,2797.329897,11819.8866,663.1649485,306.8865979,1453.340206,8604,1703.876289,438.0927835,1322.670103,5479.28866,654.8350515,173.4329897,4603.28866,5353.360825,1356.134021,182.1958763,3203.649485,973.6804124,699.1443299,97,12.34175391,10.50980022,0.524249753,0.898148148,0.621794872,-0.457188755
+3283,29926.64384,1105.30137,520.0684932,1097.808219,28345.43836,681.1712329,807.4520548,1557.815068,16193.17123,543.9931507,808.6575342,1775.047945,20714.42466,1255.19863,4498.931507,2982.746575,7883.931507,1376.972603,342.1164384,2384.486301,16351.15753,1056.445205,1302.869863,2231.150685,19329.0411,420.9657534,130.1369863,2410.554795,15024.5,1772.541096,552.7945205,2818.363014,13543.75342,641.4178082,303.869863,1284.041096,10169.95205,1455.116438,455.1506849,1334.616438,7797.979452,1284.979452,171.9931507,2523.815068,7224.013699,1427.917808,375.9726027,3452.773973,392.7054795,699.890411,146,14.63738339,13.16501647,0.437104946,0.966887417,0.744897959,-1.068044833
+3284,25903.41071,966.8571429,555.5,1084.910714,23221.10714,732.9107143,793.2857143,1502.321429,12937.82143,570.5357143,752.25,1738.107143,16865.875,1339.535714,3711.803571,3277.875,5893.642857,1682.107143,339.125,2360.732143,12880.51786,604.25,1130.107143,2876.25,15028.55357,435.75,130.7142857,2726.482143,11360.07143,1756.875,663.8571429,2824.803571,9992.089286,731.0535714,288.9464286,1639.696429,7674.410714,1299.732143,444.9821429,1367.196429,5957.910714,954.1785714,171.9285714,4925.839286,5335.607143,1450.464286,555.4642857,3467.803571,461.8928571,698.7678571,56,10.1219553,7.497625502,0.671803987,0.933333333,0.56,1.027634558
+3285,38920.27653,1030.392283,643.6045016,1141.199357,34979.15434,789.9871383,894.0932476,1646.643087,20430.77492,621.9196141,1244.633441,1790.92926,26082.04502,1453.263666,2658.327974,3501.315113,9150.990354,1481.498392,360.4983923,2459.803859,20030.36334,1046.221865,193.977492,918.5241158,23958.82958,1067.369775,138.9131833,2022.66881,17736.1254,1726.102894,667.9067524,2825.59164,16081.32154,786.4790997,328.4019293,1775.299035,12326.57556,1500.913183,483.6366559,1329.453376,9354.594855,685.8263666,184.0643087,2519.803859,8368.276527,1521.871383,787.7588424,3437.398714,509.1575563,703.0803859,311,28.9990211,14.97425214,0.856365015,0.88101983,0.563405797,-0.882538198
+3286,20438.76471,930.0588235,578.5294118,1045.512605,18201.76471,688.9579832,820.7731092,1434.07563,10516.39496,528.6638655,1386.823529,1760.058824,14214.42017,1256.546218,2246.042017,2532.647059,5105.781513,1240.462185,299.8823529,2506.378151,10603.7479,467.907563,121.7815126,1003.07563,12798.52941,1152.722689,136.3865546,942.9327731,9667.848739,1539.151261,552.4201681,2794.655462,8546.831933,840.8823529,257.0252101,1335.117647,6606.016807,1204.731092,377.3865546,1298.655462,4984.008403,582.7563025,149.4201681,1812.226891,4551.857143,1244.941176,959.7058824,3318.218487,684.092437,703.0504202,119,17.21096925,9.075321012,0.849680013,0.901515152,0.56937799,-0.184305725
+3287,43251.12227,888.6244541,498.5196507,1097.39738,39558.40611,731.3406114,892.3406114,1598.541485,23081.67686,551.9519651,1863.554585,1756.558952,29832.63319,1348.222707,4157.497817,5912.008734,10329.20087,1369.663755,352.7030568,2622.100437,22696.87336,461.1746725,147.5633188,1183.187773,27490.26638,1501.174672,163.2401747,2137.489083,20636.62445,1801.048035,640.489083,2791.694323,18724.41048,644.7991266,293.6113537,1687.751092,13987.44105,2146.061135,430.3842795,1297.703057,10217.84279,649.7510917,164.5283843,3461.71179,9169.458515,1412.58952,501.3449782,3223.637555,710.9956332,700.9257642,229,21.61056085,14.90244787,0.72419906,0.874045802,0.681547619,-1.284709729
+3288,35753.10976,903.7560976,693.7317073,1132.317073,30367.13415,763.1463415,891.4878049,1643.073171,18493.52439,541.0365854,914.9390244,1780.646341,24297.62195,1356.731707,2857.439024,2803.378049,8694.5,1345.085366,321.2926829,2575.682927,17999.85366,472.2439024,109.195122,777.7439024,21661.89024,731.5731707,187.4512195,2204.719512,16757.90244,1608.219512,554.8902439,2816.04878,14733.85366,915.4268293,283.0731707,1696.597561,11054.04878,1232.243902,428.3414634,1304.780488,8158.573171,637.7439024,165.5731707,3276.695122,7435.304878,1416.780488,215.304878,3284.646341,744.8414634,698.3658537,82,13.56688409,8.550043808,0.776421269,0.88172043,0.573426573,1.329884794
+3289,30220.3,934.625,655.5,1127.325,26920.125,727.3416667,732.0416667,1611.975,15226.025,540.0416667,564.6833333,1735.358333,20455.85833,1343.058333,1486.925,1419.725,7115.416667,1325.35,320.8083333,2367.066667,15341.65,467.9,109.4166667,523.025,18596.10833,650.925,126.7083333,1221.508333,13822.30833,1455.375,541.075,2802.433333,12168.85,671.975,273.6583333,1662.925,9198.566667,950.8166667,430.5833333,1315.766667,6903.066667,616.6583333,169.9916667,1973.225,6133.091667,1427.775,1086.141667,3216.525,761.9166667,702.1583333,120,15.56353114,10.44657565,0.741256899,0.882352941,0.615384615,-0.39341042
+3290,38002.34146,1063.105691,938.2195122,1209.861789,34482.93496,779.3252033,920.8699187,1807.601626,19705.00813,564.9105691,591,1785.512195,25703.21138,1403.390244,1256.886179,1271.235772,9182.577236,1436.723577,341.9918699,2409.00813,19215.73171,8480.341463,154.6504065,616.902439,23225.8374,531.4715447,139.9186992,1244.056911,17209.2439,1599.560976,508.9349593,2797.98374,15132.17886,1514.365854,305,1549.886179,11525.56098,903.8373984,450.5203252,1335.585366,8324.227642,647.3252033,172.8536585,1337.617886,7333.178862,1434.666667,134.6178862,3397.845528,794,699.7723577,123,13.22570916,12.10755733,0.402417646,0.938931298,0.675824176,-0.721794361
+3291,31650.93458,926.8317757,996.3551402,1231.747664,29979.34579,820.7757009,1314.140187,1805.093458,16188.14953,546.8878505,1018.336449,1867.046729,22743.85047,1334.962617,1633.682243,1688.018692,7845.271028,1430.261682,340.8317757,2511.224299,16569.8972,469.3738318,287.5420561,962.6635514,20078.85047,469.2056075,217.0093458,997.3457944,14893.04673,1727.205607,491.8691589,2792.785047,12970.51402,921.0560748,288.271028,1489.728972,9958.280374,937.317757,433.4299065,1333.785047,7370.205607,661.2429907,160.9906542,1722.140187,6484.71028,1414.28972,203.7570093,3300.616822,811.3831776,700.6261682,107,15.095187,9.554498582,0.774192676,0.899159664,0.548717949,-0.783341446
+3292,41057.02857,872.447619,483.4666667,1102.057143,37210.89524,713.5333333,1035.314286,1660.27619,20660.70476,524.1904762,2237.419048,1859.266667,27771.92381,1278.847619,5759.914286,4053.32381,10402.92381,1337.87619,343.2761905,2549.371429,20792.2381,463.6380952,287.1428571,1773.028571,25575.08571,478.0952381,162.1619048,1463.990476,20038.20952,2239.438095,520.1333333,2829.047619,17512.01905,656.8380952,286.8857143,1338.161905,12615.50476,1638.285714,435.1333333,1322.52381,8116.72381,683.152381,168.8571429,3493.666667,7746.447619,1351.6,302.5142857,3266.809524,944.2380952,700.8666667,105,15.5416459,8.91916381,0.818933809,0.92920354,0.65625,-0.18243558
+3293,24673.97647,819.5294118,594.8352941,1104.082353,19124.94118,598.4941176,480.3882353,1516.741176,8932.247059,433.8470588,505.8,1702.6,13210.32941,1145.552941,6186.870588,1957.905882,5114.741176,1118.894118,283.2588235,2298.8,9788,2658.823529,471.8941176,519.9529412,12178.88235,389.3176471,140.7058824,4589.729412,9230.211765,1435.117647,451.0235294,2780.870588,7558.941176,580.0588235,228.8823529,1099.011765,5163.388235,737.4352941,359.1882353,1260.635294,2688.305882,649.5529412,144.6470588,3613.282353,2773.976471,1053.176471,578.6588235,3082.329412,1063.705882,700.5529412,85,12.7564843,8.765353179,0.726535221,0.977011494,0.544871795,0.731202692
+3294,35826.93333,966.9777778,586.6666667,1104.966667,31043.58889,637.3222222,535.0888889,1581.422222,15909.9,521.8111111,497.7222222,1748.144444,20809.64444,1199.077778,9466.411111,4340.933333,7919.555556,1310.388889,317.5222222,2306.166667,16788.7,410.7777778,312.7888889,420.9777778,20240.7,416.3666667,131.7555556,7401.5,15436.27778,1451.4,511.4111111,2830.333333,13522.8,642.2555556,280.3555556,2372.077778,7794.111111,799,433.3222222,1287.355556,5937.955556,654.7888889,164.3444444,3818.722222,5211.633333,1261.177778,332.5222222,3239.722222,208.1777778,699.5444444,90,13.31264645,8.870208848,0.745684289,0.927835052,0.692307692,-1.248109692
+3295,33622.93421,824.0263158,571.5657895,1093.631579,31060.60526,661.5394737,600.8421053,1639.210526,16774.82895,546.0921053,560.7105263,1790.434211,21621.5,1232.578947,10479.53947,4942.315789,8235.210526,1333.684211,335.1315789,2337.236842,16748.15789,433.3421053,462.25,451.1578947,20429.68421,441.9210526,131.6052632,8026.539474,15862.48684,1518.842105,472.2631579,2812.723684,13718.19737,620.4078947,292.9473684,1832.736842,7894.236842,798.25,431.0789474,1300.552632,5918.723684,718.6578947,172.7105263,9014.815789,5404.368421,1298.065789,223.1052632,3285.631579,219.2763158,701.0394737,76,12.72863207,8.058902813,0.774043937,0.904761905,0.531468531,0.667539098
+3296,21328.15823,1142.303797,543.3607595,1127.664557,19829.76582,850.721519,660.9493671,1752.132911,11023.65823,626.5696203,454.278481,1752.556962,14237.12025,1461.64557,2216.329114,1282.563291,5226.132911,1484.417722,361.5696203,2323.240506,12083.29747,540.0506329,259.3670886,460.0443038,14301.25949,480.8037975,151.3101266,1007.670886,10916.55696,2520.164557,555.443038,2829.335443,9907.189873,809.9873418,372.5696203,1401.981013,7457.335443,1132.373418,528.9113924,1347.240506,5875.443038,1357.721519,198.164557,1055.113924,5398.037975,1784.974684,1106.924051,3374.620253,418.7658228,703.164557,158,16.33889791,12.96472745,0.608585257,0.929411765,0.516339869,0.795955089
+3297,29860.13475,1085.964539,559.4326241,1074.787234,26787.71631,674.0141844,521.1560284,1511.879433,15491.60993,532.7588652,493.8085106,1744.48227,19324.34752,1268.070922,5108.205674,2977.361702,7145.22695,1366.056738,326.7021277,2354.758865,15294.5461,418.3404255,562.4184397,527.0567376,17720.82979,429.4042553,128.8865248,3983.737589,13677.60993,1607.276596,564.2269504,2827.148936,12211.39007,649.8156028,296.2765957,1489.70922,8883.716312,885.106383,438.7234043,1340.794326,6804.553191,756.5460993,178.2340426,4756.617021,6184.134752,1354.907801,475.0567376,3302.22695,377.1631206,701.7375887,141,15.93701,11.42483159,0.697202521,0.952702703,0.734375,-1.453015216
+3298,29406.25,1065.763158,668.5,1155.407895,26946.88158,782.1052632,901.6578947,1692.447368,15185.28947,622.4078947,1090.394737,1770.355263,18995.09211,1414.815789,2655.618421,2087.223684,6993.407895,2260,356.9736842,2571.5,14601.22368,472.3684211,407.6710526,690.5526316,16702,1377.144737,141.2236842,1416.486842,12381.32895,1612.763158,626.9078947,2867.342105,11204.98684,1309.671053,324.1447368,1629.828947,8565.907895,1175.644737,466.8552632,1339.631579,6556.210526,733.6578947,185.3815789,3541.381579,5571.486842,1423.223684,215.7631579,3421.960526,487.2763158,701.9605263,76,14.84644092,7.526781791,0.861960465,0.8,0.562962963,0.286443181
+3299,41542.98058,883.7281553,508.961165,1105.951456,36942.85437,741.0582524,703.4854369,1590.504854,22153.84466,544.9417476,1160.456311,1790.427184,28521.73786,1340.242718,4477.145631,4585.320388,9835.660194,1352.330097,329.8834951,2684.990291,21541.68932,458.9805825,156.368932,752.2427184,26090.86408,904.0291262,135.0970874,3559.572816,19848.47573,1729.07767,707.592233,2797.398058,17756.08738,634.0679612,298.2912621,1797.912621,13474.97087,1460.601942,418.4854369,1300.165049,9794.84466,677.7475728,158.961165,4336.543689,8872.407767,1404.660194,396.5242718,3244.417476,696.9126214,701.1359223,103,13.0474394,11.03863311,0.533122161,0.895652174,0.66025641,-1.316717257
+3300,33322.51587,1010.785714,745.1349206,1148.912698,29088.7619,792.7142857,904.6746032,1734.809524,16879.37302,573.8571429,714.5079365,1801.055556,22422.00794,1392.896825,2066.269841,1765.15873,8023.206349,1380.325397,341.2301587,2412.301587,16359.02381,502.5396825,286.1507937,517.7142857,19508.85714,504.6666667,133.4444444,1751.206349,15509.40476,1680.563492,502.7539683,2826.444444,13499.65079,1913.912698,303.5,1712.992063,10069.09524,1012.944444,444.7380952,1324.666667,7026.047619,675.0634921,168.9047619,2000.769841,6244.087302,1424.079365,328.468254,3470.103175,840.3095238,701.1111111,126,16.86136508,9.788014449,0.814260584,0.926470588,0.636363636,1.206968109
+3301,56984.7013,964.2597403,601.038961,1178.155844,40854.44156,720.987013,420.038961,1847.935065,20914.58442,551.4155844,627.7662338,1797.363636,28254.28571,1293.103896,7956.909091,5566.298701,10119.63636,1350.12987,346.0779221,2350.844156,21821.55844,421.987013,138.0649351,423.7012987,25551.8961,683.1688312,133.6103896,7382.428571,19742.44156,1506.25974,499.2597403,2811.948052,16633.01299,600.2857143,312,2148.948052,8171.753247,859.8571429,426.2727273,1285.285714,5912.532468,603,167.2337662,3469.272727,5590.363636,1269.012987,142.4415584,3225.337662,167.8181818,701.5194805,77,12.94199918,7.690155457,0.80431621,0.950617284,0.641666667,-0.909627102
+3302,50422.75758,910.3181818,577.4393939,1151.643939,46560.05303,755.9469697,608.2878788,1851.522727,23137.90909,586.5151515,576.5530303,1804.674242,31533.16667,1364.840909,8714.545455,5223.030303,11524.62879,1442.189394,362.7348485,2323.575758,24068.21212,1711.136364,313.2045455,436.6969697,29069.98485,488.7045455,138.1287879,8144.143939,21423.88636,1555.530303,485.8712121,2826.174242,18563.84091,627.6287879,318.3030303,2192.924242,9633.666667,827.2348485,449.5,1306.356061,7087.674242,691.5378788,169.1060606,3328.189394,6498.340909,1354.484848,164.4924242,3288.636364,180.4166667,701.8939394,132,15.11263701,12.01194434,0.606835016,0.840764331,0.597285068,-1.556142028
+3303,38652.05303,911.7272727,497.7954545,1116.893939,35400.07576,721.7727273,730.0833333,1706.212121,19375.71212,580.1742424,1165.19697,1803.833333,24588.33333,1304.840909,5820.878788,3355.613636,8740.356061,1362.560606,332.1666667,2440.030303,18454.24242,4353.098485,574.1818182,552.2348485,23352.87879,1120.825758,139.8409091,4926.181818,18180.66667,1613.856061,479.5833333,2834.787879,15576.61364,749.8409091,317.2575758,1462.954545,9940.393939,1015.424242,462.1742424,1330.166667,7471.575758,767.4545455,172.5075758,3604.363636,6775.795455,1364.462121,221.780303,3397.333333,271.25,703.2727273,132,15.59028297,11.31216671,0.68812638,0.936170213,0.634615385,-0.19329788
+3304,43699.51316,1145.631579,802.4868421,1190.460526,38981.75,912.5131579,873.3026316,1758.118421,23589.14474,680.5789474,884.9210526,1783.421053,30170.96053,1695.763158,2145.368421,2747.381579,10235.90789,1918.671053,410.0394737,2468.855263,22727.96053,583.8157895,171.1315789,888.3815789,27960.56579,696.6447368,183.5263158,1909.197368,20669.94737,1862.381579,641.3815789,2830.157895,18538.21053,1634.171053,377.4473684,1904.605263,13870.07895,1220.355263,532.3289474,1342.578947,10615.69737,738.3157895,202.1710526,3050.973684,9844.184211,1703.355263,279.8684211,3427.815789,495.5657895,703.6973684,76,12.51235635,8.092296334,0.762706816,0.894117647,0.584615385,-0.373574498
+3305,37259.10072,907.4748201,629.3273381,1112.413669,33585.55755,792.5179856,994.9496403,1649.111511,19636.55036,579.8021583,1582.81295,1790.528777,25463.66547,1340.866906,2420.553957,3078.561151,9183.94964,1361.143885,325.971223,2447.978417,19397.04317,2010.895683,257.9028777,1679.931655,23863.4964,712.1007194,195.6510791,1779.28777,17442.01439,1972.679856,571.1258993,2799.697842,15554.93165,794.2230216,291.7338129,1532.622302,11774.30935,1508.586331,429.4748201,1317.464029,8610.694245,669.9928058,170.3381295,3249.938849,7760.428058,1393.553957,298.0611511,3259.003597,775.5791367,707.618705,278,20.94191707,18.03161752,0.508554273,0.847560976,0.695,-0.588046129
+3306,34893.328,807.584,530.112,1073.392,25443.92,550.904,632.448,1448.6,11430.576,411.872,1404.504,1668.76,17224.4,1026.24,5889.8,1724.072,6571.456,1087.296,272.432,2562.328,12350.904,339.456,190.664,817.072,15510.248,367.88,111.984,2296.064,11443.44,1771.696,370.968,2804.328,9091.528,512.76,228.952,845.504,5838.512,867.016,346.696,1276.952,2959.352,556.848,140.4,1371.44,3066.472,987.176,214.28,3095.224,1077.92,703.328,125,15.91282715,10.7001957,0.740164528,0.899280576,0.56561086,-1.11141827
+3307,44626.01099,947.5054945,674.3186813,1247.967033,18049.05495,479.4340659,342.1483516,1323.631868,8644.598901,393.3736264,406.9945055,1682.576923,11617.12637,940.5,4930.983516,3367.510989,4345.730769,1006.510989,240.456044,2317.901099,8622.010989,263.8406593,85.64835165,395.967033,10204.54945,362.478022,100.4120879,5780.89011,7519.082418,1352.494505,349.5604396,2781.994505,6268.972527,484.021978,218.6263736,1684.098901,2903.67033,627.4285714,330.9725275,1273.065934,2127.642857,514.4230769,133.0054945,1716.478022,2064.813187,942.5934066,106.7637363,2982.912088,152.2087912,705.6978022,182,18.6923485,12.62815894,0.737287566,0.962962963,0.736842105,1.451889148
+3308,37385.64662,992.6691729,553.3383459,1108.616541,35360.78195,750.2030075,923.2932331,1699.706767,18370.3609,597.8721805,1295.684211,1921.488722,23171.43609,1332.87218,7616.203008,4729.007519,8714.090226,1380.466165,340.3233083,2493.030075,18372.44361,1853.225564,223.6090226,474.6917293,21790.69173,515.3007519,131.7368421,5002.300752,16782.78947,1750.578947,462.8345865,2827.857143,14483.33083,634.5714286,308.9849624,1533.736842,8749.06015,1137.293233,439.7894737,1315.428571,6683.037594,653.1203008,170.7744361,4177.857143,5805,1333.451128,242.481203,3401.977444,235.7368421,707.0451128,133,19.27919199,10.00372011,0.854842902,0.820987654,0.475,-0.531477909
+3309,30835.84444,1012.555556,478.5,1076.822222,28714.15556,733.2,557.2666667,1543.911111,16894.58889,585.7666667,509.0777778,1727.722222,20240.86667,1325.533333,4366.177778,1517.255556,7487.888889,1441.066667,331.3222222,2321.722222,15603.94444,402.1555556,326.1888889,439.3888889,18944.43333,441.4555556,133.3111111,2545.466667,14607.57778,1549.411111,542.0444444,2800.577778,12718.96667,665.6333333,296.8111111,1393.333333,8894.422222,870.4111111,443.9333333,1312.277778,6817.188889,689.1555556,170.6777778,3744.088889,6140.777778,1359.444444,151.2444444,3375.033333,317.5555556,704.3222222,90,12.19645637,9.569758578,0.619958822,0.947368421,0.692307692,-0.126054834
+3310,22623.98701,1022.058442,576.1623377,1051.12987,21279.2013,733.6818182,542.8636364,1495.11039,11927.6039,592.987013,732.4675325,1747.824675,14997.2987,1297.584416,6096.058442,3168.116883,5378,1378.311688,315.0064935,2340.350649,11714.02597,437.2207792,434.9350649,671.9935065,14007.15584,414.8766234,203.0519481,4302.935065,10802.1039,1693.785714,542.2207792,2811.305195,9396.941558,602.6883117,278.512987,1604.564935,6764.058442,955.3311688,428.1623377,1307.584416,5198.967532,681.525974,168.4220779,4376.857143,4745.097403,1326.038961,415.1428571,3396.11039,338.2467532,708.5194805,154,21.62890642,9.574845844,0.896675975,0.875,0.7,-0.122693793
+3311,36209.05932,920.4830508,544.940678,1083.059322,33617.48305,737.6949153,676.8135593,1569.533898,19137.23729,579.3050847,843.9830508,1757.364407,24510.61864,1365.338983,4802.771186,3331.389831,8624.059322,1468.576271,346.220339,2406,18569.74576,448.3135593,675.8728814,610.6779661,22122.78814,859.5847458,132.1186441,3231.652542,17711.62712,1612.228814,589.2118644,2814.728814,15274.10169,863.6864407,312.220339,1630.271186,10908.82203,973.7372881,470.2966102,1369.398305,8219.720339,779.0508475,185.5338983,5445.822034,7626.084746,1451.220339,402.5847458,3312.525424,348.7118644,704.8135593,118,17.09605404,9.143474849,0.844959972,0.914728682,0.605128205,-0.758192625
+3312,39973.84615,859.2769231,469.0461538,1098.138462,34558.36923,733.1692308,744.1384615,1549.415385,19758.67692,542.2153846,1722.338462,1772.323077,26848.92308,1297.984615,2528.953846,2899.723077,9504.230769,1352.4,313.7538462,2484.307692,20655.03077,467.8615385,160.2307692,969.0307692,24790.69231,776.6,432.1230769,1254.984615,18857.66154,1791.646154,588.6769231,2820.738462,16579.4,1137.107692,273.5076923,1496.169231,12520.81538,1231.476923,400.4461538,1299.553846,9465.538462,640.8307692,164.5538462,1843.892308,8570.215385,1389.430769,589.0769231,3190.107692,633.2769231,702.2461538,65,9.957962318,8.738742111,0.479460825,0.970149254,0.656565657,-1.366103601
+3313,39195.61194,858.9850746,575.358209,1123.940299,35080.14925,884.641791,1085.537313,1675.925373,20162.38806,544.8507463,1659.238806,1838.701493,27153.29851,1298.089552,2711.268657,2947.910448,9616.567164,1352.850746,335.7164179,2428.447761,20179.16418,442.1940299,289.4776119,1624.776119,24147.07463,444.9701493,1307.179104,1403.731343,18865.40299,1891.701493,553.8358209,2801.716418,16435.53731,930.5074627,297.5522388,1674.701493,12533.19403,1054.716418,430.5970149,1312.597015,8834.373134,673.3134328,164.1492537,3789.253731,8004.477612,1371.552239,373.7761194,3381.940299,819.3134328,704.9701493,67,10.19243559,8.732668588,0.515683143,0.943661972,0.558333333,0.163935215
+3314,30072.97959,1116.132653,537,1058.693878,26747.40816,788.0204082,611.8367347,1553.377551,15143.82653,602.2244898,1373.989796,1772.622449,19882.7551,1353.030612,3297.142857,2353.163265,7022.346939,1317.469388,335.3673469,2340.316327,13768.85714,398.5816327,207.5612245,1161.581633,16431.54082,451.1836735,355.9183673,1125.959184,12954.43878,1991.540816,466.8367347,2822.642857,11165.47959,740,264.377551,1386.479592,8283.816327,1091.214286,406.4897959,1298.183673,5589.193878,662.244898,158.6836735,1413.897959,4148.204082,1193.72449,806.8163265,3285.632653,860.622449,704.4387755,98,13.83248585,9.452092471,0.730113722,0.882882883,0.685314685,-1.264186221
+3315,30063.16807,833.4789916,445.7563025,1094.840336,26111.72269,802.4705882,906.5966387,1705.663866,14820.95798,514.4117647,1614.630252,1921.243697,20488.08403,1294.394958,3180.789916,3011.445378,7539.605042,1427.537815,333.0336134,2382.319328,17297.42017,6551.638655,667.9243697,1779.630252,18465.08403,847.6134454,1219.168067,1172.781513,14618.83193,2054.10084,459.9411765,2833.420168,12509.38655,1485.268908,273.5042017,1344.89916,9037.722689,1347.705882,415.1008403,1305.193277,6138.588235,919.1512605,159.2521008,3588.05042,5751.428571,1300.621849,391.2521008,3236.378151,928.210084,708.3445378,119,17.15662133,9.125797121,0.846800209,0.888059701,0.601010101,-0.242269381
+3316,37319.43269,992.4230769,578.7980769,1109.346154,34954.00962,758.1923077,722.8653846,1691.173077,18836.51923,582.3557692,676.6153846,1798.644231,23264.14423,1331.528846,6558.134615,5243.096154,8801.846154,1411.307692,347.2211538,2392.240385,18297.71154,423.75,195.9903846,508.6730769,22243,490.4711538,152.2307692,5760.740385,17126.00962,1585.980769,587.625,2816.471154,14838.22115,688.3173077,318.6538462,1919.019231,9168.471154,888.7980769,453.3653846,1325.673077,6993.317308,662.2211538,177.7211538,5287.884615,6163.778846,1376.048077,477.8461538,3422.817308,250.3269231,705.1346154,104,12.55255259,10.80468027,0.50901842,0.912280702,0.666666667,-1.362964475
+3317,24038.75652,790.9217391,554.2695652,1061.33913,21411.94783,656.3652174,586.4695652,1456.53913,12190.27826,492.0956522,588.9043478,1745.852174,16369.2087,1198.234783,3533.913043,3273.921739,5718.921739,1520.634783,301.3478261,2362.173913,12549.24348,413.3043478,1113.747826,535.5565217,15320.66957,486.4521739,116.2521739,2719.304348,11634.12174,1523.965217,803.3913043,2791.243478,10361.53913,913.973913,268.6347826,1765.686957,7884.4,900.5565217,407.3043478,1357.347826,5941.573913,1039.104348,157.1478261,5922.33913,5557.626087,1307.069565,1048.443478,3159.904348,585.0521739,706.2434783,115,14.71519951,10.85242788,0.67534949,0.92,0.58974359,1.249778321
+3318,25409.83333,947.9833333,799.3166667,1169.283333,22466.95,720.9333333,764.125,1691.383333,12847.66667,550.9333333,949.725,1823.108333,17150.43333,1315.233333,1674.516667,2299.483333,5937.983333,1305.35,326.3666667,2428.458333,12729.45,440.1,269.3666667,632.4,15344.96667,808.1333333,123.0833333,1362.625,11878.54167,1592.125,516.625,2796.491667,10388.11667,658,276.7083333,1497.1,7747.258333,1494.208333,418.2833333,1312.616667,5896.4,661.425,161.8333333,2183.216667,5303.25,1346.408333,369.0666667,3214.075,740.2166667,706.25,120,14.52943853,11.42851572,0.617492771,0.888888889,0.571428571,0.700400184
+3319,28170.07018,947.0789474,612.2105263,1085.535088,24942.58772,724.0789474,675.0789474,1550.570175,13735.58772,557.0614035,639.622807,1717.921053,19941.76316,1305.877193,4562.842105,3639.219298,6835.745614,1283.026316,321.6052632,2546.192982,14022.25439,419.6842105,1735.359649,521.1403509,17010.0614,443.3421053,128.5350877,3314.447368,13002.59649,1758.640351,565.6754386,2788.578947,11156.62281,662.9473684,267.8421053,1800.701754,8537.149123,907.3596491,410.377193,1372.491228,6146.078947,1097.815789,163.0087719,4162.035088,5574.921053,1340.605263,1896.280702,3260.201754,829.8421053,706.9122807,114,14.77077155,10.46148422,0.705955919,0.93442623,0.542857143,-0.892072525
+3320,36709.51675,1060.913876,550.4354067,1105.057416,36430.64115,800.9952153,664.1818182,1711.483254,20479.77033,582.7655502,857.8995215,1743.497608,27528.44019,1407.267943,4381.076555,3491.971292,9360.885167,1375.995215,346.4449761,2344.100478,18459.99043,436.6220096,140.4258373,762.1052632,22659.47368,520.923445,132.8038278,3525.373206,17239.88995,1841.009569,546.784689,2795.124402,14991.78947,746.3253589,299.7033493,1868.334928,11015.89952,1068.942584,435.0956938,1303.157895,7516.803828,636.0909091,168.5789474,3492.430622,6678.641148,1373.799043,439.1004785,3297.196172,876.4976077,709.1770335,209,19.12999123,14.78235322,0.63473263,0.88185654,0.62202381,0.334738312
+3321,29775.03371,815.1797753,536.4794007,1091.434457,20806.08989,783.9026217,629.7303371,1626.033708,9764.044944,451.8913858,1263.958801,1792.385768,14578.04494,1101.827715,6427.280899,2598.378277,5516.11985,1173.775281,288.1947566,2452.490637,10941.1985,487.1273408,575.5280899,1426.501873,13756.09738,422.0037453,494.093633,3452.981273,10336.93258,1872.539326,412.8913858,2796.168539,8416.940075,924.6329588,239.0861423,1118.962547,5883.883895,983.2172285,370.9026217,1297.247191,3107.973783,713.9700375,148.8089888,3916.048689,3208.617978,1083.554307,1114.805243,3192.505618,1053.749064,710.3970037,267,22.03827107,15.81395562,0.696488569,0.933566434,0.618055556,-0.202452898
+3322,15466.59236,1000.509554,588.4904459,1053.121019,14237.15287,735.7643312,594.5477707,1439.866242,7741.796178,566.5477707,818.522293,1776.44586,10201.15287,1277.828025,3907.802548,2818.076433,3730.980892,2432.350318,317.522293,2394.210191,7965.789809,417.5923567,1033.375796,578.433121,9334.356688,466.8216561,122.3057325,2200.847134,7069.025478,1649.286624,674.1783439,2788.146497,6340.974522,829.611465,260.7515924,1601.993631,4829.464968,920.9171975,409.3375796,1332.22293,3806.840764,880.0254777,163.9171975,5386.840764,3370.796178,1279.070064,573.7579618,3276.382166,562.6178344,706.5859873,157,20.54820227,9.901635633,0.876240755,0.907514451,0.603846154,-1.18068681
+3323,24449.13636,802.8636364,565.3818182,1069.809091,21361.1,650.5272727,547.2727273,1614.018182,11798.79091,535.1090909,443.2636364,1813.118182,16171.41818,1216.836364,4297.790909,1587.5,5918.872727,1288.727273,301.4727273,2356.109091,12459.61818,6291.8,566.1090909,481.4454545,15126.4,472.0636364,111.9181818,856.1272727,11346.5,1685.627273,896.4909091,2802.781818,9959.827273,1983.063636,261.7454545,1395,7678.536364,1232.827273,394.9,1311.681818,5801.781818,755.8181818,156.2090909,4086.781818,5270.727273,1298.236364,299.6454545,3224.309091,654.7,706.9272727,110,14.95028468,9.944427218,0.746695148,0.894308943,0.611111111,0.385634787
+3324,34015.64286,926.1806723,530.4243697,1082.806723,28422.65966,755.7226891,645.9285714,1648.277311,15923.69748,566.5672269,1103.915966,1798.079832,22121.0042,1297.62605,5511.815126,3516.004202,8056.920168,1303.886555,340.605042,2455.735294,15820.16387,724.0084034,1118.827731,976.8907563,19289.43697,627.0042017,171.6092437,3913.067227,14812.85714,1771.184874,513.2563025,2792.079832,12642.53782,942.5840336,277.1134454,1521.773109,9243.94958,1203.752101,420.0630252,1304.747899,6217.617647,1087.726891,163.1386555,4113.453782,5560.218487,1285.995798,217.8739496,3282.836134,913.9537815,711.3655462,238,26.73803659,12.29665634,0.887973943,0.826388889,0.495833333,-0.687781253
+3325,30034.36184,971.4078947,591.5,1093.493421,26356.47368,629.7236842,468.5855263,1549.085526,12985.21053,506.125,739.4013158,1777.197368,17080.83553,1167.618421,9118.480263,4486.598684,6581.605263,1267.875,312.4342105,2541.210526,13629.88158,390.2236842,891.7171053,509.2894737,16384.49342,734.1184211,122.8815789,6569.802632,12154.38816,1427.335526,477.5263158,2816.342105,10450.22368,577.0921053,273.8157895,2123.269737,5754.046053,796.375,399.7236842,1303.421053,4456.736842,791.7763158,163.6578947,5171.802632,3902.796053,1239.052632,266.5526316,3251.138158,199.75,709.8092105,152,15.673825,12.50731828,0.602690738,0.938271605,0.730769231,-0.354933508
+3326,34763.552,1090.824,650.944,1106.72,32825.088,779.848,568.76,1665.832,17630.272,639.4,732.296,1758.744,21844.088,1379.984,8440.304,5005.672,7841.584,1385.616,343.864,2353.376,16661.536,440.112,457.992,497.208,20321.304,648.064,133.976,7585.496,15318.544,1607.176,642.072,2818.52,13190.968,616.352,301.288,1812.224,8229.384,884.032,441.712,1309.784,6403.984,703.416,169.064,4129.304,5456.616,1318.904,255.904,3552.992,260.136,709.2,125,16.47633259,10.09289495,0.790416912,0.886524823,0.757575758,-0.255845119
+3327,33278.03429,895.96,567.76,1106.885714,29159.77714,722.5885714,660.7371429,1582.325714,17034.82857,559.9428571,601.4628571,1753.28,22381.86286,1344.622857,3736.2,3926.171429,7846.96,1412.377143,342.3771429,2384.685714,16722.96,479.56,169.7028571,518.84,20480.16571,493.2742857,134.7885714,3255.354286,15268.96,1486.817143,864.1657143,2807.291429,13628.39429,848.92,310.7257143,2226.502857,10465.84571,1099.714286,459.9371429,1325.325714,7787.194286,659.8685714,176.3085714,3594.88,7169.702857,1449.051429,814.2628571,3367.228571,529.5371429,710.72,175,19.27941267,11.87118009,0.787946376,0.930851064,0.575657895,-0.597199902
+3328,13509.42038,768.9171975,455.5031847,1035.127389,12502.42675,613.2101911,524.8598726,1390.171975,6863.184713,463.3184713,434.6942675,1699.012739,9314.292994,1186.44586,1219.617834,933.955414,3420.509554,1296.89172,286.1210191,2322.044586,7411.898089,412.1719745,214.9617834,463.7133758,8940.273885,451.8025478,108.9617834,854.3949045,6698,1310.675159,582.8152866,2843.643312,6051.643312,688.1783439,246.9299363,2068.566879,4580.859873,727.6878981,387.3757962,1320.477707,3516.547771,646.7070064,153.6433121,2562.33121,3353.566879,1266.840764,1931.33758,3223.700637,603.2866242,709.522293,157,16.60699975,12.36827896,0.667329059,0.951515152,0.754807692,-0.327958664
+3329,24538.30061,991.6871166,480.4110429,1062.02454,23232.65644,754.7300613,505.1288344,1479.852761,12027.55828,554.9509202,775.2699387,1719.595092,16151.0184,1350.337423,2350.539877,2062.515337,5720.748466,1270.539877,301.208589,2310.288344,12265.22699,459.4601227,155.9754601,784.7055215,14440.87117,535.9877301,210.0306748,1436.852761,10576.85276,1589.361963,559.5276074,2795.030675,9541.521472,607.9877301,266.8282209,1387.067485,7065.828221,988.2699387,398.3742331,1286.852761,5434.300613,628.3190184,154.2147239,1708.638037,4980.576687,1359.803681,1531.263804,3207.417178,615.4907975,711.4478528,163,17.30274173,12.83040701,0.670925784,0.900552486,0.603703704,0.588979496
+3330,28701.3913,1093.708075,570.9875776,1067.621118,26167.47205,725.689441,670.8074534,1536.720497,15072.37888,557.1428571,1424.447205,1795.863354,20762.26708,1296.993789,4447.043478,3327.726708,6876.42236,1331.006211,341.5403727,2543.099379,15013.50311,409.2981366,178.5031056,1490.68323,18381.42857,472.9813665,208.2608696,2313.279503,13855.22981,2087.31677,531.8136646,2790.565217,12066.50311,600.2298137,260.6273292,1540.869565,8990.795031,1252.881988,394.5279503,1310.167702,6841.093168,640.2546584,152.1677019,3232.863354,6083.552795,1267.496894,241.5590062,3365.062112,728.8819876,709.4968944,161,15.25612469,14.19287187,0.366783079,0.899441341,0.62890625,0.657874145
+3331,29107.90756,895.605042,755.9495798,1155.285714,25862.90756,698.3193277,822.092437,1650.02521,15047.09244,527.7731092,530.8823529,1774.521008,20685.93277,1306.722689,2534.310924,1931.781513,7176.05042,1300.067227,326.5042017,2393.084034,15070.07563,617.2268908,844.6386555,496.0756303,18695.02521,452.8907563,127.5378151,1443.672269,13990,1615.109244,516.9243697,2804.731092,12072.90756,708.6806723,276.2689076,1574.058824,9278.151261,875.3613445,427.5714286,1356.89916,6732.521008,829.0672269,160.5042017,2484.789916,6219.352941,1366.235294,175.9579832,3235.94958,799.0168067,709.7058824,119,13.91710512,11.38558145,0.575076217,0.92248062,0.566666667,-0.432879644
+3332,39553.19792,839.7604167,501.3229167,1095.239583,35358.05208,721.4791667,757.1041667,1638.770833,19385.86458,507.8020833,2950.40625,1877.71875,26054.95833,1239.125,6883.541667,4087.385417,9969.572917,1299.135417,331.3229167,2788.21875,20127.89583,681.71875,167.0520833,1826.729167,24111.76042,505.8645833,199.4166667,1292.03125,19714.32292,2526.479167,424.875,2823.34375,16661.98958,612.34375,286.5,1130.625,11762.82292,2082.104167,415.75,1285.833333,7228.28125,620.375,161.8645833,2714.833333,7086.229167,1288.489583,250.5208333,3249.458333,979.2083333,708.4166667,96,13.09787923,9.555452418,0.683936061,0.95049505,0.571428571,-0.67919874
+3333,36812.83333,849.8431373,564.9313725,1118.843137,32760.65686,694.9607843,454.8235294,1718.607843,16662.16667,543.4705882,536.8823529,1783.186275,22339.20588,1267.284314,8124.068627,3954.45098,8315.058824,1338.647059,334.6960784,2317.411765,17183.80392,712.372549,537.9607843,453.2745098,20620.01961,462.1764706,128.7352941,8299.411765,15446.08824,1496.882353,555.5294118,2811.117647,13202.53922,607.3039216,298.5882353,2249.990196,6962.470588,771.4313725,427.5490196,1303.803922,5133,714.1372549,158.8431373,2986.990196,4782.039216,1274.323529,167.245098,3260.911765,188.9803922,709.5392157,102,14.08140823,9.499063347,0.738199999,0.953271028,0.728571429,-0.27482423
+3334,36079.37374,871.040404,560.3232323,1124.292929,33451.85859,713.3636364,555.7171717,1705.969697,17219.87879,553.969697,529.0505051,1801.89899,22412.67677,1266.59596,9592.313131,6601.060606,8366.939394,1333.080808,336.3737374,2362.717172,17593.10101,426.1818182,1320.636364,462.2222222,21253.55556,444.1919192,135.0505051,8797.454545,16021.19192,1541.313131,720.1414141,2847.969697,13925.9596,595.1919192,294.4747475,1610.626263,7781.383838,834.4646465,435.3737374,1314.434343,5974.565657,871.5757576,168,5287.666667,5236.909091,1307.151515,206.1818182,3293.010101,213.4747475,708.4242424,99,12.69613815,10.07040795,0.608978534,0.961165049,0.692307692,-1.527649538
+3335,26150.25893,961.5535714,476.9732143,1045.723214,24984.64286,728.1785714,552.0982143,1465.196429,14018.21429,580.8660714,540.8214286,1716.455357,17408.10714,1340.232143,2411.410714,2601.982143,6474.169643,1441.919643,330.125,2316.303571,14081.74107,411.7857143,419.3392857,484.0357143,16981.76786,403.1339286,131.5178571,2004.392857,12778.24107,1546.598214,501.9553571,2812.017857,11320.97321,739.7589286,296.1875,1361.375,8032.4375,964.2142857,439.3482143,1315.0625,6232.446429,681.7410714,177.9821429,3451.071429,5657.955357,1372.8125,574.6071429,3284.598214,327.9821429,709.0892857,112,13.31205843,10.81397991,0.5831776,0.949152542,0.727272727,-0.204324455
+3336,31573.00974,1097.581169,597.5357143,1134.243506,29625.0974,824.3733766,686.6071429,1624.311688,16397.93182,630.1493506,1091.876623,1777.136364,20948.51948,1513.883117,3449.944805,3689.201299,7505.824675,1684.032468,378.1006494,2434.626623,16099.03247,472.1688312,567.1168831,1033.512987,19127.31169,572.6233766,143.1168831,2684.090909,14680.25974,1881.779221,904.2045455,2827.305195,13173.27597,675.9545455,326.2694805,1705.435065,10135.27273,1306.230519,497.8409091,1351.204545,7874.058442,782.2662338,190.7337662,3449.347403,7252.714286,1640.896104,341.8798701,3511.701299,457.1980519,711.288961,308,23.57019152,18.31015356,0.629704002,0.922155689,0.636363636,-0.68973964
+3337,45624.92308,970.5384615,506.1153846,1106,40230.23077,848.2115385,920.5192308,1661.538462,22663.05769,574.3846154,2380.576923,1878.134615,30662.44231,1435.384615,2413.730769,4869.519231,10524.28846,1388.788462,315.5192308,2377.134615,23835.59615,505.6153846,152.0192308,2305.5,28681.40385,1003.403846,224.8653846,1677.346154,21827.25,2312.942308,598.4230769,2828.480769,19402.19231,693.8461538,284.1153846,1546.846154,14440.61538,1682.403846,420.6923077,1289.788462,10822.78846,663.3461538,156,2235.538462,9741.634615,1435.807692,260.1153846,3247.884615,626.4615385,706.6538462,52,10.64021001,7.162865411,0.739471059,0.866666667,0.541666667,1.499442285
+3338,32115.8,825.9894737,496.8210526,1076,29117.55789,706.3578947,1040.736842,1548.642105,16638.89474,517.2421053,1929.326316,1818.778947,22151.76842,1292.189474,5440.242105,3958.778947,7767.273684,1373.831579,351.4,2703.473684,16922.94737,510.7263158,129.8315789,1384.463158,20955.57895,987.3894737,507.7578947,2422.621053,15827.35789,2021.905263,626.4421053,2779.726316,13954.68421,742.9473684,272.8736842,1619.842105,10599.28421,1450.210526,408.4947368,1304.252632,7915.915789,633.1052632,156.8315789,4055.231579,7144.242105,1333.747368,357.1473684,3259.273684,689.8526316,711.6947368,95,17.03173275,7.740362379,0.890763518,0.840707965,0.558823529,-0.167982995
+3339,32518.61628,806.494186,602.4186047,1088.895349,25639.36628,669.2616279,684.494186,1572.837209,13726.12791,462.2325581,2228.459302,1872.156977,19352.38372,1140.052326,8180.662791,3838.122093,7139.668605,1204.534884,293.3604651,2760.19186,14355.68605,386.2267442,400.3081395,2115.709302,17397.90116,478.4883721,858.7732558,1648.848837,13985.30233,2643.854651,772.6860465,2798.145349,11713.37209,569.622093,254.1453488,1077.023256,8310.005814,1372.133721,389.505814,1285.465116,5067.261628,641.3197674,155.8139535,6161.360465,4940.645349,1168.180233,256.4011628,3145.05814,991.9186047,711.1686047,172,17.06686204,13.70022848,0.596331102,0.868686869,0.603508772,-0.556943859
+3340,36024.23954,902.4790875,560.7528517,1130.885932,25305.06084,658.3307985,607.2509506,1637.038023,12533.79848,479.269962,1752.65019,1786.60076,18053.14068,1173.969582,6439.954373,3917.13308,6746.053232,1220.418251,309.8365019,2522.064639,13435.75665,498.6197719,981.338403,1428.334601,16932.95057,681.4068441,130.3193916,3830.863118,12988.24715,2194.114068,414.6920152,2803.798479,10604.77186,634.6159696,263.6121673,1231.095057,7611.623574,1526.661597,386.8821293,1312.775665,4249.380228,821.026616,156.1520913,3997.174905,4323.311787,1195.596958,853.1558935,3211.155894,1033.779468,713.8821293,263,28.29774105,12.50405821,0.897076739,0.906896552,0.498106061,-0.846435324
+3341,23252.42697,801.6685393,516.7134831,1082.938202,14479.17978,430.9438202,236.6966292,1209.865169,6293.219101,344.6741573,943.2191011,1596.02809,9869.853933,856.9494382,3123.926966,916.4101124,3743.168539,915.3932584,221.5,2287.426966,6661.292135,255.011236,102.3089888,558.8876404,8047.724719,275.3258427,93.24719101,1299.803371,6067.146067,1194.174157,360.3426966,2786.404494,4826.516854,443.9269663,177.6629213,716.9719101,2822.837079,580.0505618,299.3876404,1243.016854,1430.573034,479.0561798,120.8764045,466.9494382,1496.926966,816.988764,149.7977528,2898.550562,1085.966292,711.0280899,178,17.23679192,13.27104469,0.638133848,0.972677596,0.654411765,-0.908075787
+3342,34313.98291,987.1153846,559.2094017,1091.217949,30316.09402,775.0811966,773.2435897,1557.380342,17619.03846,592.0854701,1082.260684,1764.213675,23384.68803,1381.551282,3522.910256,3942.196581,7969.487179,1445.764957,337.7564103,2391.192308,17536.69231,487.9358974,345.7606838,944.0042735,21368.63675,492.8461538,175.7863248,2807.042735,16158.09402,1562.602564,770.1410256,2815.611111,14309.66667,784.6709402,306,1824.367521,10819.07692,1274.850427,453.7521368,1324.84188,8156.200855,698.3717949,172.474359,3115.337607,7519.666667,1422.247863,851.6666667,3329.333333,537.457265,717.1282051,234,29.18092881,11.76013803,0.915196602,0.795918367,0.423913043,-0.645526059
+3343,25095.12687,841.3507463,776.8358209,1106.149254,22881.95522,679.4701493,688.9776119,1664.41791,12095.94776,645.8059701,508.2761194,1782.828358,16896.77612,1307.634328,2397.186567,1661.940299,6043.485075,1343.037313,340.9402985,2399.798507,13028.20896,4308.619403,702.8731343,518.238806,16242.64179,486.4104478,115.9477612,957.9552239,11670.33582,1624.11194,584.2313433,2796.529851,10196.01493,3875.574627,273.0820896,1445.014925,7899.738806,1249.38806,395.1567164,1342.671642,5948.440299,836.2089552,159.7835821,5162.156716,5385.08209,1347.313433,361.2462687,3240.940299,664.2761194,711.7537313,134,16.01879055,11.05005108,0.723982762,0.917808219,0.644230769,-0.127335608
+3344,31938.16342,843.5719844,547.3579767,1086.747082,29323.38911,736.8599222,727.8171206,1688.964981,15900.80156,512.536965,2720.36965,1828.684825,21576.76265,1251.346304,7639.276265,3679.245136,8072.961089,1323.988327,325.8015564,2576.120623,15887.05447,464.5175097,369.2723735,2188.957198,19270.80156,727.8754864,264.4396887,2486.712062,15373.58755,2686.478599,596.9455253,2799.536965,12837.4358,649.0233463,280.2723735,1412.782101,9150.968872,1839.696498,413.9416342,1317.544747,5771.455253,674.6264591,166.3501946,6390.63035,5607.33463,1305.268482,356.7859922,3281.18677,967.5680934,715.8988327,257,24.85375446,14.01383513,0.825875962,0.821086262,0.594907407,-0.20281726
+3345,28969.17895,912.2315789,562.4315789,1093.463158,26982.72632,703.8526316,448.4736842,1664.442105,13580.8,553.5473684,566.7578947,1762.715789,17869.2,1268.273684,10089.30526,4783.568421,6722.210526,1327.494737,329.5578947,2338.431579,14396.62105,459.8105263,614.5473684,462.3052632,16824.92632,461.6315789,128.2,5330.347368,12533.24211,1482.378947,487.3684211,2792.252632,10771.12632,591.4631579,282.7263158,1658.263158,6277.452632,798.7368421,419.3789474,1285.578947,4784.136842,724.9368421,164.3684211,4265.936842,4153.515789,1256.273684,175.4315789,3410.694737,224.4315789,711.1368421,95,13.79041728,9.078452357,0.752741684,0.931372549,0.664335664,-0.694308899
+3346,28265.7037,871.3259259,502.3259259,1100.325926,26182.42222,707.7925926,621.6444444,1612.022222,14849.98519,565.037037,588.7703704,1792.57037,18303.11111,1286.162963,5825.562963,3321.2,6759.644444,1435.288889,341.7851852,2371.02963,14560.34815,419.837037,1233.651852,542.8888889,17093.48148,485.5481481,137.0740741,2766.948148,13057.1037,1636.274074,663.9777778,2870.192593,11707.71852,926.3037037,304.2296296,1780.807407,8480.874074,946.637037,453.962963,1307.8,6544.22963,939.2074074,174.6592593,4523.051852,5918.140741,1401.688889,768.4592593,3340.125926,371.8074074,711.6666667,135,15.28625434,12.18818167,0.603544244,0.912162162,0.5625,1.427756054
+3347,23877.74054,866.2540541,455.9459459,1072.113514,21968.05405,733.3297297,582.0054054,1486.443243,12406.41622,549.0864865,876.4108108,1744.794595,16098.93514,1342.302703,2340.843243,1390.718919,5926.681081,1374.297297,338.572973,2347.367568,12409.08649,410.2108108,205.5891892,533.1621622,14651.23243,428.1567568,252.6054054,1006.427027,11356.21622,1589.037838,554.5675676,2814.783784,10322.00541,742.9675676,287.3783784,1466.394595,7843.913514,1057.07027,453.172973,1315.908108,6013.437838,900.1081081,179.5081081,2112.978378,5670.362162,2370.794595,7665.124324,3246.459459,411.2108108,714.4378378,185,16.88722272,14.48783877,0.513787976,0.989304813,0.608552632,-0.421714447
+3348,28259.41053,900.1894737,597.9894737,1075.557895,25610.81053,717.5578947,978.9368421,1521.147368,14495.82105,569.7263158,1777.673684,1798.442105,18552,1284.452632,5119.326316,3475.021053,6766.294737,1715.463158,329.7263158,2614.4,14405.2,419.0210526,1202.105263,1457.168421,17287.72632,723.9157895,276.7894737,1874.557895,12880.23158,1894.105263,636.6,2837.442105,11483.71579,691.4526316,284.2,1659.652632,8829.726316,1179.231579,442.2631579,1354.526316,6868.357895,938.8947368,174.3052632,4481.747368,6171.6,1386.031579,416.1473684,3280.421053,483.6315789,711.4,95,13.72580656,9.324950385,0.733792569,0.896226415,0.56547619,0.51440915
+3349,40570.68966,876.2241379,517.3218391,1105.568966,36862.70115,719.9310345,807.4482759,1611.068966,21458.58046,546.6781609,1241.212644,1797.5,28115.68391,1327.798851,3498.028736,3484.816092,9422.58046,1471.775862,386.3275862,2586.798851,21281.05172,466.954023,216.2471264,1047.781609,25970.27586,543.5287356,156.9022989,2396.16092,19500.95977,1833.189655,631.3965517,2791.505747,17525.5,633.5574713,278.7701149,1702.022989,13122.32184,1251.097701,425.9252874,1303.063218,9586.293103,683.2126437,164.2816092,3885.275862,8519.143678,1391.95977,187.2068966,3291.310345,710.8908046,712.4827586,174,22.81201537,11.12996812,0.872899878,0.794520548,0.517857143,-1.142961306
+3350,36095.97842,906.471223,556.8345324,1097.478417,31528.48921,716.2194245,709.971223,1596.338129,18029.67626,539.705036,1529.068345,1783.406475,24364.77698,1287.305755,3018.478417,3787.723022,8955.532374,1318.744604,325.7266187,2652.064748,18135.36691,414.1582734,150.4316547,879.4640288,22289.59353,916.0971223,129.3669065,2059.546763,17124.24101,1917.47482,531.294964,2805.017986,14779.05755,674.1151079,285.2697842,1959.413669,11322.06835,1507.352518,429.6223022,1310.107914,7686.010791,659.4352518,168.5683453,4873.841727,7137.733813,1369.456835,604.4964029,3306.946043,849.2769784,715.7338129,278,22.67893821,16.88457203,0.667617419,0.888178914,0.549407115,0.75341294
+3351,48807.34286,922.6952381,620.647619,1152.361905,34992.55238,668.1238095,506.7714286,2791.304762,16925.41905,535.1047619,471.1904762,2052.171429,23056.17143,1248.190476,10064.22857,5887.933333,8356.952381,1296.590476,332.7142857,2307.419048,17941.58095,401.9714286,154.0190476,421.4666667,21349.59048,430.2666667,127.9619048,10704.80952,15961.29524,1432.72381,442.447619,2810.485714,13665.32381,582.7904762,286.2761905,2145.152381,6642.828571,749.9428571,407.6095238,1296.161905,4898.685714,612.3619048,161.6190476,3512.92381,4631.161905,1221.885714,145.847619,3236.961905,172.9333333,709.8380952,105,17.29013444,8.027854241,0.885676636,0.913043478,0.648148148,1.452826454
+3352,32935.66981,966.7358491,557.3113208,1102.622642,28410.98113,871.1509434,1015.5,1592.867925,17232.29245,606.7924528,1850.839623,1783.5,22481.18868,1382.386792,5329.09434,3437.330189,7629.773585,1507.95283,366.8962264,2728.490566,16085.21698,469.0943396,1600.95283,1049.226415,19795.26415,1258.688679,745.2830189,1717.801887,15261.25472,1894.933962,611.6132075,2802.216981,13410.96226,828.2641509,304.1037736,1404.584906,9998.566038,1427.886792,453.9339623,1391.075472,7326.745283,1077.915094,177.0471698,5369.056604,6969.066038,1439.443396,652.6320755,3293.915094,550.0943396,713.3584906,106,13.61257555,10.83534956,0.605321795,0.883333333,0.582417582,0.664943491
+3353,29177.36129,882.8774194,555.8,1066.445161,25549.75484,689.3483871,673.716129,1488.193548,15034.67742,539.3548387,1649.851613,1761.974194,19584.71613,1263.2,2104.025806,3026.806452,6776.2,1724.696774,310.3935484,2398.529032,14564.38065,433.1870968,699.6580645,1064.090323,17942.90968,544.916129,119.3419355,1414.632258,13755.84516,1924.870968,634.4580645,2815.090323,11972.95484,869.483871,281.6967742,1634.787097,9007.922581,1293.580645,430.2516129,1345.258065,6827.625806,800.6,170.6322581,8353.43871,6134.858065,1322.470968,316.1935484,3299.032258,572.5483871,713.3032258,155,17.2841174,11.51754819,0.745624807,0.950920245,0.691964286,-1.029137329
+3354,31612.73148,857.1018519,605.8888889,1082.611111,28113.51852,679.8981481,651,1579.62037,15380.68519,521.6574074,1193.203704,1792.833333,20391.00926,1256.777778,3310.759259,3483.638889,7268.981481,1330.814815,300.3425926,2853.824074,15976.16667,472.6574074,219.6574074,1072.666667,19160.67593,456,127.8148148,1897.611111,14279,1946.416667,577.3148148,2780.685185,12574,1087.935185,266.287037,1949.712963,9342.203704,1067.907407,391.6944444,1317.601852,7166.027778,649.5925926,155.4259259,3546.648148,6407.074074,1332.925926,971.5,3261.787037,636.5092593,712.9444444,108,13.22676793,10.55330403,0.602823274,0.947368421,0.771428571,-0.244905049
+3355,28020.63478,840.8869565,792.9565217,1115.982609,24638.6087,671.3043478,745.7913043,1645.017391,13337.35652,523.4869565,540.3826087,1783.156522,18513.22609,1269.678261,2630.886957,1818.808696,6620.382609,1315.965217,302.9565217,2563.06087,14221.3913,1360.434783,321.0086957,555.1217391,17210.31304,455.773913,117.626087,968.226087,12875.72174,1723.504348,694.4695652,2783.234783,11293.14783,1395.269565,268.6173913,1485.347826,8461.947826,1008.278261,394.1217391,1339.513043,6552.26087,671.7652174,154.5130435,2721.365217,5868.843478,1331.217391,437.9043478,3312.086957,647.0869565,712.8695652,115,14.78839593,9.996811395,0.73691057,0.942622951,0.696969697,0.304724541
+3356,34606.91549,876,656.5633803,1125.492958,31958.69014,688.5915493,776.6056338,1666.887324,18630.26761,528.2253521,604.8732394,1744.549296,24086.91549,1295.887324,4998.661972,2693.43662,8668.169014,1294.957746,311.1830986,2407.859155,18415.95775,503.1549296,190.056338,632.028169,23095.22535,828.9577465,126.7042254,5275.070423,16738.77465,1432.971831,614.1549296,2784.28169,14842.73239,656.6478873,284.6619718,1669.126761,11476.61972,997.1267606,423,1309.056338,8255.788732,667.0422535,167.084507,3390.323944,7569.056338,1364.56338,159.9577465,3254.859155,787.1408451,710.7323944,71,10.52529642,8.968332615,0.523421155,0.898734177,0.645454545,-0.523671904
+3357,29968.45977,831.183908,584.7126437,1098.218391,26672.42529,723.1494253,929.816092,1650.781609,14568.67816,502.9310345,2913.551724,1879.195402,20158.10345,1204.678161,6835.126437,2905.482759,7449.83908,1264.977011,312.7241379,2809.505747,14845.42529,408.6896552,748.8965517,3093.183908,17888.68966,696.908046,1359.149425,1382.62069,14072.89655,2723.195402,734.5057471,2799.827586,11901.16092,708.5517241,266.6551724,1221.896552,8573.402299,1240.873563,399.6321839,1339.701149,5467.425287,764.4482759,164.4597701,7239.678161,5227.827586,2749.482759,805.7011494,3185.137931,958.0229885,711.9425287,87,12.23699768,9.261792045,0.653567763,0.966666667,0.669230769,-0.285146504
+3358,31296.79439,895.8224299,506.2429907,1082.336449,29241.3271,709.6168224,728.5700935,1541.345794,16332.08411,555.1775701,743.1869159,1765.485981,20682.47664,1299.28972,5622.775701,3634.261682,7412.261682,1410.542056,345.4579439,2416.429907,16666.93458,514.3738318,524.8971963,707.728972,19056.68224,671.9345794,128.8504673,2689.897196,14830.04673,1717.542056,548.1028037,2816.700935,12989.88785,1069.224299,303.8785047,1542,9253.317757,1236.616822,453.5233645,1309.682243,7189.364486,731.5514019,180.2056075,2686.383178,6584.897196,1405.579439,975,3256.485981,353.3831776,712.3457944,107,15.36728902,8.971133901,0.811911048,0.955357143,0.636904762,-0.981065954
+3359,37635.21429,991.2936508,533.9444444,1113.166667,34944.30159,844.6746032,959.2936508,1671.579365,19524.62698,610.2380952,1093.079365,1820.626984,24392.84921,1428.396825,4199.5,3619.388889,8531.055556,1459.357143,361.3095238,2358.452381,18452.0873,457.2380952,1203.642857,874.4365079,21984.03175,527.4603175,328.7063492,2630.84127,16985.78571,2018.515873,644.2301587,2829.515873,15147.64286,930.9365079,332.984127,1513.269841,11067.43651,1132.611111,482.8253968,1357.920635,8527.468254,935.7142857,185.6587302,3821.15873,7640.174603,1515.388889,819.0714286,3330.944444,382.5396825,714.2460317,126,20.60440132,9.178383444,0.895303126,0.828947368,0.466666667,-0.895227162
+3360,34405.98684,1007.592105,569.9868421,1086.013158,29448.15789,739.2631579,604.3684211,1515.539474,17311.27632,589.7368421,591.0657895,1752.276316,22531.30263,1356,3689.263158,4137.907895,7896.105263,1389.723684,336.7894737,2384.302632,16950.64474,503.6052632,300.3684211,521.5657895,20709.84211,439.4473684,133.7105263,3957.407895,15530.80263,1592.157895,744.2763158,2793.973684,13777.78947,866.3947368,290.6973684,1920.631579,10354.35526,956.3947368,447.1973684,1316.842105,7899.973684,684.7631579,168.8552632,3271.763158,7188.828947,1391.118421,1058.618421,3374.802632,516.3947368,712.1578947,76,11.73392884,8.587126218,0.681497752,0.926829268,0.690909091,-1.171787079
+3361,29204.90769,1017.215385,662.7615385,1132.361538,26766.00769,669.5923077,738.5538462,1601.453846,15000.57692,512.1230769,441.4230769,1735.838462,20179.33077,1214.953846,3177.030769,2348.661538,7244.6,1276.407692,297.3692308,2362.007692,14968.1,420.8692308,560.1615385,513.4384615,18326.84615,438.9307692,130.5153846,2569.876923,13910.01538,1430.269231,561.5307692,2803.007692,12023.66154,666.6615385,272.5846154,1593.961538,9152.9,783.8615385,411.8,1324.169231,6583.061538,726.3153846,158.2076923,2589.130769,6009.169231,1292.3,159.9923077,3216.453846,811.1461538,713.1538462,130,14.06419903,12.02053314,0.519138377,0.955882353,0.663265306,-0.963819017
+3362,29574.15584,796.9090909,496.1298701,1086.272727,26695.06494,642.2207792,860.1558442,1643.493506,14354.77922,492.2077922,1933.831169,1936.38961,20168.18182,1297.896104,5386.402597,3651.12987,7373.974026,1275,313.7662338,2615.233766,15184.81818,2123.74026,201.3896104,1917.506494,18442.05195,478.0519481,333.0909091,1819.038961,14529.06494,2625.61039,569.3506494,2815.012987,12348.57143,1025.207792,259.3246753,1373.025974,8960.935065,1535.857143,401.7402597,1308.051948,5917.246753,693.6883117,159.3506494,5758.155844,5557.844156,1273.519481,472.8181818,3204.233766,939.5584416,711.5194805,77,11.96207616,8.810632,0.676386304,0.916666667,0.583333333,0.880829812
+3363,21473.25806,766.9806452,506.7677419,1065.496774,17312.29677,501.6709677,392.8903226,1342.419355,7849.554839,387.5677419,907.6258065,1691.174194,11727.57419,960.4387097,3935.032258,1282.451613,4487.322581,1006.748387,257.716129,2436.612903,8459.096774,306.3032258,674.2064516,429.6451613,10532.84516,317.8967742,101.6967742,1634.883871,7757.451613,1451.193548,379.116129,2776.025806,6326.232258,579.7225806,198.5354839,779.3741935,4007.967742,655.2,327.4129032,1283.954839,2027.993548,647.1677419,132.4645161,1493.464516,2150.903226,917.0129032,287.3096774,2952.129032,1069.103226,714.2709677,155,15.13470363,13.13731438,0.49651896,0.96875,0.738095238,0.398553303
+3364,20916.94167,785.5583333,516.2416667,1066.091667,19740.55,633.1833333,438.5333333,1552.166667,9731.716667,503.2416667,670.4333333,1788.133333,12229.99167,1241.741667,8388.808333,4580.141667,4784.575,1233.666667,297.8416667,2342.458333,10141.24167,393.9083333,233.1166667,505.7,11863.13333,480.8083333,122.8416667,6664.441667,8867.566667,1474.45,525.6166667,2856.175,7789.291667,754.8833333,270.9083333,2206.191667,4888.633333,854.5916667,402.9916667,1308.408333,3765.158333,634.9416667,159.7666667,5387.5,3306.975,1232.791667,1369.916667,3261.691667,247.0166667,715.5916667,120,14.97327207,12.60405628,0.539835808,0.810810811,0.571428571,-0.523583938
+3365,34912.70492,822.9016393,468.557377,1077.163934,30278.4918,671.0655738,931.852459,1540.278689,18332.93443,523.0163934,1784.442623,1743.245902,24134,1277.393443,4616.131148,4652.639344,8199.442623,1405.770492,355.2622951,2366.934426,18326.90164,539.0655738,166.0983607,1200.704918,22517.47541,1569.262295,119.295082,2774.704918,17370.03279,1421.032787,680.4590164,2793.57377,15328.22951,659.0819672,261.0819672,1539.032787,11733.03279,1413.721311,397.4918033,1293.147541,8431.590164,642.0819672,154.5409836,3951.885246,7688.295082,1307.639344,228.5737705,3193.836066,696.557377,713.0655738,61,12.41774572,6.374083328,0.858206623,0.910447761,0.635416667,-0.361462957
+3366,34036.17134,811.9875389,580.3925234,1080.809969,11827.85981,420.0280374,285.1806854,1208.323988,4652.031153,339.9657321,604.482866,1606.043614,7418.364486,822.5109034,2555.934579,1166.242991,2764.143302,871.7352025,213.3395639,2303.105919,5007.800623,250.682243,103.9626168,615.6168224,5776.208723,346.317757,92.83489097,1287.109034,4251.735202,1349.174455,372.2741433,2771.417445,3284.454829,428.9470405,177.0996885,653.2928349,1710.909657,601.6853583,296.1464174,1253.205607,905.6666667,471.7912773,122.4766355,832.0809969,946.9657321,794.4797508,99.10280374,2824.155763,1107.311526,718.5794393,321,23.02073222,17.80876927,0.633677907,0.96978852,0.694805195,0.728901947
+3367,33215.44792,1103.0625,573.625,1077.572917,32042.57292,794.6354167,590.9166667,1573.833333,18225.92708,642.3229167,536.6666667,1716.552083,22138.90625,1411.083333,4159.104167,3273.208333,8161.697917,1466.3125,347.6145833,2388.75,17244.66667,424.8854167,466.9270833,476.6770833,21196.76042,519.9479167,136.6041667,4443.822917,16417.01042,1641.270833,573.7708333,2830.90625,14436.07292,671.5416667,309.7604167,1686.6875,9890.135417,916.40625,455.0208333,1321.447917,7445.604167,735.5520833,180,6429.75,6764.677083,1404.541667,173.3541667,3290.46875,312.5208333,714.3333333,96,12.51329854,10.031582,0.597761928,0.932038835,0.623376623,-1.503068805
+3368,26119.90196,1005.166667,496.8921569,1080.764706,23031.88235,723.8823529,678.2647059,1561.215686,12814.13725,625.8039216,1343.27451,1818.205882,17839.09804,1332.794118,4051.196078,3900.078431,6250.823529,1310.176471,382.6862745,2754.186275,12503.7549,423.2254902,938.4019608,800.8333333,15190.90196,455.9215686,127.3039216,1319.039216,11700.48039,2194.22549,496.4411765,2807.205882,9938.284314,630.9509804,264.1764706,1604.509804,7437.666667,1114.117647,416.4117647,1319.470588,5107.990196,1242.039216,159.2156863,2453.254902,4944.039216,1313.156863,903.6568627,3431.22549,862.0588235,714.3529412,102,13.56867386,9.935058728,0.681083686,0.927272727,0.653846154,0.942583471
+3369,50369.62319,954.8550725,669.115942,1206.173913,21691.50725,531.5507246,316.826087,1452.028986,10123.26087,515.173913,403.057971,1708.246377,13481.57971,1016.898551,5508.565217,2586.304348,4936.73913,1074.376812,266.0724638,2271.724638,10483.95652,294.826087,127.3188406,384.8405797,12260.24638,341.942029,110.0289855,5789.753623,9120.652174,1270.130435,404.5652174,2807.608696,7775.057971,521.826087,241.6231884,2203.043478,3691.057971,648.2173913,355.0724638,1291.782609,2756.188406,551.4927536,144.5362319,2513.594203,2636.768116,1030.565217,141.1884058,3118.173913,165.0434783,715.7826087,69,10.55516228,9.26450999,0.479168155,0.831325301,0.522727273,0.634120311
+3370,23060.41463,1028.317073,660.1341463,1065.146341,20918.57317,739.304878,661.4512195,1440.670732,11858.43902,590.8170732,680.9268293,1760.402439,15401.15854,1317.634146,3355.341463,3491.768293,5524.317073,2068.47561,326.9634146,2365.97561,12083,433.9634146,979.1585366,613.9878049,14302.32927,726.8414634,131.1829268,2310.097561,10710.7561,1592.487805,676.8658537,2808.463415,9546.621951,816.5121951,276.0609756,1788.939024,7385.5,1007.280488,432.6585366,1338.402439,5661.304878,872.3658537,167.4878049,3900.585366,5267.926829,1385.402439,1015.036585,3322.95122,493.3414634,715.0731707,82,11.50288582,9.369161051,0.580156164,0.931818182,0.745454545,-0.23679401
+3371,34913.28994,904.2721893,525.964497,1106.112426,31343.60355,727.3313609,758.1242604,1574.508876,17441.48521,570.1360947,565.4497041,1780.112426,22413.56805,1327.692308,2514.242604,4100.91716,8023.319527,1420.988166,346.6568047,2361.017751,17259.2071,455.5976331,1266.662722,504.9112426,20650.04142,528.2544379,133.4615385,1887.201183,15126.52071,1595.337278,670.6923077,2876.491124,13705.66272,956.3491124,306.1775148,1863.278107,10253.85799,1146.266272,461.4615385,1327.426036,7823.207101,1060.491124,175.8461538,2533.532544,6957.840237,1455.568047,2839.017751,3280.183432,504.5384615,720.8757396,169,22.30967433,10.49409623,0.882462257,0.853535354,0.563333333,-0.521141212
+3372,40917.30612,942.122449,546.122449,1103.489796,35141.55102,715.0816327,680.5510204,1564,19805.63265,544.755102,849.3673469,1742.836735,26770.65306,1353.163265,3017.673469,3650.734694,9418.714286,1349.857143,318.3061224,2354.469388,20843,466.4285714,125.8571429,974.1020408,25573.93878,569.5714286,124.2653061,3384.836735,19007.02041,1723.306122,676.6326531,2809.469388,16978.63265,774.6938776,268.3673469,1993.673469,12606.04082,998.4489796,412.0204082,1284.244898,9565.55102,642.1632653,158.8571429,2634.979592,8600.346939,1375.306122,616.6326531,3315.122449,627.1836735,713.8571429,49,8.551910441,7.436709255,0.493763467,0.960784314,0.777777778,0.392170541
+3373,24129.45556,851.6166667,528.5555556,1059.383333,22550.92222,672.1277778,705.1277778,1498.377778,12209.59444,523.0833333,1197.316667,1761.905556,16299.4,1346.827778,4385.638889,4052.927778,6042.538889,1369.45,336.4277778,2925.077778,12784.08333,485.3555556,209.6388889,1083.966667,16001.74444,537.6,119.8333333,2119.422222,11546.58889,1926.866667,618.2333333,2775.911111,10109.58333,763.0722222,263.4555556,1712.544444,7804.988889,1442.266667,385.8833333,1300.772222,5844.011111,663.5722222,152.4111111,5420.9,5396.277778,1300.627778,446,3231.683333,675.8,717.05,180,19.58957205,12.22073831,0.781552908,0.904522613,0.592105263,-1.075189819
+3374,27873.42222,911.0555556,925.3444444,1194.477778,24087.67778,716.3333333,812.6555556,1741.877778,14753.1,702.8,482.1555556,1792.122222,18961.62222,1357.888889,2065.033333,1469.222222,6783.377778,1485.611111,349.8888889,2347.611111,14715.92222,451.8555556,438.8555556,496.7,18127.01111,469.7888889,122.5555556,1156.822222,13513.57778,1545.588889,553.5777778,2792.966667,12122.2,943.5333333,286.4777778,1550.877778,9271.355556,1038.088889,435.2888889,1348.411111,6803.911111,733.3777778,165.5555556,1684.088889,6355.766667,1424.188889,300.7,3244.3,762.8222222,714.7777778,90,12.95351163,9.360654097,0.691230362,0.9,0.576923077,0.643351307
+3375,35053.31507,915.3493151,585.1849315,1107.458904,30808.89041,741.6917808,783.609589,1665.821918,16654.36986,562.5821918,1933.80137,1789.684932,23791.80137,1313.246575,7575.369863,4822.69863,8430.80137,1313.260274,341.6986301,2520.623288,16833.13014,432.6712329,929.7328767,1318.041096,21111.82877,957.8287671,165.1027397,2997.582192,15967.34932,2155.164384,520.260274,2784.328767,13825.26712,922.0684932,281.1506849,1641.671233,10510.21918,1400.527397,421.8219178,1315.068493,7048.746575,1131.054795,176.0205479,5004.630137,6501.390411,1338.191781,448.739726,3246.123288,898.6164384,715.9315068,146,15.51898583,12.6151918,0.582420536,0.906832298,0.695238095,1.159538134
+3376,37016.53333,883.8777778,498.7111111,1111.744444,33610.61111,732.5777778,859.9111111,1687.811111,18120.87778,526.5666667,3006.5,1956.044444,24421.9,1308.044444,5302.277778,3986.955556,8975.277778,1329.555556,332.6777778,2941.688889,17937.67778,434.4666667,165.5888889,3191.588889,22228.37778,511.5,356.8111111,1435.977778,17242.92222,2531.677778,474.9222222,2804.077778,14584.26667,1278.688889,284.1222222,1261.711111,10588.06667,1667.333333,425.5333333,1300.755556,6643.133333,637.1888889,165.5222222,2949.622222,6377.555556,1493.644444,1076.077778,3261.444444,948.4444444,716.1111111,90,12.22747362,9.744387432,0.604077395,0.918367347,0.629370629,-0.369906067
+3377,31027,817.4384615,507.5769231,1061.730769,21193.2,628.1615385,685.3230769,1570.784615,10738.64615,456.1307692,1774.884615,1848.684615,15157.73077,1115.907692,5542.315385,3111.938462,5699.230769,1180.553846,303.3,2503.192308,11195.09231,370.1615385,1249.715385,1124.161538,14208.31538,1000.976923,163.8230769,1225,10680.35385,2058.407692,571.7769231,2824.976923,8972.107692,940.1692308,241.4384615,1061.876923,6501.384615,1218.246154,389.3230769,1330.130769,3828.161538,872.5076923,154.9076923,4296.369231,3685.384615,1166.253846,2378.907692,3152.246154,1006.376923,715.9384615,130,14.30602398,12.17895837,0.524652006,0.942028986,0.541666667,-1.05246205
+3378,39891.60563,974.1267606,506,1098.859155,33461.25352,675.8732394,605.5774648,1581.788732,18567.70423,538.915493,633.5492958,1723.225352,23483.23944,1273.492958,6696.788732,3802.830986,8555.126761,1350.450704,328.9295775,2320.760563,18395.53521,452.1549296,190.5915493,499.5211268,21814.94366,421.2253521,127.1126761,5073.380282,17599.56338,1592.211268,490.7323944,2847.732394,15044.47887,636.0704225,306.2676056,1683.352113,9106.309859,897.1549296,429.4929577,1305.619718,6619.323944,651.2816901,168.1408451,3087.577465,6152.014085,1338.169014,527.9859155,3249.887324,238.2676056,715.9295775,71,12.1235654,7.510907165,0.784973326,0.959459459,0.717171717,-0.40905742
+3379,41668.14151,1165.924528,718.3113208,1210.084906,39544.65094,900.1981132,675.7169811,1907.5,21947.85849,671.6037736,655.254717,1768.037736,27731.42453,1641.641509,2977.566038,4456.084906,9688.896226,1624.688679,409.6792453,2383.839623,21760.34906,530.1320755,912.1415094,561.9056604,25783.41509,510.5283019,173.2924528,4913.169811,19738.95283,1821.198113,550.6886792,2842.632075,17410.28302,712.0377358,378.1886792,1624.556604,11570,1108.632075,531.5283019,1335.056604,8810.943396,889.6037736,212.7264151,4449.830189,7669.169811,1610.235849,211.7830189,3467.188679,292.5849057,716.6698113,106,14.06528658,9.832870146,0.715035844,0.981481481,0.630952381,-0.618372289
+3380,31629.4902,883.3202614,508.9281046,1084.568627,29251.43137,746.9084967,918.0653595,1572.830065,16472.33333,577.7124183,1467.457516,1834.823529,21018.04575,1313.51634,4426.052288,4899.444444,7604.418301,1463.79085,343.9150327,2377.183007,15735.51634,424.7647059,1486.261438,1431.797386,18672.40523,750.2222222,393.4313725,1956.96732,14405.59477,1992.333333,727.5882353,2823.830065,12969.10458,682.2026144,303.379085,1447.666667,9515.228758,1289.111111,454.9934641,1354.869281,7389.679739,1085.431373,179.3986928,3606.745098,6752.601307,1464.411765,697.4117647,3249.588235,396.9542484,717.5163399,153,14.70271054,13.37157715,0.415783982,0.974522293,0.728571429,0.117529907
+3381,17970.76,772.9733333,465.9733333,1088.96,16049.64,655.2333333,517.7733333,1452.24,8991.86,477.6066667,479.2266667,1779.993333,12055.49333,1173.9,1384.346667,1231.566667,4294.066667,1292.313333,297.9866667,2352.14,9136.666667,413.04,853.44,470.6666667,11190.87333,428.4533333,111.8133333,996.78,8418.546667,1471.313333,622.3666667,2810.446667,7455.02,1222.826667,252.0866667,2062.206667,5601.866667,781.0466667,387.36,1342.986667,4253.853333,863.04,152.9533333,2390.233333,3995.04,1297.073333,3339.886667,3168.08,587.1933333,717.68,150,16.37184629,11.80816968,0.692676398,0.955414013,0.666666667,-0.755003453
+3382,34380.72185,901.3377483,666.2715232,1100.264901,31023.03974,732.5827815,931.7483444,1590.854305,17529.70861,576.8741722,1161.377483,1820.827815,22873.54967,1324.072848,3510.94702,4335.165563,8402.907285,1481.397351,341.4635762,2478.006623,17912.09934,454.3046358,1683.86755,1115.695364,20843.18543,502.8211921,137.1125828,2014.377483,16013.07947,1963.225166,662,2828.635762,14184.50993,668.5960265,301.2847682,1676.211921,10870.71523,1284.059603,466.602649,1366.112583,8261.675497,1131.523179,180.8476821,4082.298013,7578.821192,1464.887417,219.7086093,3291.695364,476.3311258,719.7417219,151,15.37970178,13.19068368,0.514203243,0.926380368,0.555147059,-0.965935198
+3383,27554.45833,820.4916667,461.8,1079.65,24812.69167,695.275,514.325,1599.791667,13582.43333,491.4666667,1158.616667,1769.2,18578.675,1240.241667,3142.05,2240.333333,6894.008333,1257.275,327.0333333,2382.591667,13812.375,651.4333333,151.15,1131.125,16874.4,532.0583333,204.6333333,1811.841667,13309.35833,1889.4,506.7083333,2907.041667,11402.95,1250.25,268.4833333,1393.35,8173.008333,1226.983333,404.1666667,1295.208333,5450.075,624.8,159.1916667,3621.033333,5197.508333,1278.883333,1082.925,3173.925,933.4,719.325,120,15.3211261,10.86031438,0.705363574,0.882352941,0.535714286,-1.245007157
+3384,29125.29915,794.3760684,556.2051282,1054.136752,25542.2906,764.6324786,702.6495726,1631.632479,13701.81197,486.991453,2031.709402,1917.641026,19096.90598,1170.205128,7978.051282,4008.17094,7236.965812,1238.042735,303.9316239,2603.564103,14166.37607,399.2991453,417.8034188,2409.350427,17120.23932,440.5299145,415.3418803,3224,13890.84615,2850.025641,641.7948718,2785.888889,11570.90598,574.8034188,262.042735,1619.538462,8098.452991,1271.435897,389.4102564,1300.538462,5055.717949,646.957265,156.9316239,5457.094017,4964.606838,1212.74359,335.9487179,3276.512821,979.8803419,719.7264957,117,16.6532377,9.511807453,0.820832725,0.886363636,0.6,-0.686344627
+3385,27222.84706,785.3529412,526.6235294,1068.729412,24856.95294,641.3647059,671.1764706,1522.435294,14122.12941,505.9764706,728.1411765,1785.2,18519.94118,1209.894118,2346.564706,2624.611765,6625.917647,1703.141176,316.5882353,2417.705882,13886.35294,427.0235294,345.9882353,582.9529412,17076.58824,889.9058824,121.6352941,2114.870588,12720.68235,1611.623529,645.8,2839.529412,11346.82353,645.0941176,276.9058824,1661.129412,8604.411765,1080.317647,428.1411765,1312.2,6458.835294,704.1529412,161.0235294,5164.129412,5957.858824,1301.2,195.8823529,3258.270588,560,718.6941176,85,12.21976912,9.747590095,0.603067444,0.885416667,0.594405594,-0.851364042
+3386,37313.74576,1114.70339,548.6440678,1113.254237,32907.81356,796.2711864,585.7627119,1624.322034,19376.28814,617.0847458,499.3050847,1712.440678,25393.91525,1451.338983,3463.449153,2483.245763,8238.169492,1510.584746,402.8559322,2346.152542,18750.12712,455.4745763,187.9322034,550.1779661,23013.54237,518.720339,127.5508475,3381.813559,17553.42373,1508.389831,541.4067797,2794.033898,15662.69492,702.6610169,282.3220339,1611.347458,11341.00847,969.7033898,430.2118644,1306.40678,8424.788136,670.5847458,167.2881356,3805.194915,7572.033898,1393.305085,472.8898305,3302.194915,723.9152542,719.8983051,118,15.5924217,9.914177811,0.77182658,0.929133858,0.605128205,0.567122928
+3387,27049.33871,881.233871,731.8387097,1137.741935,23699.25806,712.0967742,697.5967742,1678.83871,13959.37903,562.7258065,523.3145161,1803.943548,18415.29032,1331.217742,3357.072581,3233.233871,6500.935484,1340.596774,337.7822581,2397.903226,14037.12903,430.483871,413.8467742,542.0967742,17486.77419,593.2096774,121.8548387,2404.217742,12917.71774,1510.895161,593.9112903,2793.379032,11462.8871,868.6129032,281.7096774,2002.927419,8787.66129,1047.370968,419.1370968,1352.185484,6529.717742,723.7903226,170.4758065,3428.927419,5848.064516,1383,599.016129,3206.274194,753.5887097,718.8064516,124,15.49478025,10.48929017,0.736023148,0.946564885,0.59047619,0.709043998
+3388,31075.63095,952.9761905,841.9880952,1171.345238,27769.40476,748.9642857,861.3452381,1779.47619,15577.60714,560.3214286,494.5833333,1774.5,21392.53571,1366.904762,1546.559524,1530.440476,7453.166667,1441.678571,337.6547619,2395.642857,15534.34524,480.8690476,248.8928571,509.0833333,19305.78571,490.0595238,129.3809524,1691.583333,14212.7381,1484.702381,553.047619,2837.964286,12387.30952,718.5238095,287.7261905,1600.511905,9362.988095,850.0119048,434.0238095,1340.166667,6804.047619,651.6547619,166.2738095,1561.988095,6181.607143,1418.809524,153.8452381,3250.547619,791.9285714,718.8571429,84,10.95311339,10.00962399,0.40602701,0.913043478,0.636363636,1.04369136
+3389,35800.53333,1006.822222,637.6444444,1130.688889,30111.16667,682.2222222,674.3777778,1637.966667,17487.84444,512.2333333,409.4777778,1716.288889,23548.95556,1269.833333,1575.188889,1356.011111,8311.288889,1332.322222,327.6,2350.077778,17328.87778,1156.577778,145.8777778,437.3,20982.14444,453.9666667,126.4555556,1248.144444,16407.36667,1451.833333,481.4333333,2798.3,14026,792.7444444,283.4111111,1532.655556,10692.57778,811.1222222,426.4555556,1305.044444,7496.177778,613.5777778,165.6777778,1529.544444,7000.466667,1366.855556,866.9444444,3238.333333,819.1555556,719.0333333,90,13.47447226,8.696761419,0.76382364,0.947368421,0.625,-0.813038805
+3390,50865.06,1210.08,576.92,1165.78,53539.72,822.34,809.58,1897.08,31505.14,578.68,679.78,1778.24,44480.18,1469.68,3943.62,3166.56,15021.26,1450.88,362.18,2340.7,31049.46,466.88,143.34,678.36,37870.64,490.06,150.62,2747.92,30135.02,1925.32,523.24,2827.78,26867.4,691,339.64,1551.2,19707.74,1085.3,473.28,1310.98,12978.72,673.92,183.12,1856.72,11582.58,1502.1,290.7,3375.92,885.3,716.48,50,10.43130788,6.473130296,0.784168232,0.877192982,0.625,-0.94601634
+3391,38048.17736,875.1471698,570.2226415,1113.913208,30365.70566,679.0754717,718.9811321,1705.996226,15300.05283,539.4188679,1541.54717,1889.064151,20078.61887,1235.2,8985.539623,5294.445283,7523.867925,1363.815094,410.690566,2408.45283,15842.95472,404.6226415,1930.211321,1240.879245,18869.79623,607.9584906,140.7773585,4279.098113,14197.03396,2002.384906,463.6792453,2860.320755,12170.13208,598.5056604,345.8981132,1486.879245,6532.015094,1416.558491,475.0226415,1317.007547,5083.445283,1383.988679,182.290566,3271.54717,4470.769811,1714.279245,224.2415094,3231.732075,210.3962264,721.8075472,265,19.923572,17.61666096,0.467085841,0.949820789,0.633971292,-1.072966484
+3392,38293.36478,1173.955975,553.0440252,1087.188679,35272.10063,823.4654088,678.9622642,1641.786164,19675.26415,685.1383648,665.6792453,1740.716981,24058.06918,1434.09434,3333.540881,2811.371069,8332.628931,1448.006289,347.5471698,2349.874214,18180.11321,438.0062893,527.5974843,479.3899371,21833.19497,443.0880503,131.6226415,2836.314465,16377.1761,1705.54717,473.6037736,2814.018868,14619.7044,669.2515723,307.1132075,1414.855346,9805.949686,931.6163522,451.6792453,1310.169811,7440.119497,738.9119497,176.1194969,2790.761006,6749.188679,1377.132075,162.2201258,3478.597484,300.9245283,721.8553459,159,17.94801194,11.85908528,0.750609167,0.908571429,0.584558824,-0.718504372
+3393,20218.53846,1031.783654,554.9182692,1155.639423,17968.57692,773.9230769,555.2307692,1629.581731,10170.14423,588.1346154,535.7019231,1748.245192,13004.17308,1459.177885,1389.495192,1372.384615,5060.639423,2543.956731,394.4326923,2385.956731,8550.360577,442.5961538,818.6923077,490.0721154,10062.87981,443.5913462,139.0288462,1187.548077,7770.442308,1539.394231,578.2451923,2875.528846,6917.908654,698.4903846,302.1826923,1516.759615,5313.625,901.6730769,490.0721154,1363.745192,4269.576923,873.9038462,198.375,2652.644231,3999,1612.649038,474.7596154,3591.918269,441.8942308,721.0576923,208,20.58374705,13.01183607,0.774853154,0.945454545,0.693333333,1.153051003
+3394,28539.09859,1035.56338,568.1408451,1080.197183,26273.35211,731.9295775,740.4647887,1542.267606,14609.09859,568.084507,1452.985915,1787.830986,18714.71831,1322.464789,7449.408451,4256.492958,7046.971831,1380.549296,329.8309859,2450.56338,14589.90141,420.3943662,291.3098592,1413.690141,17340.26761,1519.126761,136.8732394,2520.56338,12764.3662,1856.394366,656.7183099,2794.464789,11436.4507,619.8309859,291.2957746,1559.521127,8697.535211,1515.549296,439.4225352,1315.788732,6780.394366,686.1267606,169.7746479,3674.690141,6160.830986,1442.915493,248.9014085,3367.408451,464.915493,719.1971831,71,12.16692345,7.622522638,0.779425047,0.986111111,0.645454545,-0.851055883
+3395,40408.28485,870.9818182,514.1272727,1102.672727,32616.04848,724.3090909,734.2787879,1648.448485,18393.80606,510.630303,1421.072727,1781.672727,25280.57576,1274.981818,5258.212121,3381.260606,9330.593939,1316.321212,333.6545455,2652.642424,18332.09697,543.3878788,180.9333333,839,22555.73939,530.0545455,145.6909091,2500.49697,17641.43636,1740.836364,502.4666667,2809.921212,15113.30303,691.769697,284.7333333,1470.278788,10987.04848,1322.412121,423.8060606,1294.678788,7278.357576,658.2545455,165.8242424,3888.387879,6876.430303,1316.509091,476.2848485,3241.636364,918.230303,722.5151515,165,19.2561421,11.76165658,0.791784721,0.873015873,0.572916667,-0.594776447
+3396,54210.17778,976,610.9777778,1182.455556,20384.24444,488.8666667,308.9444444,1283.133333,9739.711111,441.8777778,379.6555556,1680.4,13526.92222,973.4777778,5641.966667,2972.644444,4848.333333,1029.066667,247.7444444,2254.744444,10453.65556,285.9888889,105.9888889,380.6,12389.33333,304.0777778,106.2,5495.355556,9213.588889,1219.233333,316.7333333,2801.655556,7839.933333,479.1777778,211.8333333,1307.266667,3776.722222,613.7555556,337.9222222,1255.277778,2863.033333,521.1777778,138.4333333,1329.433333,2731.566667,980.4666667,115.7333333,3020.044444,173.6666667,719.6222222,90,13.47624878,8.820212634,0.7560615,0.927835052,0.642857143,-1.140631767
+3397,39534.60215,1141.473118,535.8064516,1090.150538,37420.58065,812.9569892,625.688172,1642.827957,20684.24731,651.5053763,545.4086022,1739.032258,25401.8172,1467.387097,2841.365591,2372.612903,9247.580645,1473.322581,360.2580645,2321.903226,20100.25806,462.4193548,459.0860215,466.8709677,24081.76344,480.3763441,142.655914,2587.580645,18361.94624,1710.623656,473.516129,2813.096774,16040.76344,733.688172,333.4623656,1286.376344,10589.44086,1163.860215,476.655914,1351.344086,7997.55914,1218.645161,188.9139785,3619.860215,6786.053763,1431.709677,185.483871,3403.623656,281.1505376,719.9462366,93,12.58947342,9.72191753,0.635348053,0.911764706,0.65034965,-1.411484602
+3398,29376.54082,842.7244898,539.744898,1059.418367,27285.07143,678.622449,644.3877551,1559.112245,15542.90816,548.7755102,805.9489796,1767.040816,19273.08163,1264.816327,5497.55102,3591.081633,7170.05102,1363.428571,330.6632653,2473.193878,15063.54082,432.3469388,1094.897959,690.5408163,18278.92857,428.0816327,127.8469388,2908.571429,13893.62245,1693.173469,618.3163265,2810.612245,12293.16327,1119.05102,294.1326531,1535.244898,8770.244898,998.5816327,438.7959184,1318.714286,6799.030612,862.755102,174.3367347,3511.030612,6258.183673,1386.234694,1163.153061,3234.928571,357.9081633,720.3163265,98,13.01523014,9.712735386,0.665655458,0.951456311,0.685314685,-0.982979824
+3399,33014.34764,927.9184549,534.4592275,1091.446352,28774.7382,639.7896996,606.9313305,1605.218884,14259.48069,467.4034335,1859.120172,1765.927039,20688.03433,1141.699571,5425.549356,2244.077253,7730.83691,1199.154506,301.4077253,2397.600858,15112.22747,377.9356223,322.2403433,1580.88412,18840.66953,434.5236052,475.9141631,1944.141631,14607.84549,2145.918455,383.7124464,2855.201717,11805.6867,830.4077253,258.8497854,976.8240343,8119.008584,1216.819742,386.2875536,1288.386266,4338.866953,637.055794,150.7811159,2144.107296,4546.450644,1141.416309,725.2017167,3178.244635,1042.618026,723.888412,233,19.55933354,15.55378511,0.60633361,0.978991597,0.652661064,-1.516037663
+3400,37735.71429,1071.688312,565.4675325,1099.051948,22519.75325,560.8441558,285.7532468,1407.272727,12224.67532,474.5454545,469.4415584,1701.857143,15626.81818,1119.558442,6331.207792,2023.883117,5757.688312,1165.298701,285.8311688,2322.311688,12232.84416,337.2207792,157.4415584,396.5584416,14545.92208,362.8441558,111.9480519,3186.571429,11575,1358.402597,376.6233766,2816.636364,9843.61039,532.6103896,244.1428571,1087.428571,5705.051948,707.1168831,375.2077922,1285.649351,4186.480519,574.7272727,152.2597403,1928.376623,3946.467532,1125.298701,185.2077922,3197.545455,228.8571429,720.5194805,77,12.77040002,7.866573732,0.787745704,0.987179487,0.583333333,0.884822862
+3401,26183.27749,848.5287958,478.5863874,1082.094241,24036.1466,666.539267,654.6701571,1534.759162,13501.71728,510.8324607,897.4973822,1767.235602,17814.60733,1326.256545,3329.225131,2693.397906,6374.984293,1439.680628,381.4659686,2407.329843,13589.34031,6347.340314,213.1884817,599.6596859,16832.47644,654.4031414,118.1937173,2218.403141,12561.09948,1510.853403,662.6963351,2783.319372,11008.94241,937.4188482,261.8900524,1640.136126,8285.167539,1186.95288,392.591623,1301.507853,6246.858639,655.1780105,151.4659686,4462.774869,5632.863874,1278.774869,167.1413613,3280.471204,696.5602094,724.0209424,191,20.8175306,12.25770221,0.808266859,0.880184332,0.636666667,-1.265011245
+3402,36819.62362,825.9298893,487.3800738,1067.505535,29178.01845,660.4870849,614.0369004,1594.125461,15474.31365,482.9778598,1977.682657,1747.195572,21360.22878,1158.800738,5496.911439,2709.284133,7862.276753,1222.896679,305.4169742,2690.391144,15628.57565,382.4501845,169.6457565,1610.243542,19519.03321,555.896679,236.4907749,1330.97786,15458.62362,2173.546125,458.8782288,2825.900369,12938.8893,798.8228782,259.2250923,1020.476015,9095.431734,1344.800738,387.2324723,1293.918819,5392.612546,595.1291513,154.0332103,2318.309963,5311.254613,1172,1135.166052,3198.070111,995.6236162,726.5608856,271,20.95300983,17.07860184,0.579333476,0.937716263,0.615909091,0.818049654
+3403,36550.125,852.8881579,477.9276316,1095.506579,26151.9375,622.7565789,579.0855263,1583.536184,13437.01316,462.2138158,1787.289474,1793.805921,19158.10526,1127.259868,5470.539474,2760.782895,7139.401316,1193.305921,303.2861842,2522.006579,13867.32237,369.0460526,650.3717105,1618.006579,17394.88816,808.3026316,134.8026316,1650.901316,13402.13487,2082.963816,414.0427632,2802.740132,11011.48684,613.3815789,247.6776316,982.0427632,7805.815789,1425.427632,382.9572368,1306.427632,4553.713816,721.8815789,147.7598684,2281.802632,4420.243421,1135.625,424.5625,3201.144737,1015.480263,727.3717105,304,20.09140878,19.53572822,0.233560051,0.962025316,0.690909091,-0.397282998
+3404,42881.50806,981.7741935,541.7903226,1109.887097,35930.43548,684.9435484,481.2419355,1672.919355,20031.68548,543.4596774,543.9435484,1785.741935,24912.83065,1253.532258,6837.701613,3391.620968,9211.935484,1353.830645,336.1370968,2391.008065,19577.54032,402.6370968,290.1854839,470.9516129,24113.83065,419.9274194,136.0645161,3769.387097,18474.92742,1529.975806,481.483871,2833.91129,15806.68548,612.9032258,298.9112903,1476.959677,9815.209677,859.0967742,441.0806452,1311.564516,7407.008065,663.2741935,168.8145161,2813.153226,6572.475806,1321.572581,173.6693548,3281.056452,256.5322581,722.7580645,124,13.52768435,12.34648448,0.408668758,0.905109489,0.59047619,-1.451312839
+3405,25839.46429,762.6309524,454.297619,1069.321429,22978.53571,622.8333333,664.2857143,1456.642857,12776.13095,497.8928571,839.8333333,1750.642857,17125.08333,1172.857143,2377.904762,2859.988095,6209.369048,1317.988095,295.3214286,2463.97619,13159.75,3131.095238,423.0119048,856.047619,15519.10714,408.297619,128.3928571,2347.190476,11569.28571,1465.345238,752.3452381,2811.488095,10499.38095,643.3690476,259.6666667,1603.428571,7903.404762,969.797619,419.8214286,1308.785714,6107.797619,681.2738095,156.1904762,4328.571429,5413.797619,1290.964286,804.2142857,3235.059524,519.3095238,720.6904762,84,12.35424121,8.82217513,0.700042758,0.965517241,0.717948718,1.232138029
+3406,16421.44118,1359.058824,598.0588235,1040.676471,19375.47059,827.2941176,577.5,1370.205882,7453.676471,658.9117647,593.8823529,1702.529412,12420.32353,1319.588235,2815.264706,3063.088235,3938.088235,1384.294118,372.0882353,2360.323529,8400.352941,407.8823529,172.8823529,593.6764706,10543.47059,428.8529412,111.2647059,2731.852941,6997.058824,1488.5,517.9411765,2764.441176,6126.294118,601.7941176,247.5,1494.058824,4524.029412,863.9705882,374.0294118,1290.088235,4060.735294,583.5882353,139.9411765,2676.470588,3222.235294,1109.117647,133.3529412,3393.5,716.0882353,720.8529412,34,8.241482595,5.254272204,0.770417518,0.971428571,0.85,0.028511012
+3407,39577.49254,932.0746269,912.8955224,1220.044776,33813.85075,778.0597015,941.8656716,1833.253731,20435.1194,562.1492537,700.6865672,1828.328358,26072.37313,1385.80597,1327.791045,1380.641791,9091.507463,1455.164179,332.9701493,2483.014925,19453.20896,467.9402985,397.119403,666.238806,23948.79104,634.9104478,130.2686567,1066.507463,17928.62687,1557.895522,517.7462687,2802.373134,15742.95522,769.5074627,292.0597015,1406.432836,11777.1791,986.4776119,440.8507463,1341.835821,8373.731343,710.6119403,163.9253731,1242.38806,7876.208955,1443.104478,169.9402985,3304.880597,781.9402985,721.8507463,67,10.93272932,8.289673759,0.651971168,0.905405405,0.676767677,-0.0028062
+3408,39336.18023,919.8430233,705.5116279,1152.47093,14484.48837,445.3837209,280.1976744,1204.377907,6714.674419,379.5581395,306.9825581,1652.784884,9254.424419,896.7906977,4128.302326,1749.296512,3356.709302,935.8953488,224.8895349,2238.546512,6995.261628,260.0872093,99.16860465,369.8953488,7829.005814,278.5523256,95.90697674,3447.598837,5768.581395,1155.94186,309.9127907,2796.395349,4823.976744,458.255814,200.627907,1177.267442,2135.087209,566.1744186,313.2325581,1254.093023,1600.825581,499.6104651,131.1802326,956.6627907,1618.511628,880.0523256,92.83139535,2940.005814,159,725.3430233,172,16.00305791,13.94910885,0.490124012,0.960893855,0.632352941,1.173413214
+3409,30348.23387,885.8951613,612.1129032,1084.104839,27779.16129,709.733871,605.4596774,1615.258065,15866.54839,555.4274194,574.4193548,1776.604839,20036.77419,1309.669355,5493.322581,4332.766129,7170.790323,1366.862903,326.8870968,2357.524194,15050.40323,1861.08871,962.4596774,464.983871,18345.41935,438.0887097,129.8870968,4643.604839,14378.45161,1595.653226,747.6935484,2817.725806,12655.24194,654.3951613,303.3387097,1600.403226,8874.25,904.7903226,443.266129,1312.145161,6737.282258,811.4677419,177.6290323,6884.104839,6145.685484,1383.83871,1647.669355,3314.201613,340.266129,725.4193548,124,14.07871425,11.3494765,0.591718872,0.946564885,0.635897436,-0.08564453
+3410,29707.36458,988.2395833,549.7083333,1073.458333,28119.79167,718.3854167,809.6875,1522.958333,15527.22917,577.59375,1167.28125,1743.604167,19753.90625,1312.90625,3356.864583,3039.729167,7104.802083,1360.864583,330.9166667,2410.697917,15553.02083,411.8229167,414.6875,854.9895833,18766.27083,426.3541667,126.6979167,2271.760417,14525.70833,1901.3125,611.59375,2843.666667,12866.1875,1054.3125,287.8333333,1675.604167,9224.145833,1076.03125,432.8125,1311.947917,7176.166667,692.96875,171.0833333,3347.1875,6502.729167,1363.614583,1353.458333,3334.9375,367.2708333,724.09375,96,13.09803831,9.606967425,0.679726004,0.914285714,0.623376623,-0.222679498
+3411,33913.65101,1066.04698,587.4295302,1141.744966,31202.30872,793.7248322,770.9865772,1701.416107,17493.12081,622.4765101,609.3624161,1777.852349,21784.10738,1410.731544,4969.590604,4253.248322,7681.38255,1418,346.2080537,2341.194631,16414.38255,636.4832215,514.6107383,533.6375839,19083.4094,501.033557,139.1610738,4657.684564,14859.88591,1692.778523,756.6107383,2836.201342,13083.19463,694.3087248,322.2416107,2152.389262,9325.557047,1064.255034,454.9530201,1314.865772,7057.85906,721.5167785,180.1879195,3748.42953,6206.053691,1420.872483,507.6711409,3398.604027,378.3489933,726.409396,149,21.73829278,9.571915911,0.897838408,0.876470588,0.486928105,-0.765353696
+3412,44343.625,909.7678571,531.875,1085.714286,39444.42857,720.6785714,961.625,1573.285714,22449.51786,575.1964286,1380.196429,1739.678571,29329.875,1443.125,3324.196429,3346.517857,10147.55357,1463.803571,322.3214286,2339.982143,23016.78571,487.25,160.1785714,1327.142857,28575.83929,524.8571429,122,1732.178571,21113.53571,1981.678571,588.4642857,2811.660714,18879.26786,652.5535714,294.6428571,1492.571429,14038.80357,1558.910714,428.7142857,1336.589286,10393.41071,652.6428571,166.7857143,1596.75,9437.625,1422.25,176.8035714,3344.5,623.3035714,721.4642857,56,10.68790184,6.717960945,0.777763112,0.965517241,0.7,-1.119672502
+3413,37594.85944,906.4578313,657.686747,1142.943775,33399.73494,744.3453815,886.4136546,1701.943775,19661.60241,559.7991968,1445.574297,1835.228916,25079.48193,1322.650602,3296.196787,4124.670683,8926.819277,1364.60241,332.0321285,2469.208835,19118.79518,436.8915663,149.8594378,1012.638554,23696.40964,746.2088353,132.7590361,2136.445783,17436.54618,1848.574297,583.4417671,2788.120482,15518.22088,694.1405622,293.3935743,1866.975904,11663.12851,1592.550201,428.1807229,1303.827309,8450.176707,645.1285141,159.5662651,2804.333333,7687.004016,1395.044177,175.1967871,3266.97992,768.0883534,726.5301205,249,23.19092901,14.10521383,0.793767608,0.882978723,0.658730159,-0.967050417
+3414,45890.78814,1095.572034,655.4110169,1195.661017,39726.97034,827.8050847,617.9491525,1873.254237,22171.76271,598.5466102,749.8432203,1771.987288,30543,1493.737288,5917.258475,3742.449153,10892.88136,1488.889831,384.6440678,2432.95339,18947.42797,472.2457627,215.2542373,775.6271186,23544.39407,540.1949153,153.470339,4204.033898,18167.2161,2236.877119,580.0932203,2804.033898,15829.41102,769.9576271,306.7627119,1630.580508,11541.45763,1190.775424,459.5550847,1316.288136,7858.915254,682.6059322,177,2791.169492,7302.885593,1464.707627,325.9364407,3326.372881,886.9152542,726.3601695,236,20.85213854,15.49897399,0.668980638,0.874074074,0.595959596,-1.4018306
+3415,34710.11111,976.5382716,566.2345679,1090.466667,31400.47407,776.3259259,749.2222222,1611.982716,17594.37531,572.2567901,1448.851852,1748.034568,23237.20494,1398.266667,2582.780247,3494.365432,8132.135802,1341.985185,316.7802469,2343.491358,17691.01728,506.7654321,159.0246914,1451.580247,21494.85926,1217.306173,176.9382716,1571.585185,15982.80741,1733.11358,554.7530864,2793.634568,14204.13086,728.9802469,287.5234568,1507.358025,10580.61235,1384.140741,411.9728395,1305.723457,7954.666667,651.9283951,161.362963,2564.197531,7331.138272,1457.693827,2358.167901,3299.024691,616.2740741,732.1753086,405,27.91339549,19.64696103,0.710344456,0.880434783,0.578571429,0.640908909
+3416,38011.3865,916.6196319,545.398773,1080.570552,34245.13497,716.7852761,730.803681,1578.466258,19098,559.791411,1548.030675,1796.515337,25637.22086,1293.742331,3680.220859,4211.08589,8954.95092,1341.558282,307.0981595,2455.533742,19762.52147,465.6503067,195.4969325,1735.417178,24107.05521,512.9079755,200.9079755,1523.312883,17692.44172,2084.625767,588.7791411,2793.472393,15725.94479,704.2208589,280.3803681,1437.331288,11871.47239,1613.515337,406.5582822,1294.907975,8901.355828,653.8957055,161.0245399,1839.269939,8029.95092,1361.613497,383.2208589,4216.93865,633.1411043,725.607362,163,17.41245106,12.64073646,0.68773732,0.867021277,0.565972222,-1.017807903
+3417,21277.70968,1009.387097,673.5376344,1159.376344,19586.87097,779.7419355,418.6129032,1618.043011,10716.44086,622.8817204,442.1505376,1731.784946,14298.86022,1511.301075,1629.44086,2133.182796,4993.698925,1524.27957,429.0107527,2382.225806,10741.05376,478.1290323,375.9032258,745.7634409,13494.65591,506.6129032,129.8064516,1399.129032,9918.795699,1768.290323,589.2043011,2775.258065,8894.075269,673.1182796,306.6451613,1580.333333,6772.698925,1116.215054,447.172043,1348.344086,5138.677419,721.3225806,185.8172043,1840.935484,4753.430108,1533.301075,187.3333333,3228.763441,747.3655914,724.9677419,93,14.89353259,8.390060551,0.826228021,0.96875,0.563636364,1.044963644
+3418,21044.9434,721.5754717,478.490566,1044.801887,18747.83019,596.3867925,509.2641509,1518.40566,10355.76415,457.0471698,1031.150943,1769.971698,14476.77358,1098.198113,2974.433962,2201.443396,5446.150943,1189.254717,282.4433962,2494.320755,10724.09434,380.0188679,185.3490566,1131.622642,13115.33019,509.8207547,125.2641509,1229.037736,10302.38679,2048.915094,538.7264151,2832.962264,8643.877358,1380.735849,248.7641509,1330.707547,6461.320755,1032.858491,373.2830189,1308.103774,3980.650943,612.5471698,152.754717,3072.188679,3948.990566,1228.783019,1677.320755,3187.669811,954.3490566,725.1226415,106,12.64238941,10.77114769,0.523563421,0.972477064,0.741258741,0.137689934
+3419,37854.9375,922.453125,575.890625,1124.78125,25186.6875,559.859375,510.09375,1390.734375,13136.23438,473.078125,562.5625,1722.390625,16621.78125,1072.640625,8851.71875,2125.59375,6184.828125,1154.046875,282.34375,2292.96875,13095.65625,381.421875,472.734375,438.328125,15210.5,359.421875,113.0625,3553.828125,12391.3125,1463.109375,384.640625,2807.875,10432.60938,553.328125,245.109375,1014.921875,5739.9375,767.515625,374.5,1285.140625,4253.0625,659.46875,145.640625,2440.765625,4049.265625,1121.53125,153.0625,3176.921875,223.4375,725.609375,64,10.8550141,8.118790709,0.663777608,0.941176471,0.533333333,1.027081693
+3420,42759.98276,965.4310345,547.6034483,1149.275862,40514.08621,789.3965517,811.8793103,1701.672414,22740.53448,616.3965517,659.5,1747.724138,28843.15517,1442.724138,3170.689655,4081.603448,10040,1514.224138,361.1034483,2399.913793,22177.13793,471.4827586,531.637931,608.2413793,26775.60345,686.9655172,142.9310345,3296.5,20865.27586,1711.310345,771.3448276,2849.568966,18663.15517,689.3103448,347.5344828,1685.431034,13632.46552,1120.775862,495.0862069,1332.551724,10419.27586,812.2068966,186.2586207,3719.965517,9433.637931,1552.534483,754.0172414,3311.775862,389.1896552,724.6206897,58,10.36283625,8.090626428,0.624862578,0.892307692,0.537037037,-1.445624618
+3421,40769.22973,985.6891892,557.9324324,1108.891892,36038.83784,774.7027027,824.6891892,1546.797297,20390.78378,598.7297297,1076.297297,1805,26617.64865,1360.878378,3785.297297,3463.459459,9190.472973,1429.716216,334.472973,2488.635135,19912.56757,582.4189189,249.5810811,1309.405405,23588.28378,426.9864865,153.7837838,2890.608108,17793.27027,1744.432432,692.2027027,2826.418919,15883.98649,704.2837838,305.1351351,1508.540541,11690.27027,1130.932432,444.0810811,1311.256757,8866.72973,685.2567568,172.027027,3443.013514,7993.513514,1411.851351,1121.594595,3369.594595,512.2162162,726.7432432,74,12.46581316,8.026353358,0.765135564,0.913580247,0.528571429,-0.078495458
+3422,36978.2562,921.4132231,549.8347107,1100.264463,34011.71074,765.4545455,697.5206612,1634.975207,19287,589.1652893,1778.115702,1798.487603,24966.6281,1370.619835,4125.966942,3899.694215,8936.909091,1543.371901,353.1983471,2392,18776.2562,472.2727273,891.1818182,1311.942149,23442.64463,575.6694215,135.8099174,2710.603306,17336.89256,2009.677686,666.7933884,2838.280992,15554.38843,699.7272727,315.3140496,1690.479339,11476.32231,1428.53719,456.2561983,1332.206612,8713.082645,913.4958678,181.4380165,4150.429752,8051.206612,1461.876033,369.9752066,3303.214876,548.1570248,726.0991736,121,14.26810975,10.94092684,0.64187435,0.975806452,0.733333333,-0.034528645
+3423,41444.00645,884.1870968,492.0129032,1084.651613,35303.47097,745.5612903,630.1870968,1581.645161,21293.73548,551.5419355,1030.322581,1765.496774,27583.50968,1326.903226,3250.329032,3083.329032,9117.83871,1526.329032,414.3548387,2390.967742,21041.35484,475.5096774,150.0387097,918.1612903,26032.89032,654.5225806,126.5806452,2567.006452,20024.19355,1574.290323,639.5677419,2790.032258,17859.21935,619.8193548,285.9677419,1729.154839,13141.70323,1171.948387,419.1483871,1301.954839,9497.490323,645.3677419,163.316129,2945.451613,8828.516129,1395.406452,460.4580645,3240.780645,708.8322581,730.2903226,155,21.35116872,10.3278403,0.875226613,0.811518325,0.596153846,-0.077596116
+3424,21123.04274,821.6752137,499.6837607,1079.188034,18802.79487,657.3846154,507.8034188,1474.350427,10677.05983,490.2735043,420.2564103,1698.17094,14415.2906,1271.076923,1421.299145,1177.008547,5232.333333,1233.854701,306.2136752,2319.863248,10920.44444,396.3931624,149.5128205,499.008547,13101.23077,418.3076923,119.6239316,1020.811966,10204.55556,1407.897436,464.7094017,2952.230769,8886.649573,751.6410256,265.9059829,1433.982906,6790.965812,810.4615385,413.2991453,1297.136752,4768.017094,606.8803419,159.2649573,2021.700855,4530.136752,1367.931624,5420.299145,3136.452991,829.7948718,724.5384615,117,17.51557481,8.630795733,0.870171046,0.886363636,0.65,1.472489297
+3425,36075.4717,831.0943396,493.5660377,1067.566038,32596.79245,698.7358491,530.8301887,1596.792453,18642.28302,522.2830189,908.0188679,1751.528302,24540.73585,1301.339623,3177.283019,4062.245283,9173.132075,1319.245283,324.9811321,2435.849057,18693.30189,410.5660377,122.245283,734.2641509,23316.13208,800.6226415,128.5660377,2895.867925,17655.58491,1527.622642,667.754717,2808.018868,15246.43396,654.9245283,293.8867925,2110.207547,11587,1158.641509,423.5283019,1311.377358,7945.962264,648.2641509,166.9811321,4573.075472,7332.113208,1409.415094,2157.528302,3236.018868,842.0188679,725.1132075,53,10.56489194,7.091228003,0.741270088,0.883333333,0.535353535,0.532759986
+3426,52138.07317,983.0487805,609.2073171,1188.262195,25995.61585,605.8109756,343.0182927,1636.47561,12694.79268,474.9939024,448.9817073,1746.20122,16382.12805,1116.969512,9593.384146,3203.664634,6210.853659,1161.719512,283.9329268,2291.359756,12941.70122,342.652439,277.3414634,414.4634146,15114.28659,393.3536585,113.8658537,6364.969512,11340.14634,1345.817073,434.7073171,2814.359756,9724.871951,536.4207317,263.6158537,1964.963415,4653.006098,713.0853659,370.8109756,1278.323171,3499.542683,597.554878,147.8780488,2033.762195,3230.121951,1093.182927,174.6280488,3127.695122,186.445122,728.0914634,164,16.19567201,13.33823143,0.567218068,0.976190476,0.602941176,-0.563684979
+3427,15717.11429,844.1885714,524.2685714,1090,14213.42857,669.3485714,560.5028571,1521.908571,7951,504,520.8114286,1784.085714,10221.12,1194.794286,2412.057143,1841.028571,3765.634286,1461.434286,330.4457143,2359.662857,8004.457143,390.6457143,1233.634286,514.7885714,9403.954286,441.3714286,120.2057143,1496.845714,7115.651429,1670.954286,612.1142857,2831.022857,6324.651429,796.2457143,266.44,1854.765714,4803.222857,820.2457143,412.2857143,1352.714286,3705.108571,959.7942857,161.4971429,2732.091429,3450.182857,1302.108571,423.1485714,3281.954286,489.04,727.7828571,175,16.16387299,13.87229693,0.513267759,0.961538462,0.777777778,-0.750149486
+3428,33687.04717,833.245283,516.3584906,1063.707547,28996.01887,676.9056604,543.5566038,1515.707547,17122.14151,528.6320755,613.8962264,1794.226415,22062.63208,1247.632075,2991.462264,2304.933962,7734.650943,1550.103774,315.509434,2384.603774,16359.92453,429.6509434,711.9056604,585.8301887,20667.45283,433.0754717,124.5188679,1966.566038,15407.18868,1589.707547,697.9622642,2830.358491,13450.48113,917.4150943,282.8773585,1586.264151,10132.26415,939.3207547,425.8584906,1317.556604,7529.773585,830.6792453,163.0283019,3959.141509,7020.216981,1330.726415,165.3867925,3240.90566,568.7264151,726.1320755,106,13.2002428,10.28524875,0.626811195,0.972477064,0.679487179,-0.748892301
+3429,19371.75455,878.8090909,882.3454545,1179.754545,16544.58182,693.8272727,711.5090909,1722.8,9104.563636,492.2,563.3545455,1795.254545,12341.86364,1257.727273,4367.718182,2919.936364,4441.236364,1318.481818,295.1818182,2367.527273,9097.481818,413.8454545,120.2,474.0181818,11152.89091,431.3727273,119.9181818,3440.554545,8479.836364,1429.327273,559.7363636,2781.663636,7297.390909,593.5363636,254.8545455,1863.363636,5624.481818,776.8636364,405.9636364,1319.381818,4034.827273,598.2,161.7545455,2792.054545,3796.009091,1289.372727,155.7818182,3222.236364,807.5181818,728.3363636,110,14.80632777,9.789272086,0.750249666,0.924369748,0.6875,-0.02732841
+3430,26893.34118,1223.288235,606.4235294,1082.2,22002.36471,639.7529412,431.9941176,1484.470588,11607.09412,539.9235294,515.9176471,1726.529412,14807.64118,1292.770588,5975.323529,3279.858824,6113.511765,1312.335294,314.2941176,2347.070588,12549.80588,382.9352941,336.4647059,442.1764706,15343.38824,434.4941176,126.3764706,5031.505882,11286.68824,1539.017647,460.5941176,2803.2,10071.80588,638.3352941,277.9705882,1426.894118,7230.035294,879.8764706,425.2941176,1311.694118,5499.994118,679.4529412,170.8647059,4468.570588,4703.535294,1257.235294,142.5176471,3409.982353,282.9235294,729.0647059,170,24.67817533,10.10783286,0.912271552,0.805687204,0.53968254,1.250836299
+3431,31055.26126,928.3153153,783.9009009,1099.342342,27614.18018,711.1981982,796.1711712,1650.846847,15396.88288,651.4684685,703.2252252,1790.027027,20164.22523,1282.810811,3111.351351,3230.135135,7168.981982,1364.441441,325.3063063,2478.666667,15480.86486,518.5135135,504.9459459,579.9459459,18615.76577,864.8558559,117.5675676,2266.612613,13840.4955,1546.441441,628.5675676,2786.576577,12242.09009,971.7657658,273.3873874,1608.027027,9173.297297,942,393.5495495,1329.783784,6873.261261,726.2702703,158.5495495,3587.531532,6117.225225,1303.081081,167.1621622,3741.810811,648.6936937,727.5855856,111,12.76237748,11.86442612,0.36846721,0.874015748,0.566326531,-1.160736766
+3432,21395.28358,750.4253731,504.0820896,1067.179104,19300.17164,611.5820896,530.5671642,1484.768657,10454.17164,476.7313433,464.1865672,1744.850746,14025.49254,1368.119403,2705.529851,1827.507463,5245.268657,1323.880597,313.8208955,2399,10893.15672,7121.5,128.6044776,495.5074627,13450.16418,468.5820896,110.0223881,1977.044776,9788.380597,1391.313433,712.358209,2779.238806,8591.649254,1617.723881,248.9925373,1430.61194,6644.171642,814.1343284,369.7014925,1295.507463,4933.671642,636.7686567,148.6343284,3106.253731,4509.164179,1216.455224,157.4552239,3231.61194,664.4925373,729.3955224,134,13.97510614,12.23580393,0.483140517,0.943661972,0.744444444,0.065391004
+3433,33904.97273,933.7727273,511.2272727,1108.990909,30232.99091,730.8909091,730.3363636,1662.054545,17102.42727,561.3363636,888.3272727,1774.172727,22431.34545,1332.981818,5683.481818,4069.472727,7827.736364,1480.6,373.8636364,2455.227273,17580.83636,498.4363636,152.5181818,1256.081818,21883.27273,438.3727273,155.0727273,2143.336364,15930.32727,1997.490909,594.4454545,2783.218182,13859.44545,644.7636364,285.8636364,2019.836364,10563.42727,1319.9,412.3090909,1317.490909,7668.118182,768.5090909,166.3454545,3490.645455,7080.909091,1405.827273,182.6363636,3316.618182,679.8545455,726.8,110,13.28180526,10.72281554,0.590098604,0.964912281,0.714285714,-1.253454434
+3434,28927.66667,993.5,745.4148148,1134.448148,26199.75926,769.5518519,767.5,1717.722222,15176.85926,651.6962963,1055.414815,1775.22963,19979.46296,1392.725926,2903.833333,1924.025926,7024.066667,1366.607407,330.6037037,2455.003704,14336.44074,439.2222222,514.3,639.6296296,17897.64074,457.3037037,191.8814815,1972.185185,13197.45926,1737.488889,526.8518519,2805.962963,11402.30741,733.0518519,278.9259259,1483.333333,8682.711111,1027.918519,423.5,1334.1,6317.314815,740.9814815,161.4814815,2242.22963,5802.374074,1357.837037,343.0185185,3276.444444,794.8407407,731.2740741,270,20.86770657,18.21592792,0.487855702,0.885245902,0.676691729,0.493651956
+3435,26391.14286,885.5607143,547.8642857,1086.507143,13546.40357,446.6071429,338.9071429,1248.407143,5966.807143,355.6571429,666.5035714,1604.132143,9138.364286,895.7821429,3932.628571,1575.135714,3462.382143,944.275,227.5,2317.967857,6619.857143,320.1821429,252.2642857,623.0571429,8139.035714,305.375,98.23928571,2057.485714,6038.764286,1441.439286,384.2321429,2810.535714,4888.05,471.7714286,192.15,761.5714286,2983.167857,831.2142857,311.8,1262.925,1552.217857,531.5821429,131.2821429,1703.135714,1625.421429,866.4392857,185.2142857,2907.014286,1073.503571,733.8,280,25.5471774,14.12854588,0.833156394,0.962199313,0.746666667,0.189297487
+3436,29803.01587,945.3492063,606.6825397,1104.309524,15501.35714,526.515873,386.5079365,1368.484127,7749.388889,434.8095238,1061.404762,1756.428571,9528.285714,1186.238095,8902.984127,4596.047619,3592.706349,1077.103175,254,2375.174603,7905.785714,460.2619048,170.3888889,817.9206349,9213.460317,558.1190476,110.7380952,4664.595238,6937.920635,1590.888889,429.3492063,2843.666667,6154.166667,519.3650794,228.3888889,1337.31746,3717.246032,961.0952381,354.1825397,1279.365079,2818.380952,558.5952381,147.2142857,2347.309524,2523.190476,1049.531746,405.5952381,3044.190476,247.0079365,729.2777778,126,13.79336783,11.69993079,0.52963009,0.961832061,0.692307692,0.888092007
+3437,29410.62319,916.5942029,620,1079.130435,26390.30435,661.115942,561.4782609,1553.521739,14591.71014,512.8405797,662.9855072,1796.637681,19086.18841,1209.028986,4315.289855,3685.594203,6804.869565,1602.115942,306.6231884,2405.202899,14422.47826,413.0144928,517.5507246,596.3768116,17950.89855,719.6956522,122.3623188,2580.521739,13102.84058,1475.043478,707.4492754,2803.101449,11738.82609,650.2028986,272.5217391,2028.521739,8730.536232,937.3478261,418.4492754,1301.84058,6788.231884,716.7246377,170.057971,6511.434783,6152.855072,1304.797101,164.173913,3215.84058,559.0434783,728.3768116,69,11.4007868,8.781305554,0.637758003,0.793103448,0.570247934,0.607694294
+3438,37256.83251,909.4581281,515.8374384,1094.684729,31968.97044,758.0295567,805.9064039,1683.403941,17685.04926,523.5862069,1400.990148,1803.256158,23640.48768,1241.610837,4519.487685,3333.083744,8798.167488,1278.635468,320.6896552,2453.433498,17496.71429,549.0591133,130.2216749,1550.960591,21511.51232,490.9901478,292.6256158,2761.128079,16540.68966,1997.364532,564.5024631,2808.487685,14210.30542,631.1773399,278.2315271,1346.714286,10099.97537,1056.078818,412.4236453,1289.251232,6355.862069,606.9310345,159.9211823,3577.827586,6105.172414,1263.497537,326.5418719,3317.596059,939.4876847,732.0295567,203,20.4143163,13.14743509,0.765000112,0.902222222,0.667763158,0.282000155
+3439,31597.09524,930.6095238,654.2857143,1087.171429,22494.59048,650.3190476,641.1952381,1619.733333,11872.4619,499.4761905,1146.595238,1792.12381,14991.80952,1197.5,6194.385714,5115.338095,5488.661905,1229.290476,303.5095238,2450.22381,11866.52857,402.8333333,1769.733333,743.2142857,14339.94286,631.9666667,286.3571429,6013.661905,10891.64286,2025.52381,461.9904762,2816.519048,9314.585714,653.2285714,278.2952381,1431.471429,5771.647619,1073.638095,412.1047619,1365.914286,4403.57619,985.1333333,166.6761905,6172.261905,3900.604762,1212.009524,274.352381,3188.628571,260.4285714,733.7571429,210,24.51487059,11.14474484,0.890689779,0.95890411,0.5,-0.841512463
+3440,37982.79518,1001.987952,545.7228916,1112,35269.43373,801.4096386,742.9759036,1588.409639,19708.16867,615.2289157,1696.53012,1786.144578,25298.62651,1427.156627,3370.819277,3885.987952,9419.662651,1473.963855,374.8313253,2408.036145,19603.50602,479.2409639,776.7590361,1531.927711,24023.44578,615.5180723,332.8674699,2343,17836.80723,2287.855422,613.0722892,2838.445783,15847.38554,656.7108434,326.0361446,1490.819277,11941.71084,1426.337349,481.9036145,1365.361446,9104.012048,904.6626506,185.8795181,2774.012048,8297.337349,1523.012048,193.4337349,3307.337349,466.0722892,727.8554217,83,15.45476777,7.063194879,0.889454526,0.902173913,0.691666667,1.47236129
+3441,32827.8169,788.8591549,483.5352113,1049.464789,29253.53521,650.7183099,886.1126761,1443.394366,16929.6338,541.5915493,1941.056338,1730.774648,22449.73239,1238.43662,3390.267606,3181.633803,7739.71831,1385.492958,309.5633803,2712.957746,16674.42254,510.7605634,565.6056338,1990.126761,20439.39437,409.8309859,355.943662,1850.450704,15512.28169,1937.760563,875.7042254,2807.985915,13769.98592,670.028169,283.3239437,1466.591549,10271.23944,1244.422535,434.5352113,1379.577465,7800.380282,735.5352113,170.7887324,5404.704225,7201.338028,1349.690141,1148.816901,3280.408451,521.0140845,729.5352113,71,13.78173987,7.196326407,0.852845185,0.865853659,0.493055556,-0.855215985
+3442,41706.04412,1005.308824,555.9852941,1122.088235,36407.77941,813.8970588,802.6176471,1670.720588,21758.64706,635.1911765,1439.794118,1774.191176,27612.83824,1470.794118,2723.897059,5475,9960.955882,1496.632353,363.6911765,2407.235294,21018.16176,501.4117647,506.7058824,985.7058824,25668.13235,1183.5,138.6911765,1863.897059,19593.23529,1621.882353,788.1617647,2822.794118,17463.08824,827.8235294,333.7352941,1843.161765,12977.30882,1616.367647,477.4411765,1339.661765,9753.852941,769.5588235,183.7941176,3000.794118,8853.029412,1531.955882,762.7205882,3296.411765,537.2794118,729.5147059,68,12.419182,7.687623735,0.785381461,0.839506173,0.472222222,-0.901068453
+3443,39741,871.4347826,768.0144928,1126.550725,35443.10145,729.4637681,777.1884058,1703.782609,20854.76812,554.4057971,770.9565217,1799.811594,27858,1306.507246,2364.115942,2664.637681,10162.53623,1339.376812,338.3478261,2435,20537.3913,432.1014493,212.5652174,622.9130435,25257.53623,572.1594203,131.1594203,2518.304348,19936.62319,1526.202899,528.9275362,2796.304348,16982.53623,743.9565217,279.942029,2017.782609,12826.23188,1043.15942,441.884058,1332.246377,8631.231884,697.1884058,163.4347826,4802.695652,8317.695652,1404.753623,650.3188406,3265.15942,849.1304348,729.8405797,69,11.3104941,8.077682009,0.6999663,0.884615385,0.638888889,-0.095154126
+3444,51273.9434,978.6100629,619.0566038,1180.641509,11678.96855,410.572327,179.5974843,1115.773585,5696.119497,335.5786164,543.4968553,1619.937107,7749.704403,833.3647799,2401.301887,1563.157233,2789.050314,874.9874214,206.0503145,2255.886792,5713.930818,217.9371069,80.10062893,460.918239,6617.132075,250.2515723,97.11949686,2597.672956,4874.402516,1188.628931,288.0880503,2776.515723,4108.050314,430.6603774,184.163522,993.2138365,1919.779874,574.1320755,298.836478,1250,1430.754717,470.8805031,124.3018868,907.9937107,1391.283019,821.9119497,86.81132075,2826.062893,171.4716981,731.3459119,159,18.09075825,11.25707321,0.78281424,0.969512195,0.709821429,-0.867972502
+3445,40219.49438,914.9438202,485.9325843,1102.910112,34723.02247,753.9213483,655.1460674,1564.741573,20293.65169,546.4382022,968.7752809,1740.752809,27214.57303,1407.786517,2849.224719,2716.11236,8869.382022,1575.438202,437.4269663,2379.078652,20299.29213,455.2247191,224.0898876,830.1797753,25188.25843,606.9213483,124.5280899,1654.865169,19229.59551,1502.494382,552.752809,2799.337079,17117.44944,716.6629213,289.3033708,1476.606742,12572.83146,1233.764045,430.5617978,1312.752809,9187.988764,662.0337079,171.3595506,1632.898876,8391.337079,1450.078652,571.3370787,3261.168539,718.0337079,729.8876404,89,12.00918528,9.608503503,0.599871713,0.946808511,0.674242424,-1.042576677
+3446,34096.2,926.6571429,964.4,1195.371429,27968.84286,732.9857143,911.8142857,1777.7,17524.42857,545.8571429,475.9714286,1772.1,22028.58571,1367.285714,1014.957143,972.4285714,7992.757143,1420.628571,343,2347.285714,16850.68571,478.8285714,127.5,476.3857143,20430.57143,489.5857143,133.3571429,1138.757143,16234.14286,1515.642857,472.3428571,2809.685714,13947.41429,683.7142857,309.0285714,1570.471429,10604.15714,870.8571429,455.2714286,1319.771429,7151.114286,632.0571429,165.3571429,921.6142857,6969.557143,1445.057143,195.3,3251.585714,818.2142857,729.3428571,70,10.86676762,8.403102825,0.634059226,0.933333333,0.7,1.175203449
+3447,41364.58025,927.3580247,646.7530864,1165.333333,25603.24691,660.3950617,964.0987654,1627.592593,14703.71605,487.5185185,1170.617284,1755.061728,20580.23457,1221.358025,2996.814815,2621.407407,7591.740741,1370.08642,312.2839506,2541.950617,15161.58025,417.7901235,152.7407407,1099.419753,18999.19753,770.6296296,129.1975309,1208.888889,14743.66667,1816.308642,449.6790123,2803.91358,12952.83951,1153.728395,269.5185185,1225.185185,9560.975309,1341.851852,416.2962963,1305.049383,6345.864198,617.9753086,165.345679,1749.703704,6089.012346,1293.061728,621.8271605,3196.567901,895.345679,734.7283951,81,19.06609731,6.562829733,0.938890987,0.801980198,0.473684211,-0.218572878
+3448,38370.55172,960.4367816,743.2413793,1169.103448,23553.41379,633.5172414,723.5172414,1602.057471,13798.11494,493.908046,795.5287356,1776.54023,18789.58621,1228.954023,2850.712644,2191.436782,6999.413793,1257.724138,311.5632184,2377,14155.70115,412.816092,144.6091954,795.1034483,17675.01149,602.1034483,128.2183908,2940.758621,13749.68966,1568.551724,486,2777.597701,11988.73563,1190.574713,275.5172414,1397.137931,8845.988506,935.0574713,417.0344828,1297.229885,5850.597701,614.6896552,162.0229885,2330.632184,5655.103448,1311.908046,310.6666667,3136.517241,904.3448276,729.7126437,87,11.27674321,10.22066347,0.422530147,0.945652174,0.659090909,-1.285110803
+3449,34349.6375,821.625,479.2375,1067.75625,31432.55,709.48125,635.61875,1621.64375,17389.7875,520.89375,1566.19375,1764.3875,23222.30625,1241.125,3675.7,3559.03125,8699.30625,1297.925,327.58125,2388.9875,17288.7375,408.73125,133.825,1275.15625,21525.525,771.50625,186.3625,2522.55625,16508.74375,1938,494.7375,2794.475,14242.3625,691.275,286.3625,1446.63125,10232.73125,1298.2875,417.5875,1304.225,6698.8375,624.1875,161.3625,2720.73125,6284.875,1299.925,794.48125,3194.20625,927.19375,733.2125,160,16.84203385,12.90437022,0.642601904,0.888888889,0.62745098,0.596630757
+3450,29242.09392,818.0331492,546.9337017,1081.176796,11467.53039,508.2209945,460.5745856,1297.679558,5475.176796,372.9668508,1250.430939,1695.005525,8021.58011,912.7016575,4431.502762,2367.198895,3089.850829,983.558011,237.0110497,2381.414365,6028.707182,325.1491713,255.0110497,1282,7365,348.801105,103.9944751,2463.994475,5576.618785,1873.729282,380.121547,2779.39779,4525.044199,543.9116022,194.3259669,835.5690608,2981.707182,1289.872928,318.961326,1261.138122,1580.414365,546.2983425,130.6629834,2400.276243,1662.331492,897.7845304,563.9171271,2949.524862,1060.679558,734.7127072,181,21.58397586,10.73783307,0.867469155,0.952631579,0.718253968,0.271429915
+3451,24722.60656,857.295082,544.6229508,1072.131148,23961.52459,699.3114754,712.3442623,1564.409836,12772.78689,555.9016393,1019.360656,1770.131148,16268.29508,1284.803279,6531.655738,4945.852459,6166.868852,1319.180328,321.9672131,2571.557377,13089.57377,415.6557377,1065.278689,732.2131148,14766.21311,422.6885246,125.2295082,3843.131148,11370.78689,1821.409836,706.2295082,2814.770492,10184.31148,810.9672131,281.8360656,1706.47541,7253.344262,1110.344262,447.2295082,1330.065574,5714.311475,815.8688525,176.9836066,4471.655738,4903.95082,1374.95082,1631.147541,3208.836066,355.9672131,729.1311475,61,12.52982438,6.644827276,0.847797017,0.835616438,0.635416667,-1.413066117
+3452,26392.51261,908.7731092,1044.201681,1189.521008,24221.65546,726.6302521,817.5630252,1817.588235,13729,543.3781513,598.0504202,1783.89916,19126.57143,1347.058824,1090.07563,1454.647059,6920.016807,1431.798319,337.6134454,2368.521008,13677.65546,447.6806723,154.5546218,599.487395,17317.44538,477.7310924,133.0504202,1284.369748,13326.28571,1544.042017,487.605042,2806.445378,11384.84874,814.8403361,289.7731092,1788.806723,8657.12605,848.2352941,440.2689076,1319.344538,5933.033613,630.6722689,165.7731092,1821.428571,5683.042017,1402.89916,794.697479,3275.865546,858.0756303,732.6806723,119,14.27186029,10.83579675,0.650808327,0.937007874,0.772727273,-0.068988959
+3453,29096.18812,987.7920792,612.0792079,1115.366337,26950.70297,769.1485149,1031.39604,1628.148515,14895.43564,585.8217822,1746.306931,1770.782178,18657.59406,1370.376238,4134.108911,4007.39604,6731.267327,1572.811881,342.2079208,3179.782178,14799.60396,586.4653465,1310.811881,1268.574257,17702.60396,512.9207921,138.8712871,3099.643564,13093.43564,2051.287129,804.3861386,2839.613861,11711.14851,671.7128713,312.2079208,1783.39604,8643.643564,1373.257426,466.2178218,1397.891089,6652.49505,1066.544554,180.3564356,4468.445545,5979.336634,1473.950495,257.1584158,3334.544554,450.9306931,732.4752475,101,13.23028605,10.05930935,0.649543534,0.926605505,0.601190476,-1.072642881
+3454,25513.86544,868.1865443,522.4250765,1050.553517,22899.32416,679.8256881,764.6024465,1487.495413,12971.78287,533.7033639,1074.926606,1767.275229,17042.55352,1237.06422,3729.987768,2906.412844,6011.278287,1307.324159,325.5932722,2370.868502,13213.9633,429.2507645,1086.541284,821.17737,16118.6055,440.2752294,142.1987768,1253.850153,11909.83486,1867.085627,579.0856269,2798.902141,10520.0367,1070.29052,265.7186544,1475.391437,7843.278287,1084.2263,405.4495413,1348.905199,5899.779817,1007.957187,152.6727829,2096.844037,5546.04893,1289.348624,506.0428135,3276.388379,589.2293578,737.4770642,327,28.20388511,15.322315,0.839558264,0.913407821,0.571678322,0.85739017
+3455,35643.71728,916.539267,665.617801,1135.198953,16206.18848,498.0366492,340.7172775,1288.732984,7777.282723,417.0366492,530.3036649,1695.649215,10317.08377,969.8010471,7604.026178,2215.581152,3890.827225,1005.528796,241.5602094,2279.926702,7936.842932,289.9895288,454.0104712,471.7801047,9238.570681,321.8743455,98.65968586,3757.267016,6928.120419,1362.109948,317.5811518,2785.13089,5872.670157,480.8010471,216.0680628,1167.115183,2978.617801,707.5968586,336.895288,1277.418848,2284.408377,613.7643979,137.434555,1596.91623,2137.937173,978.6858639,152.9109948,3036.790576,193.591623,738.0157068,191,20.45852729,12.38354886,0.795997346,0.950248756,0.535014006,-0.63816587
+3456,30389.35983,917.5020921,538.8075314,1082.623431,13684.45188,489.7991632,323.0543933,1303.543933,6833.92887,416.3472803,581.4853556,1727.422594,8965.062762,977.5188285,6173.09205,1912.887029,3350.322176,1090.790795,244.6066946,2267.16318,7084.824268,315.8619247,3642.58159,521.4518828,8240.138075,350.334728,106.2635983,1486.179916,6357.899582,1546.288703,514.1046025,2813.707113,5436.769874,500.9916318,211.9748954,905.3263598,2981.610879,763.5439331,345.1338912,1266.694561,2285.154812,1248.32636,139.3640167,986.4769874,2057.09205,1016.715481,115.1422594,3056.32636,217.8535565,735.9874477,239,23.0835976,13.46771233,0.812161905,0.929961089,0.692753623,-1.377562006
+3457,31216.47431,940.4664032,549.5098814,1098.964427,29257.71542,753.1462451,852.5059289,1616.992095,15880.24901,592.4743083,1247.628458,1802.3083,20291.67194,1364.284585,4457.466403,4420.513834,7225.521739,1404.897233,348.2332016,2478.6917,15679.63241,487.1422925,629.2173913,984,18704.58893,1096.513834,134.3636364,2594.865613,14488.16996,1718.956522,749.9130435,2829.644269,12784.78656,641.8616601,317.2055336,1836.521739,9249.296443,1748.351779,458.9604743,1321.162055,7086.656126,798.4387352,179.0079051,3598.063241,6278.624506,1452.071146,578.4387352,3342.059289,386.4980237,738.1106719,253,21.00186171,15.76427388,0.660741914,0.910071942,0.708683473,-0.325645596
+3458,37527.55882,907.4926471,497.3308824,1117.191176,33501.50735,748.9705882,758.8823529,1590.595588,19447.09559,582.6764706,857.25,1774.345588,24991,1383.698529,2629.477941,3372.147059,8671.735294,1458.007353,345.5441176,2352.132353,18647.04412,447.5882353,933.1176471,778.9632353,22365.64706,716.4558824,134.2426471,1794.25,17599.84559,1719.911765,946.8088235,2842.625,15510.38235,680.375,317.3308824,1848.838235,11224.60294,1327.852941,462.0808824,1332.220588,8528.985294,840.5073529,180.5220588,2258.455882,7825.125,1541.058824,2188.235294,3266.441176,399.7058824,735.625,136,15.79351667,11.0395618,0.71512825,0.957746479,0.772727273,-0.198878332
+3459,35414.09565,903.2695652,599.0173913,1102.356522,31620.74783,719.6434783,849.6173913,1635.208696,18243.38261,545.6869565,1021.547826,1758.173913,24174.11304,1344.086957,1911.843478,2497.286957,7981.269565,1594.626087,423.9217391,2426.608696,17704.93043,446.5913043,129.7043478,1122,22534.18261,505.3565217,135.2956522,1389.73913,16936.9913,1715.13913,562.5043478,2801.356522,14809.81739,797.6782609,282.4434783,1526.678261,11035.03478,1491.330435,434.3652174,1302.817391,8050.8,628.4,161.1391304,2068.182609,7392,1424.2,328.0782609,3268.286957,727.2782609,734.1913043,115,13.89842237,10.6191315,0.645153464,0.974576271,0.680473373,-0.729303495
+3460,23990.60145,1081.985507,698.0652174,1082.210145,20644.62319,700.8695652,811.5797101,1497.297101,12006.60145,563.6811594,1151.166667,1771.297101,16198.86957,1233.463768,2141.413043,1843.855072,5704,1242.630435,294.4275362,2365.615942,11872.65217,377.4057971,147.4782609,961.1231884,14549.63768,427.9782609,390.7028986,1324.855072,10887.74638,1787.804348,475.8478261,2794.992754,9583.427536,648.384058,249.0434783,1187.246377,7171.144928,935.9347826,377.3115942,1315.210145,5230.978261,582.615942,151.8695652,1439.514493,4877.23913,1227.652174,174.4565217,3426.268116,778.615942,735.1811594,138,14.65324876,12.0442459,0.569558856,0.951724138,0.707692308,-0.198959902
+3461,25558.77922,894.0909091,1035.194805,1184.077922,24086.84416,730.7012987,967.5974026,1772.038961,12858.75325,529.2467532,1750.584416,1968.623377,18066.38961,1277.831169,2225.584416,3187.272727,6510.285714,1298.12987,316.2727273,2839.896104,13261.28571,444.7792208,167.3506494,1145.519481,16496.54545,549.2467532,246.9480519,1431.649351,12391.63636,1910.298701,509.6103896,2792.961039,10719.25974,973.6883117,285.2987013,2050.597403,8115.454545,1199.532468,433.9350649,1355.025974,5867.597403,638.7142857,163.5324675,3056.558442,5412.974026,1359.103896,511.2337662,3313.285714,839.4545455,733.6753247,77,11.00237518,10.22764298,0.368607813,0.819148936,0.493589744,0.837338531
+3462,36483.43128,870.2227488,497.0947867,1116.023697,21294.82938,601.521327,474.4028436,1551.132701,10402.66351,447.2654028,1549.018957,1765.341232,14982.49289,1089.251185,6361.696682,3174.630332,5627.327014,1171.824645,287.8436019,2683.507109,10911.61611,364.4123223,870.92891,1346.156398,13820.38863,423.0331754,117.478673,2538.265403,10400.9763,2153.094787,428.0331754,2800.781991,8381.962085,799.7725118,238.2274882,1042.218009,5826.943128,1261.123223,363.8104265,1289.578199,3304.161137,754.943128,146.4691943,2967.459716,3296.791469,1085.464455,471.3649289,3129.748815,1030.691943,736.0616114,211,17.55615827,15.63212476,0.455165379,0.959090909,0.732638889,-1.14818044
+3463,45951.76309,1030.084788,587.2394015,1133.281796,39134.91521,766.9600998,641.3715711,1815.157107,21586.85536,600.8354115,843.0648379,1777.476309,26684.38903,1381.541147,7980.314214,5059.441397,9812.713217,1453.458853,354.40399,2378.571072,21224.57107,439.6558603,466.319202,508.8778055,25375.66584,631.4314214,143.2743142,5010.107232,19490.09227,1814.568579,523.6508728,2824.446384,17152.06983,640.9750623,332.9875312,1606.269327,10987.17207,1272.773067,465.6758105,1316.9202,8339.072319,910.6658354,184.563591,4865.062344,7268.740648,1445.299252,168.6608479,3362.089776,279.8179551,741.5910224,401,29.56277326,17.86966053,0.79663173,0.899103139,0.59672619,1.172615818
+3464,31494.60638,1052.648936,606.4468085,1100.702128,28265.48936,762.5957447,794.3510638,1658.37234,16346.7234,615.6595745,800.9680851,1812.648936,20721.61702,1347.914894,6013.457447,2496.946809,7096.276596,1395.734043,332.9361702,2355.180851,15692.39362,454.4787234,729.3085106,474.4042553,18510.67021,455.5319149,142.1489362,3284.478723,14946.35106,1731.031915,564.2340426,2821.989362,13166.34043,656.5851064,301.1276596,1294.93617,8890.904255,930.6382979,453.9361702,1323.925532,6727.882979,747.4468085,175.1595745,2598.840426,6237.574468,1362.393617,353.7021277,3478.276596,335.9042553,735.9361702,94,13.02311426,9.61688654,0.674310943,0.94,0.671428571,0.435963611
+3465,32248.375,986.7241379,718.9094828,1128.573276,28691.71552,780.6939655,1027.689655,1673.198276,16062.06466,589.1034483,1400.362069,1859.25,20504.06897,1358.922414,7584.293103,4656.849138,7117.073276,1454.767241,347.1163793,2438.017241,15541.37931,448.262931,855.0905172,1217.413793,18544.18534,520.8491379,169.512931,3424.676724,13739.10345,2074.030172,699.0560345,2822.025862,12255.48276,731.4741379,301.7413793,1839.956897,9100.284483,1534.443966,453.7155172,1348.650862,6965.331897,844.6465517,172.8017241,4012.094828,6237.073276,1427.340517,355.362069,3338.176724,501.6422414,737.8362069,232,19.09923478,16.20081041,0.529605699,0.902723735,0.610526316,-0.506819777
+3466,29432.78814,932.8305085,608.1440678,1093.067797,25852.23729,708.0508475,592.7542373,1516.516949,14406.54237,554.9915254,665.1186441,1748.474576,18661.33898,1274.720339,2864.432203,3082.805085,6733.872881,1341.008475,309.5169492,2422.635593,14361.86441,422.8050847,908.3983051,534.7966102,17146.22881,435.8220339,127.9745763,1922.59322,12622.70339,1589.881356,1359.686441,2793.144068,11371.68644,675.6694915,281.8559322,1796.491525,8435.194915,979.559322,428.5169492,1368.90678,6631.305085,810.9491525,173.6779661,7020.169492,5802.627119,1323.313559,371.6186441,3405.584746,527.3050847,735.5338983,118,13.37038558,11.42090369,0.519954363,0.967213115,0.648351648,-0.838315139
+3467,27977.5125,1056.725,588.55,1066.075,25730.875,609.2625,930.9875,1469.825,13893.8125,470.0125,2106.375,1822.15,19756.7125,1177.325,5305.5375,3730.3375,6833.675,1293.9375,294.0625,3271.25,14944.275,714.5125,134.3125,1551.0125,18429.325,445.95,151.9625,1320.5375,13394.5875,2443.2125,661.725,2810.1875,11806.4875,799.7875,260.3125,1356.6625,9097.8,1722.4875,386.5625,1283.15,6961.075,604.5625,151.5625,2736.4125,6292.4125,1267.45,256.9875,4425.4875,639.5375,733.7625,80,10.96741784,9.538906954,0.493493349,0.930232558,0.661157025,-1.158358743
+3468,34162.20134,940.0469799,539.2348993,1092.42953,30083.07383,738.9395973,669.8255034,1619.228188,17305.08054,569.9932886,817.1342282,1744.134228,23588.26846,1343.362416,4300.228188,3946.463087,7972.389262,1545.228188,400.5234899,2384.328859,18076.61745,479.2550336,162.2684564,890.0805369,22183.75839,469.3758389,181.295302,3166.805369,16653.7651,2001.503356,582.7315436,2782.362416,14492.03356,638.3624161,282.0268456,1803.919463,10963.00671,1240.697987,415.5503356,1310.818792,8038.946309,685.4697987,169.0067114,3226.704698,7503.463087,1387.389262,256.5704698,3335.536913,686.7516779,737.4496644,149,16.13665098,12.53735862,0.629563251,0.861271676,0.62605042,0.102300909
+3469,19401.90741,886.5802469,911.8641975,1154.246914,17916.07407,713.3395062,819.4074074,1700.17284,9696.419753,527.4012346,970.0864198,1833.117284,13680.20988,1298.506173,1600.12963,1970.67284,4845.611111,1344.314815,322.3641975,2443.67284,9917.030864,467.2098765,179.7839506,963.462963,12186.74691,572.1975309,135.3518519,952.8024691,9173.450617,1698.493827,458.5123457,2818.882716,7987.604938,1237.444444,274.1481481,1850.191358,6069.253086,1150.074074,433.5185185,1331.962963,4403.635802,627.845679,167.8518519,2275.574074,4106.265432,1368.82716,295.5,3238.030864,828.7839506,736.308642,162,15.86299186,13.59087112,0.515705464,0.870967742,0.675,0.569861402
+3470,25666.39259,829.9925926,599.2592593,1080.874074,23575.51852,673.2814815,775.037037,1611.377778,13388.38519,535.162963,695.2592593,1831.296296,16844.52593,1227.42963,6068.844444,3795.362963,6287.325926,1528.644444,317.2,2378.703704,13312.85926,407.5703704,3152.266667,638.6,15711.6,447.4444444,141.5555556,2561.82963,12258.59259,1899.888889,898.7037037,2867.703704,10867.5037,731.8444444,285.6222222,1526.325926,7565.422222,1067.037037,438.6296296,1330.644444,5731.207407,1236.118519,176.0666667,3170.496296,5196.77037,1347.066667,442.8296296,3300.422222,325.7777778,738.037037,135,16.66465968,10.42482836,0.780172027,0.944055944,0.767045455,-0.223995974
+3471,40163.11628,1122.209302,589.9302326,1112.604651,36010.27907,835.1162791,864.8372093,1615.651163,20952.53488,664.1395349,803.627907,1754.162791,26444.90698,1458.906977,4899.790698,3347.976744,8854.837209,1446.418605,351.5116279,2368.023256,20902.83721,465.6744186,390.7674419,756.744186,25176.5814,458.5581395,161.5116279,4056.023256,19605,1856.976744,636.627907,2836.488372,17296.90698,668.0930233,324.9069767,1560,11905.06977,998.3023256,458.5813953,1315.116279,9267.162791,714.1860465,187.1162791,2495.534884,8650,1438.953488,648.0465116,3436.883721,363.8372093,733.5348837,43,8.245848955,6.787791979,0.567785057,0.977272727,0.671875,-0.727235857
+3472,39356.82051,1057.435897,654.474359,1138.038462,33890.44872,756.0769231,811.8076923,1668.269231,19874.61538,582.0512821,711.6666667,1777.705128,26166.76923,1371.538462,5375.615385,3548.538462,9012.794872,1575.858974,327.0384615,2389.230769,19162.52564,481.6282051,430.6923077,538.6538462,23704.30769,830.1025641,133.4871795,3880.987179,18042.05128,1558.115385,879.8205128,2826.371795,15876.69231,716.474359,308.3717949,1996.474359,11573.62821,1099.448718,458.1410256,1326.910256,8628.346154,730.5897436,178.0769231,3788.910256,7931.910256,1438.589744,392.9230769,3386.371795,552.1025641,735.974359,78,14.2060604,7.321117526,0.856978771,0.951219512,0.5,-0.830599592
+3473,23926.09565,961.1652174,607.0869565,1074.452174,20837.91304,711.4521739,537.7826087,1538.278261,12320.89565,754.6956522,480.0434783,1739.521739,16601.31304,1313.721739,6668.791304,3081.165217,5680.278261,1527.547826,396.5913043,2344.747826,12322.6087,699.226087,619.0434783,596.2956522,15387.61739,508.7826087,118.3217391,2366.304348,11640.94783,1912.826087,639.8608696,2780.052174,10183.4,868.0608696,264.1391304,1604.043478,7767.33913,984.4869565,392.8782609,1334.669565,5688.913043,737.3913043,158.0869565,3806.234783,5314.330435,1307.756522,174.9565217,3326.095652,748.2956522,735.0347826,115,13.25383069,11.27196442,0.526026112,0.950413223,0.737179487,1.270153879
+3474,40584.66837,879.0714286,501.0918367,1089.265306,35010.97959,716.8061224,725.1632653,1694.020408,19756.97449,528.6122449,2650.362245,1853.882653,26457.60204,1266.392857,3767.97449,4040.469388,9723.897959,1331.454082,324.7602041,2482.341837,19586.55102,432.3367347,150.9132653,1763.117347,24274.94898,996.4132653,278.0612245,2151.658163,18918.2602,2186.015306,478.2040816,2809.142857,16312.63265,664.5765306,287.1377551,1302.352041,11567.81122,1804.653061,431.2908163,1303.489796,7657.454082,630.1938776,163.9438776,2798.678571,7241.30102,1312.341837,437.9591837,3281.989796,914.9489796,739.6785714,196,19.33469797,13.40976073,0.720399483,0.907407407,0.653333333,0.157778594
+3475,30880.73913,791.2,481.9478261,1067.182609,27111.47826,660.5652174,695.6608696,1626.46087,14925.66957,493.826087,2258.53913,1855.2,20189.21739,1167.495652,4016.086957,3835.478261,7602.808696,1248.217391,311.0956522,2726.730435,15037.05217,410.7826087,255.1652174,2452.234783,18251.17391,815.5565217,121.7391304,2441.6,14321.29565,2201.556522,523.4956522,2832.417391,12126.82609,838.2521739,264.0521739,1224.852174,8685.556522,1453.4,401.8347826,1309.652174,5390.365217,626.6956522,165.4,4361.704348,5255.93913,1228.46087,863.5826087,3101.713043,959.1391304,736.0173913,115,13.05941808,11.27627753,0.504418312,0.966386555,0.680473373,-1.456698941
+3476,35111.8617,865.5904255,551.7978723,1072.840426,30825.81915,689.212766,672.6276596,1615.808511,16742.1117,511.6808511,1718.37234,1744.12766,22628.30851,1228.180851,5445.941489,3670.574468,8648.452128,1269.531915,314.5159574,2409.962766,16927.6117,416.0478723,259.4042553,1665.638298,21180.02128,460.9042553,168.7819149,2252.765957,16646.20745,2038.590426,569.0744681,2822.835106,13982.94681,596.7340426,275.7978723,1101.856383,9871.074468,1513.468085,406.9255319,1306.654255,6071.547872,631.3457447,166.4734043,3516.712766,5913.058511,1241.324468,343.8297872,3225.68617,974.037234,738.7393617,188,18.81099263,12.83343413,0.731137098,0.94,0.652777778,0.745878417
+3477,33065.30337,918.8988764,610.741573,1119.505618,26669.13483,688.9550562,611.7865169,1572.269663,14836.88764,543.9325843,908.505618,1789.449438,18513.26966,1243.022472,7945.977528,5225.94382,7005.651685,1331.078652,311.4719101,2489.449438,14865.50562,410.7078652,926.6292135,652.8426966,17708.7191,399.988764,132.3033708,5837.157303,13456.19101,1860.696629,766.9775281,2811.685393,12059.62921,600.7752809,293.3483146,1650.078652,8586,1011.752809,438.752809,1332.382022,6613.438202,831.6966292,167.8988764,4960.044944,5985.078652,1337.078652,226.3146067,3358.898876,347.3820225,736.3033708,89,12.05740304,10.25638603,0.525765144,0.87254902,0.622377622,-1.28580105
+3478,18601.83582,1297.746269,585.7761194,1060.507463,19556.8209,840.6716418,1007.432836,1457.507463,8928.58209,654.9552239,1389.761194,1764.19403,10868.47761,1319.119403,2923.41791,2365.447761,3729.164179,1271.731343,288.4925373,2372.970149,9394.134328,383.7014925,404.8208955,1152.522388,10217.98507,430.8955224,357.9104478,1734.104478,7017.402985,1856.597015,550.3731343,2814.731343,6520.61194,561.4029851,253.5373134,1317.402985,4560.19403,914.880597,390.5074627,1321.358209,3978.074627,695.5970149,156.6268657,2055.41791,3106.791045,1173.38806,203.4776119,3492.895522,463.6865672,734.761194,67,12.66191359,9.000696907,0.703345586,0.72826087,0.435064935,-1.32966669
+3479,38865.38971,1020.941176,575.7573529,1126.080882,34632.47059,777.8602941,756.1544118,1631.419118,19584.47794,609.3088235,1155.397059,1786.808824,25486.15441,1411.786765,4061.705882,4013.661765,8788.066176,1457.852941,346.0294118,2400.095588,19130.80882,498.8970588,634.9852941,754.1764706,23322.69853,1412.095588,131.7867647,2401.683824,17607.22059,1585.433824,777.9926471,2809.007353,15711.11029,891.9411765,315.9338235,1853.397059,11454.22794,1310.669118,460.125,1341.507353,8777.816176,779.6617647,179.4044118,3190.433824,7611.198529,1418.639706,840.9926471,3392.955882,539.2426471,738.4705882,136,18.79590054,9.809629391,0.853005085,0.925170068,0.53968254,-0.969168099
+3480,31193.56311,833.7572816,693.0873786,1103.941748,28118.30097,669.9417476,920.7184466,1598.330097,15345.51456,539.0097087,814.3980583,1760.951456,20667.51456,1238.194175,3855.087379,2514.291262,7272.961165,1380.262136,330.5145631,2481.135922,15946.43689,1030.76699,337.0582524,655.5728155,19642.95146,990.8543689,112.038835,1327.135922,14190.42718,1530.805825,619.7961165,2782.708738,12468.62136,750.223301,269.6699029,1319.932039,9430.893204,1143.524272,402.2621359,1314.601942,7092.796117,670.1553398,156.631068,2703.718447,6424.048544,1296.932039,154.7961165,3347.106796,652.7087379,737.0970874,103,13.79595338,9.598160348,0.718310296,0.962616822,0.66025641,-0.782418809
+3481,31436.67692,956.8846154,541.9076923,1076.115385,27421.47692,698.8615385,579.0692308,1531.130769,15555.16923,542.5461538,821.8615385,1756.1,20695.92308,1319.284615,4129.915385,3685.884615,6887.369231,1487.146154,391.9461538,2404.815385,15660.30769,552.2076923,139.1,882.8769231,19242.89231,457.9461538,116.9384615,4104.415385,14396.2,1640.315385,687.6923077,2792.153846,12565.96923,612.7153846,270.0846154,1867.861538,9211.884615,1236.969231,395.4,1311.438462,6829.869231,625.3307692,155.4230769,2792.123077,6254.446154,1318.138462,590.8846154,3265.523077,697.8461538,737.2923077,130,15.33323999,11.35475971,0.672020751,0.909090909,0.666666667,-0.353454313
+3482,23342.80909,779.5,478.5090909,1053.427273,20977.31818,633.5818182,668.4,1474.336364,11934.9,542.4636364,1088.854545,1702.645455,16071.28182,1176.909091,3242.572727,3348.518182,5759.118182,1265.227273,306.7181818,2435.681818,11564.12727,429.6454545,546.0272727,523.2363636,14422.22727,503.5181818,119.9090909,1315.990909,11028.55455,1495.281818,584.7727273,2780.409091,9492.990909,759.1818182,258.4545455,1482.9,7032.918182,977.2090909,396,1314.563636,4796.509091,793.0090909,157.1545455,2890.081818,4553.309091,1256.981818,1068.181818,3161.836364,868.9363636,737.2818182,110,12.29258916,11.68030144,0.31166972,0.94017094,0.763888889,-1.213991517
+3483,44446.26957,1138.817391,579.7652174,1135.695652,39615.88696,854.973913,762.6782609,1846.869565,22334.73043,663.6347826,947,1849.191304,27029.49565,1459.982609,5166.269565,4345.226087,9919.226087,1500.608696,371.0695652,2415.113043,20977.10435,466.5304348,339.2869565,974.6434783,24502.54783,636.3826087,144.3565217,4131.756522,18930.22609,1867.226087,525.3652174,2821.817391,16755.66087,656.3304348,333.1565217,2036.321739,11256.38261,1363.965217,480.0434783,1342.626087,8248.069565,757.6695652,191.3565217,6287.973913,7243.878261,1455.678261,188.2956522,3438.565217,300.026087,737.4956522,115,12.81832945,11.53712816,0.435788136,0.950413223,0.798611111,-0.839395202
+3484,23401.70476,860.6190476,537.8761905,1075.895238,20009.68571,682.0190476,969.7238095,1556.095238,11710.19048,537.9142857,1148.619048,1905.2,15232.06667,1259.238095,3516.847619,3212.371429,5336.952381,3087.819048,311.2666667,2387.428571,11715.47619,430.1333333,529.7333333,1211.371429,13839.51429,436.4095238,119.1428571,1641.180952,10667.58095,1835.552381,601.7428571,2810.92381,9424.419048,999.2285714,281.1619048,1613.409524,6955.552381,1213.857143,435.7809524,1333.295238,5299.028571,750.9619048,174.2952381,5857.990476,4856.266667,1339.980952,183.9714286,3243.809524,570.5428571,737.9904762,105,12.49931276,10.98410794,0.477232724,0.945945946,0.625,0.45059468
+3485,26306.24706,835.9764706,682.8470588,1127.458824,24044.8,670.2470588,699.9882353,1607.941176,13092.90588,502.1411765,1099.611765,1782.270588,17760.15294,1237.058824,2624.976471,2805.011765,6329.423529,1303.023529,303.2470588,2570.270588,13240.03529,413.2705882,126.9294118,464.3294118,16133.68235,441.4,115.6588235,1836.105882,12223.70588,1563.082353,510.5294118,2790.047059,10448.25882,655.4588235,267.0705882,1755.364706,7961.152941,916.1058824,412.2352941,1321.011765,5730.458824,605.2235294,159.5411765,2258.588235,5187.023529,1309.282353,173.0823529,3239.141176,814.3764706,737.3529412,85,12.14341295,9.16227859,0.656293085,0.923913043,0.594405594,1.341436171
+3486,43695.14634,931.5609756,508,1134.682927,38992.09756,737.4634146,627.6829268,1617.414634,22993.4878,578.5121951,534.9268293,1738.219512,27994.7561,1378.414634,6171.170732,3066.658537,10329.19512,1467.439024,358.8536585,2344.02439,22209.7561,453.1219512,411.5365854,470.9512195,26746.29268,425.804878,138.2926829,3197.682927,20647.4878,1694.780488,679.6341463,2830.731707,18361.36585,664.1707317,333.2682927,1580.804878,13008.65854,972.195122,480.4390244,1304.878049,9723.121951,730.3902439,182.3414634,2085.292683,9063.146341,1495.902439,812.0487805,3310.097561,356.6829268,736.2195122,41,8.024342213,6.578691096,0.572590112,0.931818182,0.732142857,-0.192262555
+3487,27123.74194,841.6451613,582.5483871,1064.137097,24833.54032,719.8548387,804.4516129,1530.427419,13625.52419,537.8306452,1479.233871,1790.137097,17923.08871,1245.362903,4226.491935,3432.056452,6346.612903,1360.5,314.1129032,2490.572581,13732.3871,409.9758065,658.9193548,1069.548387,16512.10484,441.9758065,523.2580645,1431.620968,12193.98387,2064.354839,921.5967742,2811.233871,10869.08871,676.516129,270.8306452,1527.677419,8133.870968,1365.016129,426.5403226,1369.451613,6370.733871,805.7016129,171.6048387,5686.274194,5665.258065,1355.806452,918.0403226,3279.169355,514.1370968,740.6129032,124,14.7585535,11.29100826,0.643972741,0.911764706,0.59047619,-0.489302477
+3488,27788.51429,848.6428571,520.9857143,1079.15,24780.98571,742.3785714,776.7071429,1673.85,13779.28571,516.0714286,1505.314286,1830.878571,18644.95714,1252.014286,4877.521429,2483.1,6800,1316.085714,326.9857143,2374.871429,13516.87143,2973.992857,225.6142857,1621.835714,16645.57143,501.7571429,819.3214286,1860.185714,12626.4,2292.064286,646.4857143,2785.914286,11100.75714,652.9857143,283.4785714,1352.778571,7979.764286,1175.657143,423.55,1304.228571,5478.971429,650.8285714,165.0928571,4545.557143,5083.171429,1325.571429,321.0857143,3231.264286,882.0357143,738.9,140,14.7643422,12.76623078,0.502346492,0.933333333,0.666666667,1.261650576
+3489,48002.23256,1063.139535,606.372093,1158.813953,42054.76744,836.1860465,859.9534884,1716.790698,24931.2093,649.9302326,1123.813953,1834.790698,31601.65116,1502.116279,2933.27907,4011.883721,10984.69767,1563.27907,372.4883721,2386.767442,23900.25581,493.6511628,308.1860465,790.4651163,28777.37209,496.5581395,153.4418605,4106.44186,22571.44186,1932.372093,867.3488372,2814.813953,20130.13953,681.2790698,349.372093,1719.186047,14408.37209,1204.604651,509,1334.767442,10849.09302,755.9534884,184.8837209,2812.302326,9965.093023,1578.116279,168.5581395,3450.139535,456.627907,738.5116279,43,8.771586308,6.398037362,0.684082308,0.977272727,0.614285714,-0.018750224
+3490,27841.85057,852.3218391,536.1149425,1080.137931,25048.96552,697.1724138,552.4827586,1632.597701,12762.82759,503.7701149,984.954023,1763.712644,18180.41379,1250.574713,3300.045977,2454.241379,6717.896552,1257.344828,321.0114943,2361.183908,13384.25287,421.0229885,358.2988506,908.137931,16780.71264,534.3448276,146.9770115,2354.114943,12686.57471,1672.413793,495.6436782,2823.689655,11074.89655,903.4482759,278.7471264,1312.850575,8018.471264,985.5402299,415.2758621,1320.137931,5539.091954,668.6666667,169.4942529,3019.114943,5077.08046,1320.195402,1508.735632,3135.712644,903.2758621,739.137931,87,11.46043439,11.22848942,0.200169705,0.820754717,0.659090909,1.403823791
+3491,32108.61842,986.0986842,556.5065789,1099.282895,22343.51974,665.6644737,747.2236842,1606.355263,11093.53947,500.1973684,1902.875,1796.907895,15725.24342,1163.730263,6394.381579,3484.217105,5922.677632,1186.796053,291.4144737,2826.125,11444,378.2565789,230.3157895,1721.092105,14142.20395,425.2697368,124.4013158,1409.375,11008,2546.328947,452.1776316,2791.157895,9052.085526,604.4473684,244.8421053,973.8026316,6429.348684,1422.901316,379.7236842,1289.434211,3835.736842,576.1710526,149.5328947,2600.585526,3684.875,1120.552632,844.6447368,3304.618421,1005.427632,741.4605263,152,14.7779841,13.1880064,0.451227359,0.955974843,0.678571429,0.161562323
+3492,40976.0495,1050.366337,578.8910891,1127.425743,37269.67327,835.1386139,791.3564356,1765.663366,21114.79208,638.2376238,1405.930693,1822.752475,25964.90099,1441.029703,6511.910891,3892.425743,8895.683168,1435.445545,356.5049505,2393.623762,19188.53465,467.7920792,381.1485149,998.1881188,22361.44554,476.9108911,405.8316832,3847.039604,17560.30693,2003.029703,572.2079208,2844.891089,15618.91089,662.7326733,316.7524752,1798.376238,10666.9505,1242.227723,456.4356436,1323.871287,8094.831683,713.4752475,179.3267327,3314.80198,6923.257426,1429.722772,608.8613861,3506.277228,367.4158416,742.009901,101,12.4920004,10.59391688,0.529906488,0.901785714,0.601190476,0.016575832
+3493,30997.86873,953.8223938,596.2548263,1181.57529,28921.85714,780.9150579,726.4054054,1745.359073,16161.23552,575.8648649,714.8223938,1780.239382,20057.36293,1378.11583,3927.177606,3398.733591,7317.706564,1895.934363,349.2084942,2439.046332,15884.46718,667.8146718,1471.706564,622.5598456,19041.97683,499.2934363,136.3552124,3235.57529,14494.06564,1710.552124,611.8648649,2890.72973,12890.51737,962.7413127,317.1389961,1878.208494,9489.745174,966.6795367,471.3243243,1384.092664,7205.795367,1092.46332,185.3050193,4715.725869,6285.440154,1507.706564,1346.72973,3291.888031,437.5250965,742.7876448,259,21.70385382,15.53507482,0.698331028,0.938405797,0.685185185,-1.105490753
+3494,38349.37313,1131.208955,583.5820896,1147.746269,34753.61194,837.4626866,905.9402985,1694.61194,19631,635.0895522,1476.925373,1840.462687,24770.76119,1429.343284,2221.432836,2632.776119,8429.059701,1922.61194,346.5671642,2423.597015,19734.95522,471.8955224,805,1037.761194,23462.83582,510.9552239,755.1791045,2050.686567,17556.34328,2059.746269,580.8955224,3019.432836,15689.43284,679.4776119,334.1791045,1626.014925,11481.56716,1121.19403,478.6567164,1343.567164,8839.671642,871.3731343,184.5373134,4077.522388,7760.58209,1444.223881,305.7164179,3430.253731,469.2985075,739.3134328,67,12.70829876,7.117989337,0.828421218,0.893333333,0.62037037,-1.165202602
+3495,35691.47651,928.6644295,528,1094.020134,32673.88591,752.3489933,673.704698,1580.268456,17771.63087,570.8187919,836.0805369,1727.275168,23125.44295,1376.832215,2053.57047,2737.087248,8601.785235,1553.060403,351.409396,2394.442953,18272.4094,440.9261745,666.557047,678.0805369,21970.63087,552.6711409,138.590604,1475.409396,16203.26174,1654.120805,578.1073826,2837.281879,14471.66443,754.2080537,315.8993289,1575.436242,10805.24832,1182.409396,461.5167785,1341.181208,8482.288591,812.0134228,181.147651,2459.342282,7390.120805,1481.758389,1262.295302,3198.040268,481.3489933,741.9530201,149,15.01465377,12.92254715,0.509176124,0.93125,0.665178571,-0.550072707
+3496,24652.33628,942.3761062,609.9513274,1105.331858,21467.72124,689.6460177,551.0840708,1599.986726,12191.28319,548.1371681,912.0044248,1831.265487,15984.13274,1248.707965,3607.685841,2553.530973,5705.659292,1935.278761,311.039823,2426.827434,12011.72566,429.5221239,1386.40708,692.1415929,14642.97345,473.0619469,131.5929204,1864.482301,11051.51327,1763.115044,715.039823,2837.911504,9730.668142,780.6769912,276.4247788,1703.053097,7184.831858,1167.982301,420.5,1358.982301,5407.442478,1000.106195,169.6681416,6092.743363,4952.283186,1313.504425,215.4557522,3300.442478,559.0309735,744.3982301,226,18.73412568,16.67922673,0.455349984,0.872586873,0.538095238,-0.862867826
+3497,15917.44898,925.244898,1417.408163,1158.77551,15891.02041,720.0816327,994.8163265,1725.877551,7626,542.4489796,2205.44898,1864.326531,11591.42857,1277.714286,3011.387755,4411.408163,4247.877551,1346.55102,285.2244898,3109.081633,8625.77551,528.7142857,274.4897959,1215.469388,9973.897959,1309.306122,127.877551,1739,7479.122449,2290.510204,544.3469388,2797.591837,6823.591837,808.0408163,258.0204082,1760.163265,5104.142857,1589.387755,402.4897959,1372.897959,4209.653061,656.755102,148.5306122,4129.285714,3649.204082,1308.612245,463.8571429,3449.102041,628.3877551,740.8979592,49,13.95366464,4.636646608,0.943177686,0.844827586,0.408333333,-0.589186412
+3498,39066.5625,881.03125,641.015625,1105.65625,33189.01563,714.984375,888.984375,1637.109375,20054.01563,561.015625,1421.953125,1747.40625,25733.90625,1312.09375,2878.609375,2940.828125,8954.203125,1403.265625,340.125,2659.109375,19350.125,421.109375,166.765625,563.921875,23235.20313,596,129.5625,1581.78125,18047.875,1855.421875,550.40625,2776,15913.53125,677.859375,282.59375,1581.390625,11831.89063,1261.9375,433.859375,1311.078125,8425.734375,635.59375,162.546875,2725.453125,7854.109375,1395.625,241.609375,3269.34375,768.046875,738.703125,64,11.74691077,7.145962142,0.793686556,0.927536232,0.592592593,0.963884105
+3499,31037.32065,824.4456522,587.548913,1089.119565,27995.41848,671.6195652,588.0869565,1587.434783,15406.86957,517.4293478,715.5380435,1767.847826,20431.41304,1242.027174,3789.826087,2823.608696,7234.217391,1407.032609,344.4565217,2386.809783,15700.33152,7243.483696,423.2119565,653.2445652,19380.79348,504.2554348,131.8586957,1997.695652,14262.04891,1783.728261,666.8423913,2819.766304,12487.76087,737.6413043,267.1141304,1409.494565,9245.581522,1286.146739,384.2826087,1293.603261,6973.875,725.9565217,151.2608696,3029.673913,6322.054348,1281.630435,167.9130435,3239.88587,660.9728261,744.0054348,184,20.07199669,12.52712051,0.781337019,0.855813953,0.605263158,-0.795274997
+3500,36857.15464,849.2371134,618.6597938,1083.041237,32349.24742,690.5876289,537.3814433,1536.319588,19433.62887,655.8247423,917.2164948,1726.773196,25241.04124,1307.123711,2190.216495,3570.154639,8240.731959,1622.886598,433.6597938,2356.103093,18670.20619,429.556701,456.8247423,1123.247423,23647.59794,559.5670103,146.9793814,1635.938144,17950.24742,1654.618557,572.9175258,2785.556701,15621.70103,741.8247423,286.0824742,1465.793814,11670.25773,1313.175258,422.0309278,1327.989691,8496.927835,725.5773196,160.185567,2653.628866,7922.649485,1382.71134,274.9072165,3170.876289,734.5154639,741.2783505,97,13.53322674,9.553972306,0.708247614,0.923809524,0.621794872,-1.037160361
+3501,26877.72832,851.4566474,668.6184971,1103.271676,23054.95954,690.3641618,796.9884393,1594.16763,13450.24277,518.583815,1295.028902,1782.179191,17388.71098,1246.364162,2745.549133,2290.549133,6080.508671,1404.728324,352.9248555,2442.508671,13233.56069,464.2427746,108.4797688,1132.132948,15988.98266,877.9768786,265.5433526,1759.936416,12179.80925,1565.213873,556.6300578,2801.219653,10700.11561,667.0404624,273.9306358,1820.028902,7905.901734,966.4797688,406.3526012,1312.65896,5803.976879,593.6820809,159.3699422,4053.225434,5314.537572,1301.768786,190.3236994,3266.739884,763.3988439,744.9942197,173,23.22532035,9.85463752,0.905518973,0.887179487,0.480555556,0.888640309
+3502,27502.40952,991.8095238,1181.095238,1277.114286,24778.64762,769.3142857,1156.542857,1960.161905,14260.87619,567.752381,689.6761905,1913.657143,18514.28571,1373.447619,921.0666667,1126.619048,6686.542857,1469.409524,341.7047619,2539.752381,13815.99048,499.952381,171.0571429,552.9047619,17235.06667,558.3047619,136.6,886.5809524,13329.64762,1602.104762,466.6380952,2824.914286,11467.37143,1167.447619,300.7047619,2050.87619,8567.771429,897.4,460.2095238,1359.352381,5879.085714,644.647619,171.4190476,1172.685714,5601.895238,1439.571429,148.6380952,3426.114286,844.5047619,741.847619,105,13.88935377,10.14793755,0.682776768,0.921052632,0.621301775,-0.674948754
+3503,32469.07317,880.6341463,883.0121951,1133.560976,29166.7561,706.695122,880.0731707,1713.463415,16239.45122,527.8902439,1564.902439,1793.280488,21491.92683,1287.792683,2248.097561,2551.987805,7453.878049,1358.060976,313.597561,2666.963415,16317.71951,941.8292683,151.4634146,769.8780488,20132.93902,474.8170732,151.2073171,881.304878,14862.93902,1775.756098,653.5,2806.487805,13039.62195,812.8292683,285.304878,1468.914634,9763.914634,1383.963415,422.3414634,1311.45122,7359.841463,632,165.097561,2459.414634,6706.560976,1359.707317,316.7926829,3314.182927,636.7926829,742.8536585,82,12.5130826,8.602452027,0.726206489,0.931818182,0.573426573,0.686974477
+3504,32847.20769,896.7461538,546.3923077,1112.661538,29798.26154,728.5769231,743.3538462,1639.561538,16483.85385,569.0461538,1171.584615,1758.338462,21919.14615,1327.853846,6441.238462,4277.7,7693.692308,1570.761538,395.0076923,2515.723077,16857.93846,530.2692308,223.9,897.4076923,20843.87692,647.2769231,121.7692308,2892.384615,15384.23077,2127.830769,616.2384615,2787,13618.69231,655.7615385,279.8461538,1611.930769,9959.707692,1782.261538,410.3461538,1293.838462,7412.138462,836.7538462,159.3769231,3189.130769,6811.592308,1386.4,278.6153846,3233.238462,671.8076923,745.7153846,130,19.93209248,9.044804813,0.89111324,0.82278481,0.601851852,-0.223115984
+3505,18809.2454,967.5705521,577.5460123,1056.220859,17015.68098,705.4846626,767.208589,1502.748466,9632.079755,544.392638,1248.312883,1742.239264,12460.58896,1285.723926,3161.306748,2509.460123,4435.190184,1465.055215,391.4969325,2784.386503,9198.90184,422.0920245,113.6257669,1166.447853,11650.80982,458.2147239,137.4785276,1263.601227,8769.417178,2194.717791,545.2699387,2784.233129,7697.98773,638.1717791,252.7300613,1417.993865,5647.226994,1229.834356,391.8159509,1314.435583,4273.190184,585.9263804,154.7239264,1777.546012,3873.030675,1258.220859,430.1472393,3295.134969,718.0184049,744.5153374,163,17.5467492,12.19491312,0.719014009,0.953216374,0.603703704,0.523961173
+3506,40449.22105,834.9578947,477.7157895,1073.873684,35299.17895,695.0736842,816.8631579,1594.936842,20693.67368,528.9473684,1579.915789,1781.652632,26845.70526,1270.252632,2679.515789,2528.747368,9793.231579,1335.305263,318.7157895,2731.694737,20500.14737,410.7368421,148.9157895,607.3052632,24888.53684,433.7263158,131.2947368,1844.210526,19091.54737,1818.515789,485.7894737,2793.863158,16609.49474,660.6842105,281.4842105,1453.652632,12467.25263,1066.421053,426.6947368,1294.242105,8554.484211,646.8526316,161.5368421,2421.463158,8010.905263,1355.884211,239.7263158,3264.084211,809.4736842,745.2421053,95,18.03330761,7.767567679,0.902478694,0.778688525,0.465686275,0.388306836
+3507,36919.00556,858.4333333,550.3111111,1097.161111,31133.73333,696.2444444,557.5888889,1744.9,16502.12222,508.7888889,1452.144444,1784.427778,22586.67778,1216.033333,7155.355556,3279.277778,8485.116667,1271.05,326.3444444,2541.4,16894.06111,411.2888889,796.2666667,1306.194444,20895.37222,468.5611111,320.5777778,2507.905556,16293.36667,2174.005556,657.0222222,2835.427778,13668.32778,673.2,276.55,1159.516667,9482.1,1495.272222,415.1166667,1317.277778,5757.316667,727.9166667,163.5888889,5069.372222,5587.866667,1257.711111,782.1055556,3286.055556,987.7888889,744.8277778,180,20.31797606,11.97557584,0.807835573,0.882352941,0.557275542,-0.927585422
+3508,38600.54032,1018.528226,619.1572581,1124.810484,33249.92339,804.0040323,1021.495968,1702.399194,19409.87903,608.4798387,1814.548387,1829.471774,24977.31855,1430.040323,4086.971774,4385.294355,8751.649194,1592.737903,330.4395161,2491.245968,19112.91532,511.4596774,275.7137097,1218.008065,23193.6129,477.0887097,154.4637097,2065.818548,17506.52016,2404.141129,623.108871,2815.947581,15489.21371,710.1209677,318.2217742,1480.270161,11304.72581,1253.479839,460.4475806,1340.596774,8697.459677,694.7298387,173.7540323,2639.649194,7690.576613,1449.854839,196.1814516,3371.766129,579.2459677,750.5604839,248,22.19390555,14.41831795,0.760231618,0.942965779,0.645833333,0.106365011
+3509,38599.33092,872.7463768,548.5169082,1114.978261,35384.28986,711.7318841,955.0942029,1762.657005,17708.2029,515.5241546,2187.628019,1832.676329,24913.81643,1241.26087,6086.060386,3225.103865,9225.128019,1320.644928,321.9202899,2862.374396,18597.87681,448.6859903,495.1231884,1694.681159,23487.61111,512.9879227,234.647343,1347.060386,17819.24155,2709.896135,567.8164251,2824.28744,14403.70048,685.8067633,284.6376812,1019.806763,10042.44444,1670.115942,414.2487923,1307.096618,5764.070048,697.2874396,158.2874396,3359.497585,5691.147343,1254.074879,493.6183575,3291.347826,1019.277778,751.6666667,414,28.04385003,20.17648424,0.694531814,0.867924528,0.638888889,0.469273394
+3510,19408.77778,1073.305556,848.5138889,1133.944444,18366.93056,635.0138889,720.7083333,1647.916667,9398.319444,525.8333333,1350.527778,1852.680556,12335.125,1211.041667,10767.58333,5247.958333,5002.75,1279.180556,314.5277778,3248.916667,10526.61111,472.2638889,275.4583333,1037.083333,12008.69444,436.8888889,139.8611111,5399.75,8820.361111,2193.902778,563.0694444,2796.263889,8226.763889,705.5555556,261.5694444,1965.819444,5912.208333,1449.569444,429.9027778,1319.194444,4759.375,647.625,175.3194444,5793.013889,3961.5,1320.5,1359.430556,3370.291667,356.125,743.875,72,13.52916698,7.718338677,0.821300224,0.818181818,0.6,-1.142590862
+3511,32753.26531,871.2108844,646.5034014,1113.278912,30999.94558,732.4081633,814.0204082,1634.496599,17268.66667,549.2312925,1185.517007,1768.265306,22468.90476,1318.163265,3034.346939,2496.183673,8118.006803,1356.102041,325.7959184,2501.632653,16361.89116,428.8911565,170.2585034,1016.734694,20053.46939,452.5034014,173.4353741,2471.408163,15055.88435,1846.714286,498.3945578,2825.136054,13126.05442,666.9251701,282.5510204,1618.07483,9789.62585,1055.455782,415.6190476,1302.591837,7035.068027,646.0748299,167.8979592,3514.598639,6486.809524,1370.945578,275.2108844,3249.278912,801.4693878,748.8571429,147,17.140145,11.71761394,0.729823483,0.875,0.628205128,0.059862169
+3512,22188.37594,983.7894737,869.7894737,1094.661654,19905.90226,718.3984962,1056.661654,1606.315789,11297.76692,661.8120301,1058.097744,1791.285714,15542.78195,1253.015038,2593.406015,2368.947368,5646.383459,1284.578947,311.3383459,2693.323308,11224.3609,408.075188,486.5413534,819.2406015,14300.84962,1364.466165,120.9022556,1301.729323,10881.85714,1572.120301,453.924812,2797.984962,9283.37594,962.2180451,271.8571429,1487.218045,7090.06015,1172.533835,403.924812,1398.924812,4882.323308,706.2030075,158.5037594,2604.488722,4607.842105,1244.293233,325.3984962,3375.887218,854.0977444,745.8646617,133,14.87872116,11.50927643,0.633748263,0.95,0.682051282,-0.465014871
+3513,44648.96923,1012.938462,602.6615385,1140,41642.23077,818.8923077,875.4,1676.215385,23914.56923,632.4,2512.830769,1872.261538,29678.50769,1497.369231,4318.015385,5299.723077,10635.52308,1575,374.1076923,2468.107692,23212.95385,731.2461538,226.0461538,1882.861538,27952.38462,505.0461538,150.0923077,2623.030769,21572.87692,2515.015385,668.4461538,2813.8,19228.03077,1870.292308,354.9692308,1671.753846,14258,1780.923077,511.4307692,1358.169231,10576.84615,710.3076923,195.1692308,2903.461538,9592.076923,1596.153846,207.5076923,3358.676923,451.2769231,744.8153846,65,10.4679295,8.2371199,0.617091967,0.902777778,0.590909091,-0.141555815
+3514,28012.76147,895.7568807,594.3577982,1091.389908,24179.29817,745.206422,1159.045872,1571.880734,13724.55963,528.2614679,2178.105505,1903.715596,17817.18807,1223.711009,3685.279817,4485.330275,6452.779817,1272.307339,296.3944954,2719.830275,13425.05963,405.8899083,110.266055,1315.614679,16503.22936,991.4770642,386.4036697,1295.853211,12393.97706,2054.266055,490.440367,2789.041284,10926.90367,621.0091743,263.1513761,1362.720183,7978.96789,1314.752294,402.3119266,1315.761468,5833.288991,589.3623853,154.3348624,2555.37156,5357.256881,1271.298165,329.0366972,3305.266055,786.6880734,749.4082569,218,20.02353022,14.77568699,0.674892367,0.927659574,0.637426901,0.875941695
+3515,26564.31387,981.1094891,917.1313869,1229.029197,23384.88321,776.540146,1137.532847,1912.007299,12660.29927,554.2919708,1016.175182,1856.759124,17166.90511,1339.394161,3001.905109,2224.992701,6061.291971,1403.839416,326.1021898,2413.233577,12213.64234,473.6861314,131.6423358,940.189781,14893.33577,551.2408759,132.2262774,1637.649635,11602.56204,1929.189781,474.4452555,2840.875912,9945.277372,704.5547445,288.7737226,1361.963504,6976.131387,1004.072993,425.9635036,1310.043796,4615.189781,612.5693431,161.189781,2623.452555,4241.70073,1339.021898,382.3138686,3341.489051,927.9635036,746.3941606,137,13.97376666,12.70239427,0.416758594,0.951388889,0.752747253,-0.468669711
+3516,36083.22222,934.2936508,606.6904762,1118.293651,33341.03175,798.8095238,918.6904762,1730.706349,19091.98413,593.8095238,1474.515873,1913.111111,23711.92063,1335.047619,6938.261905,5943.404762,8536.857143,1444.111111,348.8333333,2517.722222,18627.85714,434.2698413,981.8174603,1045.293651,21893.53175,475.5555556,712.7539683,4387.365079,17453.10317,1937.873016,621.3730159,2818.626984,15298.34127,678.7698413,320.7063492,1697.420635,10474.03175,1148.531746,461.1666667,1332.785714,7856.269841,869.4126984,182.3174603,5857.547619,7265.539683,1455.420635,764.2380952,3358.873016,330.015873,748.1507937,126,19.56946403,8.831849188,0.892368415,0.834437086,0.494117647,-1.03408367
+3517,35791.37931,1021.735632,597.5172414,1125.643678,31730.12644,804.1034483,778.5172414,1752.735632,18214.1954,624.9770115,814.8735632,1866.367816,22443.77011,1403.057471,6497.034483,4630.275862,7800.83908,1474.402299,375.2413793,2757.643678,17303.56322,479.7241379,317.2068966,713.1609195,19935.4023,460.2413793,137.9425287,4356.62069,16354.13793,1947.045977,546.6551724,2832.643678,14345.09195,838.137931,333.2413793,1720.195402,9774.287356,1020.034483,468.3908046,1331.333333,7245.735632,777.0344828,188.0229885,5085.965517,6774.770115,1477.816092,1110.655172,3345.735632,344.7816092,745.6896552,87,12.62015944,9.051060347,0.696877013,0.925531915,0.659090909,-0.957890009
+3518,42316.67797,1013.016949,498.8983051,1099.237288,37053.25424,767.0338983,695.6101695,1634.305085,20959.62712,591.220339,539.4237288,1758.661017,28132.32203,1351.949153,3786.305085,2615.288136,9238.59322,1528.338983,407.7288136,2355.40678,21431.45763,466.7118644,119.8644068,571.1355932,26084.27119,447.2033898,119.3389831,1874.830508,19353.0678,1521.186441,604,2768,17200.20339,614.3898305,288.5423729,1489.813559,12778.52542,940.779661,399.9322034,1281.20339,9268.949153,647.5423729,152.6779661,1518.118644,8318.59322,1354.016949,306.559322,3306.322034,678.8644068,746.5423729,59,12.2541068,6.458897781,0.84981551,0.983333333,0.567307692,-0.479417122
+3519,35882.39796,866.8112245,500.7704082,1088.076531,29042.90816,687.1479592,555.8979592,1550.494898,16562.80102,505.2346939,1623.831633,1771.719388,22746.15816,1263.066327,4000.454082,2740.403061,8249.056122,1302.755102,316.494898,2365.158163,16612.29592,418.6326531,179.5153061,1618.867347,20641.57143,1055.352041,431.3418367,2147.193878,15909.04082,1820.612245,476.8418367,2804.882653,13894.7551,631.0918367,286.1479592,1224.091837,10088.32143,1108.045918,419.5663265,1302.816327,6751.147959,637.0561224,164.7295918,3427.035714,6420.382653,1337.770408,1702.239796,3162.591837,888.8571429,750.5969388,196,18.80904776,13.74802328,0.682456655,0.91588785,0.6125,-0.269078976
+3520,30769.36957,832.173913,525.4347826,1082.01087,26071.16304,619.5434783,999.326087,1602.467391,12595.16304,455.5543478,2099.326087,1865.369565,17915.33696,1096.76087,9675.228261,4288.978261,6827.934783,1141.858696,279.9456522,2642.956522,13855.25,361.0543478,672.5978261,3037.826087,17155.28261,519.8152174,139.1956522,1752.826087,12960.95652,2979.891304,379.7173913,2798.641304,10405.17391,577.9782609,250.9021739,917.2065217,7076.184783,1425.391304,375.0108696,1283.097826,3817.271739,681.4565217,146.326087,2579.706522,3983.271739,1084.771739,328.6521739,3135.554348,1041.032609,747.1630435,92,14.61684939,8.203455008,0.827658002,0.92,0.681481481,-0.084158406
+3521,35553.8,927.1857143,574.0857143,1108.5,32942.32857,743.5428571,699.1142857,1646.371429,18721.62857,573.6714286,2074.314286,1808.542857,23452.1,1363.371429,4267.571429,3793.4,8589.042857,2150.285714,335.7,2396.2,18499.11429,440.5285714,969.3142857,1360.642857,22430.4,490.1142857,147.5285714,2072.228571,16843.04286,2246.842857,604.9428571,2875.985714,14976.61429,716.5285714,317.6857143,1627.057143,10971.61429,1595.457143,476.8142857,1379.014286,8402.614286,925.0285714,179.7714286,3744.771429,7697.028571,1446.7,206.8857143,3389.957143,460.1,746.8285714,70,10.70949992,8.585160385,0.597807477,0.945945946,0.578512397,-0.88747844
+3522,35822.17568,1068.445946,760.2027027,1121.108108,31547.2973,774.2567568,842.5675676,1670.567568,17640.58108,610.7162162,1133.891892,1754.256757,23186.14865,1432.486486,1666.972973,2055.094595,7866.202703,1358.77027,323.2027027,2471.108108,17376.47297,882.7567568,534.9594595,787.9324324,21065.45946,1245,124.3243243,997.2162162,15943.17568,1750.297297,541.8108108,2822.094595,14094.09459,1053.540541,278,1419.324324,10278.59459,1053.162162,413.1081081,1328.689189,7709.824324,752.2297297,149.9189189,2661.445946,6987.864865,1380.702703,385.3783784,3299.297297,614.472973,746.027027,74,13.31809973,7.083248719,0.846837759,0.973684211,0.616666667,0.984850478
+3523,26785.31897,827.5344828,604.0431034,1087.793103,24210.41379,675.6551724,735.0431034,1608.094828,13692.56034,508.2672414,536.0086207,1757.181034,18836.7069,1236.465517,1504.094828,1273.956897,6857.724138,1293.137931,308.3189655,2368.844828,13923.44828,420.9827586,197.7931034,478.7672414,17131.43966,479.5344828,121.7413793,1297.025862,12837.74138,1449.094828,473.5603448,2877.206897,11099.65517,1245.715517,275.5344828,1621.974138,8390.146552,825.6465517,413.112069,1332.405172,6012.741379,639.5948276,153.3534483,1686.715517,5587.405172,1342.060345,703.4655172,3276.62069,817.7155172,750.6551724,116,18.85418322,8.408430375,0.895047108,0.846715328,0.585858586,-0.209172365
+3524,33800.64029,866.7122302,640.323741,1123.942446,28062.23022,693.8489209,781.6690647,1695.266187,15366.91367,512.9280576,960.2589928,1780.402878,19786.46763,1217.266187,4653.453237,2925.366906,7624.42446,1276.546763,313.8848921,2454.76259,15160.35971,1920.014388,141.5755396,737.057554,19025.08633,741.0719424,127.4388489,2758.201439,14287.10072,1670.388489,526.0791367,2811.338129,12201.64748,615.0071942,276.381295,1820.05036,8723.309353,1063.035971,422.8273381,1298.697842,5563.582734,622.2661871,163.5683453,4510.079137,5380.618705,1290.007194,509.2302158,3319.978417,939.5755396,748.4460432,139,18.52873925,9.959689892,0.843246804,0.891025641,0.579166667,-0.832528761
+3525,35708.92771,826.7650602,482.7710843,1087.343373,31241.96386,670.8253012,883.3915663,1677.560241,17066.43373,555.2289157,2551.903614,1821.644578,23184.10241,1199.012048,5396.614458,4375.108434,8743.825301,1270.915663,318.0843373,3131.740964,17383.12651,440.9337349,492.9156627,1665.192771,21174.9759,1310.710843,131.7228916,2049.042169,16870.21084,1987.728916,473.373494,2791.668675,14098.72289,609.2108434,275.3975904,1158.174699,10002.27108,1864.463855,409.6746988,1338.807229,6234.987952,696.8614458,161,4274.108434,6036.692771,1267.975904,550.1807229,3275.433735,965.3554217,749.1927711,166,19.99197071,11.29321337,0.825167964,0.887700535,0.574394464,1.025074103
+3526,36655.71053,1046.931579,652.6631579,1132.5,18121.23684,514.0473684,291.6105263,1312.1,8769.994737,422.8526316,429.2947368,1685.215789,11916.68421,996.6631579,7479.910526,2685.178947,4320.278947,1027.557895,245.4684211,2287.984211,8896.073684,285.2368421,199.8631579,425.6473684,10433.51053,312.1894737,106.8947368,6412,7692.794737,1283.194737,325.8105263,2805.521053,6532.736842,476.8578947,219.0473684,1084.184211,3183.810526,643.3631579,336.4684211,1262.973684,2407.331579,548.3842105,136.1842105,1991.778947,2258.126316,976.7210526,101.6210526,3092.663158,199.3,751.4894737,190,19.97122421,13.03287378,0.757717577,0.900473934,0.558823529,0.893324409
+3527,39511.8,1109.093333,725.04,1188.8,35342.53333,861.0133333,807.4666667,1940.36,19662.70667,665.4,871.8933333,1768.133333,24416.98667,1543.173333,6271.573333,6356.253333,8766.04,1590.12,399.2666667,2653.133333,19089.98667,518.12,2442.146667,870.9466667,23253.28,576.4933333,162.0533333,6154.826667,17845.10667,2209.92,613.6533333,2821.053333,15788.06667,707.2,346.2133333,2132.706667,10469.78667,1369.253333,504.8533333,1341.32,7853.546667,1349.653333,196.2266667,5958.16,7002.026667,1559.493333,264.5866667,3446.08,300.76,747.1733333,75,13.4261784,7.382101489,0.835277279,0.872093023,0.641025641,-1.259522644
+3528,18374.41935,860.344086,561.0645161,1075.698925,17544.51613,689.7311828,568.8172043,1524.247312,9432.16129,532.8817204,730.5483871,1784.064516,11917.56989,1242.526882,1937.924731,2592.193548,4710.612903,4191.731183,314.3333333,2356.860215,9796.365591,402.8387097,1245.204301,593.5806452,10906.72043,463.344086,148.7311828,1829.741935,8195,1644.215054,573.1935484,2846.064516,7383.354839,842.6774194,280.0860215,1790.494624,5496.548387,959.7419355,430.2043011,1373.634409,4228.086022,1037.021505,168.2903226,5127.268817,3707.139785,1343.344086,440.8924731,3340.451613,467.5913978,749.5698925,93,16.5649495,7.446821316,0.893253703,0.885714286,0.510989011,-0.663042035
+3529,32908.80882,933.6176471,483.8088235,1072.102941,28850.47059,713.3823529,1247.191176,1583.544118,16426.45588,555.2647059,1260.544118,1758.235294,20950.16176,1330.441176,3937.794118,3066.117647,6923.941176,1343.897059,323.4117647,2468.220588,16112.95588,619.6617647,415.1176471,1375.088235,19822.89706,467.3970588,133.5147059,1266.102941,14821.64706,1916.25,547.6617647,2857.735294,13195.98529,703.25,287.9117647,1556.470588,9610.779412,1282.794118,416.5735294,1328.911765,7149,739.0294118,158.3970588,1887.882353,6703.926471,1359.588235,723.8235294,3310,603.4705882,747.7352941,68,11.43392258,7.708734268,0.738550124,0.985507246,0.618181818,-0.781613298
+3530,28150.41803,809.3606557,617.3442623,1076.696721,25500.12295,652.6229508,555.6393443,1556.713115,14325.05738,494.557377,434.6721311,1702.836066,18955.85246,1222.786885,3729.270492,2518.442623,6650.196721,1382.434426,321.6639344,2357.959016,14494.13115,1697.778689,399.5409836,446.4672131,18018.60656,437.6721311,114.8688525,1976.016393,13181.61475,1557.860656,634.8688525,2788.745902,11685.40984,907.3032787,266.3114754,1420.647541,8688.877049,910.7704918,393.0409836,1302.918033,6617.401639,704,151.1557377,3398.54918,5912.934426,1299.737705,438.9836066,3230.647541,646.1721311,749.7295082,122,14.02146994,11.72567126,0.548324767,0.897058824,0.625641026,-0.583986249
+3531,28949,850.7857143,595.5454545,1083.279221,26293.4026,663.9025974,615.6688312,1586.824675,15266.46753,513.2662338,574.8376623,1729.012987,20326.61039,1206.019481,3213.811688,2858.974026,7395.474026,1282.051948,306.7142857,2358.331169,14593.25974,398.3246753,241.7012987,538.6038961,18701.70779,556.0064935,132.1038961,2676.331169,14281.05844,1457.857143,583.7857143,2788.357143,12098.22078,890.2922078,273.1428571,1821.090909,9064.12987,886.6038961,403.5714286,1308,6170.818182,648.2727273,155.512987,2719.928571,5837.785714,1296.811688,1050.149351,3220.285714,866.4350649,749.6298701,154,15.08329879,13.29000772,0.472916029,0.944785276,0.733333333,-0.431976689
+3532,23211.09375,759.046875,517.28125,1048.453125,21152.5,674.421875,666.75,1510.203125,11849.53125,483.140625,1263.625,1813.296875,16510.3125,1141.03125,4987.4375,3806.46875,5803.015625,1202.765625,290.890625,2309.28125,11741.15625,607.6875,377.640625,1659.96875,14605.5,478.578125,323.640625,2006.515625,11128.14063,2234.515625,991.859375,2793.421875,9556.78125,625.609375,247.34375,1523.640625,7086.015625,1180.515625,386.9375,1297.078125,4836.171875,659.5,154.234375,6353.859375,4567,1223.046875,244.890625,3136.921875,876.609375,748.703125,64,11.72790529,7.287295444,0.783522218,0.96969697,0.761904762,0.049162265
+3533,35251.47059,945.6323529,595.2279412,1124.235294,31203.79412,754.0882353,705.0367647,1698.941176,17950.24265,555.6470588,468.5147059,1742.580882,24578.875,1386.102941,1531.375,1128.838235,8693.617647,1432.257353,344.5294118,2342.036765,17640.94118,528.1985294,191.1470588,513.2205882,21747.06618,524.5588235,140.8088235,1196.897059,17161.28676,1603.007353,504,2815.169118,14908.57353,765.0588235,298.9485294,1265.779412,10668.63971,880.4117647,439.9191176,1314.698529,7104.676471,647.8897059,173.2794118,1499.007353,6734.183824,1459.345588,3073.801471,3206.279412,899.3823529,752.8529412,136,19.13596194,10.0504822,0.850969956,0.824242424,0.596491228,-0.083059159
+3534,41183.75439,854.8947368,492.9824561,1105.263158,34601.03509,686.5263158,871.5087719,1762.315789,17057.87719,505.7719298,2182.684211,1908.333333,23931.36842,1205.22807,8850.877193,4394.087719,8987.491228,1246.929825,319.1929825,2868.807018,18022.94737,415.5438596,209.7192982,3270.192982,22645.84211,505.1403509,129.2982456,1174.807018,16914.24561,3273.052632,422.8947368,2833.192982,13518.31579,612.2631579,276.7017544,942.1052632,9074.877193,2084.596491,408.6491228,1271.789474,5096.859649,600.7894737,154.9649123,2300.45614,5159.333333,1191.070175,241.5789474,3214.614035,1032.77193,747.7192982,57,9.183090202,8.462445887,0.388319376,0.919354839,0.7125,-0.791207352
+3535,38269.2314,848.107438,488.4876033,1083.454545,23624.18182,567.7603306,761.0330579,1487.586777,10991.38843,426.8429752,1452.115702,1749.22314,15626.06612,1040.198347,6714.132231,2457.429752,5898.595041,1126.264463,268.553719,2407.909091,11961.23967,367.6363636,186.1487603,1769.528926,14558.66116,611,133.1487603,2496.049587,11135.43802,1724.933884,394.0826446,2913.818182,8901.289256,518.6280992,236.4214876,877.2975207,5903.586777,1016.247934,358.0082645,1280.132231,3098.198347,568.1900826,143.5867769,2474.578512,3269.107438,1025.752066,283.3636364,3067.595041,1050.652893,749.2809917,121,14.72739808,11.00316916,0.66468647,0.896296296,0.581730769,-0.230518178
+3536,23567.76023,1045.187135,599.6374269,1073.672515,14306.1345,471.8011696,492.3157895,1264.309942,7145.578947,400.5497076,1046.789474,1701.017544,9504.94152,946.994152,7990.80117,2580.204678,3499.795322,985.5964912,233.748538,2297.397661,7178.023392,316.5964912,1728.766082,990.3391813,8484.877193,320.6783626,127.5146199,1728.339181,6354.245614,1870.736842,326.2748538,2811.549708,5406.157895,487.2046784,212.4327485,886,2852.725146,814.122807,331.5964912,1289.473684,2179.140351,851.0701754,132.1052632,1414.467836,1972.274854,966.9356725,121.128655,3016.883041,213.1695906,749.871345,171,15.34886779,14.52695003,0.322847731,0.977142857,0.76,1.082471082
+3537,37643.49254,985.5298507,520.1119403,1110.432836,33846.91045,776.9104478,795.8432836,1595.38806,19030.72388,604.0970149,1270.104478,1786.798507,24091.29851,1421.619403,2803.208955,3612.559701,8757.910448,1468.440299,360.1716418,2343.179104,19001.36567,454.7462687,413.5895522,1178.350746,22982.51493,533.4104478,141.8656716,1947.022388,17589.24627,2021.820896,746.0895522,2838.641791,15790.39552,708.6641791,336.3283582,1810.283582,11460.5,1389.835821,478.6492537,1317.291045,8647.432836,725.1865672,187.1044776,2152.873134,7663.559701,1548.186567,3326.283582,3325.268657,397.7014925,748.6641791,134,17.64469128,10.0060641,0.823658326,0.864516129,0.676767677,-1.344084628
+3538,24756.47917,949.0486111,623.4930556,1088.125,20900.84028,712.0833333,568.375,1556.583333,12036.50694,561.6597222,508.3402778,1766.020833,16201.20139,1286.138889,2548.902778,3034.048611,5656.8125,1357.625,310.8055556,2366.652778,11897.8125,418.7916667,635.3055556,457.9791667,14363.45833,485.7083333,125.4791667,2764.6875,11020.02083,1473.916667,746.2430556,2826.388889,9807.159722,937.5138889,282.1666667,2149.840278,7167.798611,888.3125,425.9166667,1305.541667,5427.951389,744.4097222,165.9375,3078.847222,5022.0625,1346.673611,874.5555556,3431.708333,536.3194444,750.2361111,144,16.13047039,11.84881196,0.678542825,0.905660377,0.642857143,-1.106236686
+3539,25127.03883,925.2135922,982.5533981,1096.223301,23861.68932,747.4271845,849.8252427,1732.23301,13493.42718,579.6796117,1208.592233,1812.436893,17565.32039,1337.699029,2047.407767,2616.621359,6023.038835,1424.883495,320.1359223,3332.427184,13066.93204,520.9514563,721.1359223,637.1456311,15892.95146,514.6699029,125.1262136,860.0776699,12001.05825,1888.514563,538.2135922,2804.213592,10516.82524,711.6990291,282.2427184,1634.029126,7602.883495,1084.786408,420.3300971,1395.281553,5860.650485,775.2621359,159.9029126,3356.805825,5234.825243,1364.84466,234.8058252,3335.631068,630.9514563,750.1747573,103,13.21254481,10.16988623,0.638388374,0.944954128,0.613095238,1.184393009
+3540,26623.54054,1119.824324,507.0135135,1051.236486,24260.14865,736.6486486,724.9324324,1478.891892,13577.27027,586.6148649,1106.358108,1715.168919,17626.09459,1341.648649,2725.283784,2513.844595,6054.155405,1481.22973,397.5675676,2416.621622,13000.98649,398.6216216,108.7567568,843.777027,15888.89189,1115.527027,117.7702703,1232.945946,11945.51351,1595.493243,498.5945946,2790.533784,10462.85135,574.0337838,262.0878378,1315.263514,7805.628378,1301.689189,383.6959459,1285.040541,5702.581081,583.6621622,146.75,1729.635135,5041.337838,1235.358108,457.8310811,3363.486486,705.2567568,750.8918919,148,15.11700132,12.70313441,0.542089046,0.942675159,0.704761905,-0.981973736
+3541,29062.24419,839.2248062,608.5658915,1097.166667,16755.02713,500.751938,343.0968992,1366.748062,6902.228682,397.3643411,666.1937984,1632.697674,11093.37984,952.1356589,4355.44186,2442.081395,4183.131783,986.3062016,238.4689922,2379.767442,8057.511628,314.2868217,681.6860465,614.1550388,9795.864341,365.0387597,108.2945736,4064.418605,7256.856589,1620.434109,380.0116279,2775.445736,5629.98062,522.8527132,210.8837209,822.3565891,3157.065891,826.0775194,328.1589147,1266.51938,1675.542636,653.1550388,135.3604651,2221.488372,1830.755814,923.1782946,306.4379845,2946.713178,1091.608527,751.2674419,258,21.25478526,16.05278632,0.65543088,0.928057554,0.651515152,1.53849603
+3542,31226.30625,908.55,635.81875,1111.61875,12844.59375,495.875,301.43125,1329.64375,6697.1375,415.81875,596.84375,1717.2125,8576.2125,977.40625,5916.7375,3344.58125,3363.675,1043.99375,242.20625,2285.35625,6934.68125,289.575,609.175,448.325,8516.19375,355.2125,118.7625,8841.1875,6357.60625,1425.8375,422.38125,2811.80625,5549.125,671.88125,226.55,1559.39375,3334.475,688.70625,349.0125,1302.75625,2578.3375,669.85,142.725,4750.2625,2326.68125,1055.8,514.7375,3089.6875,249.2625,750.33125,160,16.57882603,13.68153509,0.564780032,0.898876404,0.601503759,1.392425154
+3543,25897.2521,812.6386555,787.6134454,1146.369748,22604.34454,661.0252101,649.8991597,1682.151261,13076.63025,552.394958,528.8487395,1792.798319,16977.17647,1260.369748,1910.966387,1435.546218,5835.109244,1549.470588,415.1932773,2412.285714,12937.10084,484.1680672,307.2268908,473.5378151,15883.47899,636.3865546,118.8655462,888.4621849,12056.57983,1546.957983,585.8487395,2793.815126,10677.38655,1050.218487,268.1092437,1442.831933,7937.243697,1011.915966,404.8151261,1319.361345,5838.613445,649.2941176,158.5294118,1869.285714,5327.831933,1335.184874,180.6302521,3191.084034,738.4369748,750.8235294,119,13.89021526,11.40599553,0.57070774,0.959677419,0.607142857,-0.987695324
+3544,24998.44565,871.2065217,784.1086957,1173.836957,22832.86957,708.8152174,916.6521739,1833.315217,12815.20652,546.8152174,1230.673913,1867.967391,17021.03261,1273.554348,2330.565217,2950.26087,6099.923913,1311.391304,315.9347826,2776.282609,12664.16304,431.173913,164.326087,764.423913,15511,1571.923913,126.423913,1182.902174,11632.1413,1499.195652,471.5217391,2817.804348,10220.63043,898.7608696,280.326087,1743.228261,7642.304348,1181.5,419.7391304,1349.228261,5338.478261,631,167.9456522,2402.271739,4917.891304,1358.380435,361.3152174,3342.630435,831.2173913,748.6630435,92,13.93281484,8.546521053,0.789765015,0.948453608,0.786324786,1.180951013
+3545,34076.76087,879.2173913,485,1107.717391,27894.43478,730.5108696,647.8695652,1693.565217,15667.43478,514.6195652,1442.065217,1775.478261,21355.33696,1254.902174,4007.978261,2519.543478,7945.641304,1285.836957,318.7608696,2416.836957,15680.59783,917.5978261,177.1413043,1338.25,19668.09783,954.173913,1363.902174,1704.326087,15097.83696,1949.956522,608.8586957,2798.48913,12893.33696,664.4565217,269.9891304,1342.804348,9150.25,1135.076087,418.9456522,1311.173913,6229.630435,657.0652174,161.6413043,3860.5,5865.673913,1325.097826,390.5434783,3222.043478,909.0108696,751.1195652,92,11.67038173,11.31014556,0.246540679,0.859813084,0.544378698,-0.905284506
+3546,21350.90602,925.5451128,517.9962406,1040.105263,20122.53383,683.3120301,602.7669173,1452.766917,10983.23684,545.3496241,724.7255639,1698.139098,14893.86466,1264.469925,1673.071429,2372.255639,5361.210526,1499.736842,378.8233083,2350.112782,11294.95489,453.6278195,231.5413534,751.9774436,13802.40602,415.6090226,146.2706767,1228.37218,10297.25564,1542.966165,529.8383459,2806.575188,9225.484962,583.2443609,247.443609,1426.913534,7004.511278,1063.240602,383.906015,1299.206767,5190.319549,676.6541353,152.1015038,1997.007519,4739.924812,1282.206767,582.0338346,3184.097744,689.7406015,758.5526316,266,29.68761069,12.72106917,0.903542931,0.782352941,0.639423077,-0.097238834
+3547,34040.6242,1118.66879,717.6178344,1107.363057,19406.80255,578.0828025,392.8152866,1487.522293,10094.77707,445.8152866,1294.229299,1757.10828,12764.43312,1106.802548,7421.471338,2911.11465,4838.585987,1090.509554,254.7006369,2302.006369,9955.942675,320.6178344,267.2993631,659.8535032,12101.47771,351.1401274,1332.66879,6574.401274,9083.573248,1566.242038,385.955414,2814.178344,7677.496815,529.6050955,233.9745223,1227.923567,4363.394904,774.7770701,360.0828025,1263.789809,3318.636943,583.044586,151.3630573,4245.057325,2930.267516,1060.789809,240.7707006,3125.503185,238.433121,755.7133758,157,16.09442989,13.25847383,0.566891162,0.928994083,0.61328125,0.725540005
+3548,37367.92169,919.4759036,597.6506024,1107.066265,35854.56627,751.0060241,690.1325301,1707.674699,19815.03614,596.6987952,881.6807229,1793.855422,24286.8494,1369.253012,7450.271084,4006.120482,8848.650602,1464.216867,332.186747,2394.006024,19411.75301,438.3072289,549.9698795,802.8975904,22541.31325,443.0240964,155.3975904,2913.204819,17902.5,1838.89759,664.8253012,2821.566265,16053.25301,704.2951807,319.1204819,1819.283133,10982.46988,1189.807229,472.3614458,1311.813253,8335.048193,739.9036145,182.2228916,3745.493976,7501.421687,1457.46988,1604.879518,3343.662651,352.8373494,753.9698795,166,19.54661121,11.32852878,0.814926123,0.897297297,0.614814815,-1.11725984
+3549,25200.34899,909.7651007,692.2080537,1101.563758,22424.90604,717.4362416,717.033557,1565.543624,12853.32886,551.8255034,618.9932886,1760.375839,16473.60403,1284.080537,2487.57047,2322.389262,5921.630872,1379.543624,316.8456376,2373.812081,12616.42953,422.4295302,309.1744966,554.8993289,15659.79866,465.7114094,135.4966443,2030.832215,11730.97987,1619.805369,623.1543624,2849.14094,10292.31544,856.6375839,292.4630872,1803.771812,7676.959732,921.261745,433.9932886,1318.771812,5928.738255,677.3758389,169.1744966,2004.483221,5371.161074,1355.006711,469.3020134,3268,511.7315436,752.6711409,149,15.84465163,12.20063471,0.638024618,0.949044586,0.827777778,1.438063046
+3550,23657.27536,834.0072464,629.1376812,1093.355072,21096.64493,654.9057971,665.9202899,1579.76087,12049.98551,550.7681159,672.6521739,1745.65942,16138.92754,1261.181159,3217.717391,3316.992754,5468.202899,1512.717391,400.9057971,2459.905797,12168.81884,422.115942,341.5144928,714.4130435,15023.07971,491.384058,158.3188406,2055.463768,11308.41304,1617.297101,933.1449275,2789.992754,9693.137681,711.9565217,264.9492754,1820.507246,7401.463768,1144.34058,396.1014493,1319.036232,5410.644928,662.173913,159.5724638,2742.797101,4977.521739,1341.898551,448.9202899,3221.434783,727.4855072,755.5434783,138,15.49991466,11.84722416,0.644811951,0.951724138,0.663461538,0.160095977
+3551,37434.44765,1120.855596,743.8519856,1161.173285,12286.59206,418.967509,182.8736462,1168.249097,5652.234657,351.5487365,440.9530686,1623.364621,7709.382671,839.5523466,3220.776173,1770.902527,2776.685921,882.0866426,205.2382671,2254.415162,5567.935018,223.33213,93.62815884,476.8050542,6531.779783,263.8844765,91.31768953,3079.916968,4635.66426,1179.696751,276.4259928,2775.945848,3972.67509,435.5379061,184.6534296,912.3898917,1754.458484,642.1155235,301.7400722,1254.368231,1304.776173,481.631769,121.7689531,1163.303249,1258.963899,835.1480144,83.92779783,2890.66426,179.101083,756.5451264,277,23.18126785,15.76472699,0.733153501,0.938983051,0.65952381,0.971705273
+3552,39718.71517,894.5913313,530.2383901,1107.569659,35816.42415,706.1424149,553.2012384,1728.718266,18695.58204,554.3529412,1306.188854,1780.216718,23281.80186,1280.950464,6240.721362,3381.817337,8519.705882,1374.346749,330.6625387,2442.22291,18552.05263,407.6037152,489.4860681,765.1578947,22229.96904,499.4643963,227.374613,3644.436533,17119.56656,1732.653251,463.9411765,2817.873065,14927.04025,624.1826625,315.2352941,1414.009288,9012.517028,972.9411765,436.9659443,1349.399381,6949.024768,723.1145511,171.7368421,4723.452012,6029.247678,1324.668731,254.3034056,3289.219814,268.2972136,759.2600619,323,31.81711862,15.09061152,0.88036748,0.870619946,0.49845679,-0.633086962
+3553,30533.85625,903.73125,604.95625,1093.50625,28976.725,737.3375,728.15,1689.4875,15604.65625,580.7875,778.74375,1827.56875,19258.00625,1302.36875,5567.41875,5274.15,6976.26875,1369.9125,359.90625,2433.0125,15375.6875,422.3375,1763.0375,651.275,18052.6,516.775,149.11875,4772.05625,14006.43125,1709.475,667.2375,2824.71875,12324.76875,697.525,301.6125,2042.50625,8201.5875,960.63125,440.79375,1377.5,6228.3625,1020.36875,179.08125,7277.6375,5601.575,1412.35625,2639.73125,3322.46875,316.79375,756.24375,160,17.19533401,11.96199141,0.718377645,0.952380952,0.784313725,0.184401788
+3554,40066.39024,970.1219512,554.2439024,1144.512195,36319.14634,904.2682927,1284.756098,1775.780488,21376.4878,644.7317073,2430.146341,1865.243902,25547,1408.121951,5840.853659,4231.487805,9596.878049,1511.390244,367.5853659,2438.317073,20573,491.3170732,616.0487805,2668.902439,23819.65854,499.9756098,688.5853659,2128.756098,18846.58537,2672.121951,514.3658537,2881.073171,16996.31707,660.6097561,342.5609756,1452.560976,11662.2439,1780.365854,484.4878049,1350.560976,8543.902439,789.1707317,190.5853659,3505.121951,7849.780488,1503.829268,444.7560976,3343.756098,363.9268293,752.2926829,41,10.65513907,5.239347262,0.870753255,0.891304348,0.585714286,-0.393559128
+3555,44589.46575,948.7260274,546.9589041,1127.178082,42001.21918,799.8767123,839.4657534,1685.712329,23527.78082,623.5616438,722.739726,1773.767123,29409.52055,1425.780822,4282.369863,4571.657534,10902.31507,1550.561644,388.4383562,2359.643836,23351.57534,478.369863,1044.835616,712.6164384,27935.69863,462.739726,178.6849315,3574.123288,21688.26027,1908.342466,586.369863,2845.465753,19389.24658,663.9726027,340.890411,1656.945205,13703.50685,1213.369863,486.5890411,1323.589041,10252.93151,995.1643836,185.7671233,3502.60274,9174.493151,1533.958904,218.6849315,3365.150685,371.6438356,752.739726,73,11.30716237,8.826735618,0.624990631,0.869047619,0.608333333,-1.182986129
+3556,18506.35897,929.3675214,486.1794872,1080.931624,16939.2906,738.5811966,525.0769231,1477.581197,9479.145299,570.2649573,470.017094,1701.008547,12175.25641,1424.504274,979.9230769,1171.051282,4516.837607,1373.111111,339.8547009,2339.102564,9858.042735,435.5299145,164.7948718,482.7777778,11837.65812,470.6581197,136.8290598,983.8119658,9143.17094,1497.931624,615.5982906,2856.17094,8203.555556,815.3162393,304.4529915,1606.367521,6041.376068,857.4017094,458.1367521,1313.136752,4633.521368,671.042735,194.2820513,1946.564103,4325.589744,1597.333333,7604,3165.57265,409.017094,754.3247863,117,14.16702329,10.76856404,0.649788808,0.9140625,0.75974026,-0.098508433
+3557,16083.84685,838.2522523,481.9459459,1067.522523,15526.1982,673.4864865,569,1480.594595,8186.252252,515.0720721,440.972973,1754.135135,10625,1245.324324,1356.801802,875.036036,3975.972973,1316.954955,301.5765766,2305.747748,8733.243243,392.1801802,162.8648649,454.7207207,10424.77477,491.8558559,122.963964,939.0990991,7914.432432,1400.036036,520.7297297,2843.477477,7071.288288,739.0900901,280.1441441,1615.405405,5254.513514,799.1891892,418.7747748,1317.621622,4197.333333,774.8468468,172.2252252,2253.855856,3723.756757,1576.477477,2695.477477,3189.684685,419.8738739,754.5855856,111,14.59694404,10.06639341,0.72416824,0.932773109,0.69375,0.174030039
+3558,32669.14599,933.919708,614.8905109,1540.562044,29802.66423,750.2481752,797.1970803,2424.737226,16867.39416,568.810219,517.3284672,1826.948905,21031.0365,1364.474453,1398.744526,1574.29927,7561.875912,1716.583942,342,2370.218978,16739.83212,4614.226277,599.3284672,554.6277372,19914.80292,492.270073,140.270073,1143.927007,15412.74453,1675.248175,557.0437956,2857.255474,13674.48175,2063.868613,315.9051095,1443.306569,10029.43796,943.4379562,473.1021898,1344.941606,7471.963504,819.9124088,175,2891.489051,6837.89781,1491.583942,330.5620438,3285.445255,441.0729927,754.729927,137,18.26288033,9.847910825,0.842157914,0.88961039,0.537254902,-0.966121404
+3559,41494.90323,1069.215054,543.4086022,1114.258065,35877.36559,819.5483871,885.1827957,1633.483871,21420.72043,623.4946237,1079.569892,1731.634409,26473.96774,1430.150538,3383.655914,3348.602151,9363.924731,1521.064516,348.4408602,2349.462366,20189.31183,455.9569892,173.1935484,1068.193548,24195.43011,876.827957,188.2795699,1420.311828,18668.35484,1765.430108,549.6989247,2834.709677,16831.5914,743.7096774,326.9139785,1490.989247,12272.78495,1391.591398,485.0645161,1327.021505,9044.387097,674.4623656,179.8387097,1729.784946,8234.602151,1468.408602,417,3447.978495,475.4516129,753.1827957,93,12.67549965,9.540318857,0.658411438,0.948979592,0.65034965,-0.893868383
+3560,39730.13333,885.7111111,607.7333333,1102.111111,33344.46667,698.8,1009.577778,1648.822222,19858.57778,603.3777778,1973.288889,1753.177778,25414.8,1308.577778,3280.355556,2727.644444,8994.066667,1362.111111,319.6444444,2728.155556,19660,518.3111111,941.1333333,1090.955556,23969.91111,459.8444444,125.6444444,1398.644444,18031.33333,2028.111111,552.6,2838.066667,16043.42222,827.9111111,282.6666667,1478.844444,11739.02222,1010.777778,419.2444444,1388.088889,8825.911111,847.2444444,152.5777778,2802.111111,8079.777778,1420.711111,359.5555556,3283.977778,611.4444444,751.7777778,45,10.60824098,6.092175798,0.818653983,0.849056604,0.511363636,1.23228057
+3561,45351.3,893.22,495.44,1085.32,39754.3,731.44,687.7,1665.7,23399.46,566.8,466.74,1757.54,30424.88,1359.42,2731.34,3243.34,9860.5,1600.9,407.96,2377.62,23313.5,517.46,398,522.28,27884.8,455.72,129.34,1871.18,21487.2,1566.96,630.12,2776.54,19241.58,626.02,279.6,1546.52,14121.24,975.46,421.96,1316.1,10107,850.3,158.28,1956.62,9526.74,1442.4,177.4,3269.04,681.68,753.4,50,9.830607945,7.307581504,0.66890277,0.961538462,0.568181818,-0.004440381
+3562,34416.48731,865.0507614,528.248731,1099.614213,32463.47208,707.3807107,840.5076142,1664.548223,17588.94416,533.5888325,2400.553299,2164.071066,23516.58376,1303.111675,4176.329949,4002.309645,8779.84264,1327.944162,320.3959391,2814.436548,17799.07107,770.1472081,503.4923858,1452.538071,22012.29442,570.4619289,129.9695431,1494.817259,16824.70051,2353.730964,494.6345178,2811.456853,14229.14213,734.8020305,286.1675127,1169.248731,10245.05076,1644.116751,424.6243655,1319.48731,6350.091371,715.1979695,165.822335,2914.812183,6161.162437,1317.619289,836.4568528,3343.228426,951.1116751,756.7360406,197,19.78153902,13.09030462,0.749730323,0.924882629,0.608024691,0.865362187
+3563,38321.47971,999.6634845,561.7303103,1114.188544,37047.99761,785.7828162,784.6252983,1720.52506,19818.47255,624.4940334,1305.601432,1769.97136,24972.49403,1436.090692,4857.873508,3763.918854,8929.417661,1480.455847,359.150358,3039.923628,19670.5179,1584.384248,760.1384248,913.7136038,23425.51074,493.4343675,165.6563246,3809.565632,17970.11456,2109.24105,526.8329356,2823.026253,15832.39141,703.1193317,324.0548926,1460.78043,10292.32697,1184.768496,479.2673031,1377.102625,7888.74463,818.9379475,187.5369928,4773.155131,6831.634845,1465.995227,517.8878282,3341.415274,296.8281623,761.1384248,419,29.49812538,19.17518631,0.759893471,0.939461883,0.596866097,-0.928856685
+3564,40167,958.1111111,675.8888889,1183.888889,33745.62963,775.8333333,953.1851852,1779.722222,20726.27778,551.1666667,499.4814815,1745.055556,26273.87037,1379.407407,921.4814815,1007.740741,9372.462963,1395.685185,338.8148148,2342.111111,19554.96296,461.0740741,132.6666667,502.3518519,23452.31481,580.9259259,128.4074074,836.1851852,18611.11111,1502.833333,464.8703704,2817.555556,16199.74074,826.9444444,307.9444444,1528.481481,11822.7963,915.8703704,451.1296296,1325.148148,8019.314815,633.9444444,172.9814815,1008.740741,7654.166667,1454.351852,329.9074074,3344.018519,824.2407407,754.1296296,54,11.0781041,6.389068104,0.816935262,0.964285714,0.701298701,0.019231594
+3565,37365.23711,862.3195876,534.1958763,1104.56701,33303.42268,720.3608247,782.0721649,1699,17447.52577,530.7525773,1670.319588,1787.371134,23916.83505,1260.783505,5727.742268,4078.072165,8854.412371,1329.340206,323.5670103,3116.979381,17747.7732,494.4536082,510.3298969,1350.103093,22232.19588,670.0618557,134.1443299,2935.206186,17183.83505,2463.969072,600.1237113,2808.659794,14342.12371,622.1030928,282.0309278,1255.030928,9951.329897,1465.597938,415.9175258,1317.525773,5987.680412,703.3092784,162.3505155,5158.43299,5814.85567,1290.082474,618.7835052,3286.134021,989.814433,755.7525773,97,13.5968205,11.64368516,0.516390008,0.734848485,0.532967033,-0.095788869
+3566,21081.02198,968.2857143,532.4065934,1085.802198,18637.06593,647.0769231,487.4065934,1608.879121,9882.846154,506.1758242,1159.78022,1759.483516,12705.7033,1218.461538,9474.714286,4645.274725,4898.285714,1206.21978,328.6923077,2582.879121,10226.13187,360,2421.494505,788.5604396,12343.53846,422.7032967,216.978022,5478.659341,9078.967033,1771.725275,442.2967033,2822.813187,8077.747253,802.0659341,327.7912088,1549.857143,4823.769231,889.6263736,408.4065934,1388.197802,3730.065934,1226.252747,169.4945055,5978.307692,3184.626374,1218.89011,517.021978,3239.758242,257.9450549,756.6923077,91,13.34213716,9.009524541,0.737572026,0.957894737,0.636363636,-0.437962607
+3567,35648.60351,877.1578947,548.3684211,1098.750877,33211.41404,726.1929825,668.3263158,1683.540351,18636.46667,567.8736842,689.5789474,1780.589474,22684.82456,1293.407018,6282.635088,3665.82807,8315.333333,1397.308772,333.7368421,2349.803509,18031.90877,414.8877193,547.9438596,583.4210526,21181.4,459.0035088,136.0596491,3657.210526,16753.70526,1643.491228,635.7298246,2812.635088,14657.6807,636.1157895,307.1298246,1484.396491,9790.189474,966.0035088,451.3087719,1311.684211,7433.210526,741.5964912,173.5929825,3523.024561,6755.8,1390.2,1124.435088,3317.810526,336.0526316,759.6807018,285,21.4771401,18.74643538,0.487979139,0.83090379,0.539772727,1.093977252
+3568,29767.80682,921.8636364,525.6931818,1060.147727,27205.06818,712.3863636,621.5454545,1527.556818,15861.13636,573.625,676.9886364,1735.386364,19866.64773,1292.011364,5290.875,3111.704545,7340.488636,1368.181818,332.0454545,2340.420455,15338.73864,405.8181818,809.4772727,601.7727273,18461.85227,465.8863636,134.0909091,3990.227273,14496.56818,1819.443182,567.1931818,2825.693182,12753.20455,624.7613636,301.2954545,1795.556818,9056.715909,1073.159091,453.8068182,1316.681818,6673.715909,845.5795455,175.2954545,3481.590909,6124.102273,1385.556818,443.8295455,3311.613636,387.4318182,755.7954545,88,13.43121045,8.609965826,0.767506061,0.977777778,0.564102564,0.757385757
+3569,22296.94737,821.4947368,599.9052632,1086.936842,21206.08421,668.2842105,707.7894737,1488.094737,11439.97895,517.4631579,1426.273684,1847.578947,14745.98947,1211.705263,3580.178947,4248.442105,5483.926316,2489.621053,302.3473684,2659.473684,11814.10526,695.2105263,773.7684211,1166.6,13646.4,450.9684211,253.0947368,1795.957895,10707.41053,2182.852632,617.4736842,2806.389474,9527.252632,1520.242105,269.0842105,1653.115789,6926.505263,1338.526316,426.7473684,1328.6,5294.526316,815.6,163.8631579,4273.021053,4815.305263,1328.947368,315.4631579,3233.063158,455.4842105,755.3684211,95,15.46515515,8.875784915,0.818910326,0.818965517,0.527777778,1.197970382
+3570,33486.46667,883.9083333,536.3583333,1065.15,29429.36667,715.125,725.8666667,1533.65,16858.36667,578.975,1092.166667,1781.233333,21955.26667,1339.7,3064.158333,3898.766667,7853.708333,1767.433333,325.85,2515.783333,17293.93333,466.7416667,1356.325,1018.433333,21074.98333,589.175,509.5583333,1582.058333,15737.35,2010.183333,667.675,2817.883333,13893.875,752.6666667,306.7083333,1529.216667,10119.18333,1421.641667,439.425,1349.325,7753.75,1060.941667,170.8583333,4876.75,7100.95,1427.583333,383.6916667,3208.008333,565.65,755.8916667,120,12.8384648,12.19122815,0.313506259,0.967741935,0.612244898,-0.070604191
+3571,23503.80625,846.19375,505.73125,1043.43125,21508.86875,650.58125,691.86875,1481.80625,11876.73125,499.075,941.2,1766.63125,15973.59375,1183.825,3052.5375,2910.2,5631.66875,1265.5125,284.40625,2385.225,11995.075,409.6875,186.88125,779.925,14390.11875,570.6875,124.05,1465.88125,11080.0375,1562.85625,559.4875,2810.6375,9934.69375,1178.3125,275.3,1669.7875,7173.23125,974.35,394.91875,1309.46875,5390.35,609.1125,154.58125,2120.9625,5210.2,1272.125,1100.33125,3280.225,598.3,757.35,160,15.66908016,14.00999382,0.447833074,0.855614973,0.588235294,1.247827253
+3572,24387.45513,845.4487179,829.1538462,1147.24359,21779.33333,678.3910256,739.6153846,1672.967949,12294.32692,513.1474359,1013.929487,1803.679487,16244.61538,1270.769231,1701.50641,2353.025641,5571.987179,1517.621795,402.1474359,2566.685897,12471.95513,419.2307692,122.6794872,552.6410256,15244.73718,1204.410256,118.9166667,1021.217949,11537.52564,1404.564103,558.4294872,2803.147436,10087.78205,2157.237179,268.3782051,1562.269231,7586.621795,1406.634615,408.5320513,1308.564103,5582.275641,612.8461538,156.6858974,2156.269231,5094.679487,1317.724359,266.1282051,3500.378205,750.2179487,759.0384615,156,18.88669519,11.23393776,0.803868571,0.912280702,0.6,0.084810101
+3573,20618.6,1287.314286,655.6742857,1083.068571,17916.90286,719.88,601.5771429,1555.548571,10219.35429,538.0285714,893.0114286,1774.788571,13483.67429,1260.931429,3366.777143,2455.211429,4706.211429,1367.068571,354.3485714,2400.022857,10160.6,393.1085714,164.2228571,890.4171429,12140.19429,970.0342857,123.2742857,2986.234286,9395.588571,1461.085714,600.0285714,2799.485714,8212.84,651.7885714,259.6857143,1645.914286,6059.514286,907.6,390.7828571,1302.64,4447.188571,601.8628571,153.9714286,2561.434286,4066.902857,1274.834286,186.2742857,3282.548571,767.4285714,757.8971429,175,21.35260562,11.06130507,0.85536203,0.888324873,0.614035088,1.116044474
+3574,29213.70968,930.4032258,534.0725806,1051.677419,25638.71774,711.7580645,615.3548387,1547.016129,14143.3871,532.9919355,1228.645161,1765.467742,19569.83065,1235.322581,4160.927419,4401.709677,6985.346774,1247.233871,309.4435484,2353.459677,14114.74194,447.6774194,194.4516129,960.4274194,17453.83065,501.8870968,244.6370968,3198.790323,13526.68548,1983.975806,557.6854839,2790.475806,11488.87097,730.3951613,253.8548387,1580.330645,8174.403226,1166.58871,401.4274194,1289.935484,5453.693548,618,160.4354839,4885.83871,5276.66129,1248.604839,566.0322581,3281.58871,916.233871,757.0806452,124,15.97670132,10.56583146,0.750097312,0.925373134,0.635897436,-0.920463967
+3575,34026.18824,983.7647059,566.0117647,1092.529412,30300.08235,740.1647059,1102.152941,1664.835294,15690.29412,551.6,1561.352941,1761.870588,22076.16471,1256.682353,11062.50588,3486.223529,7850.305882,1305.988235,305.5882353,3420.458824,16045.41176,634.0705882,231.4470588,1451.870588,19937.72941,573.6941176,129.8705882,3404.623529,15331.88235,2723.811765,525.7411765,2806.905882,12891.04706,592.7529412,279.2117647,1233.152941,8937.047059,1346.235294,403.2823529,1293.729412,5326.576471,612.5882353,158.8117647,4425.6,5248.694118,1218.705882,415.1882353,3432.223529,998.2470588,756.2705882,85,12.09301883,9.01431404,0.66660102,0.944444444,0.653846154,-0.019361438
+3576,35964.89655,856.3678161,571.8850575,1105.827586,17996.2069,564.4022989,749.1954023,1379.873563,8431.229885,412.137931,1829.126437,1738.195402,12386.86207,1055.045977,7877.528736,3099.103448,4725.137931,1080.413793,252.0229885,2518.793103,9108.218391,368.5172414,1288.402299,2221.425287,11073.86207,803.7356322,509.2873563,1818.413793,8458.45977,2086.367816,463.7701149,2858.908046,6941.804598,536.5862069,217.4022989,817.4367816,4436.62069,1192.45977,343.183908,1278.126437,2335.885057,811.183908,144.6206897,3745.91954,2503.321839,997.8735632,982.7356322,3036.632184,1057.344828,756.0574713,87,12.832281,8.757143659,0.730950215,0.956043956,0.608391608,-0.582258194
+3577,28958.68254,802.9761905,537.6190476,1063.015873,25433.0873,685.2063492,911.468254,1598.515873,13691.59524,586.4206349,2626.484127,1875.238095,18664.5,1178.198413,7872.849206,4054.698413,7097.833333,1239.134921,341.1825397,2644.880952,14045.94444,402.547619,811.015873,2356.380952,17572.07937,529.4047619,335.9444444,1699.825397,13768.19841,2891.5,771.3333333,2795.444444,11469.12698,658.5555556,263.7142857,1133.865079,7958.515873,1706.634921,407.8888889,1378.277778,4927.833333,742.1666667,161.8253968,6957.02381,4858.857143,1227.309524,361.3888889,3219.365079,978.1190476,759.5396825,126,14.87396102,10.92713228,0.678447985,0.926470588,0.605769231,-0.259803835
+3578,30095.79861,819.4722222,520.7152778,1093.076389,27236.65972,660.5625,680.5694444,1626.840278,12381.92361,474.6041667,1553.166667,1838.361111,18077.00694,1147.729167,5419.756944,2566.270833,6869.770833,1202.402778,294.6666667,2482.395833,13617.875,490.1111111,377.9027778,1664.638889,17248.05556,563.3541667,121.7569444,1337.673611,12768.75694,2472.826389,433.8819444,2835.194444,10308.875,1317.756944,257.3263889,999.4166667,6989.354167,1320.555556,379.5,1293.701389,3962.416667,652.2847222,150.1527778,2714.194444,4027.097222,1160.666667,1582.5625,3227.930556,1033.888889,761.4722222,144,20.53152011,9.753752823,0.879952121,0.786885246,0.631578947,-0.090512006
+3579,18770.52174,908.8695652,829.1130435,1149.086957,17027.06087,701.2173913,655.1652174,1648.008696,9539.086957,604.6347826,526.2608696,1767.669565,11963.4087,1295.278261,1532.4,1308.895652,4435.678261,1322.791304,318.6956522,2533.808696,9481.66087,463.2347826,970.373913,465.1130435,11582.2087,437.4173913,120.6,1213.069565,8733.565217,1504.791304,554.4869565,2825,7858.365217,700.3391304,264.7565217,1529.782609,5803.678261,791.9391304,393.7652174,1373.704348,4473.852174,865.2,154.9478261,2234.66087,4180.304348,1340.695652,353.373913,3171.930435,626.4173913,759.9913043,115,13.30452056,11.36704757,0.519657233,0.927419355,0.68452381,0.396618535
+3580,38901.55285,859.7398374,507.5447154,1096.886179,32423.95122,679.8617886,1102.235772,1637.357724,15097.4878,494.5691057,2915.203252,1855.00813,21777.80488,1161.04065,8152.658537,4205.341463,8124.430894,1217.544715,297.8861789,2865.95935,16135.5122,432.5447154,146.0650407,2442.886179,19921.79675,825.1463415,128.5934959,1315.02439,15167.93496,3265.853659,384.1707317,2813.650407,12047.13821,585.9837398,261.5609756,882.5528455,7849.447154,1592.536585,386.8943089,1276.585366,4299.203252,590.8617886,145.7398374,2194.195122,4481.780488,1124.292683,313.7723577,3177.98374,1043.845528,760.7723577,123,14.54398291,11.04358767,0.650713346,0.968503937,0.640625,-0.330453235
+3581,37890.61111,1052.259259,568.9444444,1128.472222,13660.0463,438.0740741,204.7777778,1199.064815,6534.472222,364.1481481,614.8333333,1651.398148,8762.990741,881.2962963,3949.333333,1680.351852,3130.805556,930.4537037,221.3703704,2262.537037,6431.212963,237.1851852,81.28703704,492,7504.527778,390.7592593,96.47222222,2525.953704,5497.555556,1181.944444,283.2407407,2794.111111,4741.861111,453.3611111,192.1944444,902.5185185,2248.5,657.6296296,306.8240741,1258.796296,1679.87963,490.5277778,128.7777778,942.4907407,1590.675926,903.7592593,99.32407407,2971.527778,193.3240741,760.7962963,108,13.96533345,10.30440246,0.674958369,0.972972973,0.701298701,0.107762038
+3582,19166.16216,940.0540541,538.8018018,1070.243243,17406.21622,736.7207207,538.045045,1497.72973,9766.351351,561.6666667,700.8918919,1735.036036,12296.96396,1299.441441,2623.630631,3005.117117,4451.045045,1298.63964,312.5315315,2372.234234,9619.369369,411.2792793,359.1621622,847.6036036,11078.63964,580.9189189,126.3603604,2728.63964,8701.09009,1613.414414,871.7837838,2803.351351,7711.063063,775.1261261,287.2342342,2057.765766,5628.423423,1055.612613,437.9009009,1328.081081,4206.90991,688.3513514,172.018018,2688.36036,3829.828829,1404.702703,3118.288288,3243.495495,398.1351351,760.1801802,111,13.23826379,10.85572012,0.572326311,0.932773109,0.720779221,-0.092690651
+3583,32241.50833,954.275,507.1,1065.741667,27781.93333,736.2416667,786.6916667,1543.483333,16392.04167,586.1666667,1674.241667,1751.283333,20607.00833,1340.3,2695.566667,2917.666667,7509.5,1388.108333,324.1916667,2356.183333,16046.175,433.65,198.2166667,1682.383333,19432.50833,480.0666667,150.5583333,1283.616667,14997.04167,2077.158333,536.2,2845.833333,13326.78333,690.8333333,292.575,1494.775,9798.716667,1424.183333,451.3583333,1311.95,7448.808333,939.6583333,173.1666667,1672.883333,6944.208333,1634.416667,373.9416667,3323.208333,484.3333333,759.4166667,120,14.01642554,11.12583748,0.608216238,0.923076923,0.659340659,-1.033497514
+3584,27310.30702,897.2017544,752.254386,1112.026316,23511.73684,715.4385965,801.2807018,1651.991228,13095.65789,686.745614,797.3421053,1757.877193,17063.5,1281.114035,3490.201754,2275.640351,6237.587719,1345.105263,327.2368421,2625.04386,13209.81579,477.4298246,1291.298246,672.1578947,15921.91228,482.0701754,113.3596491,1820.684211,11790.11404,1695.508772,572.0789474,2794.438596,10318.38596,871.1578947,266.2719298,1599.350877,7563.833333,891.6140351,403.1842105,1386.535088,5931.429825,961.2719298,151.9561404,2703.842105,5329.561404,1369.605263,298.8333333,3279.184211,613.4035088,759.0526316,114,16.1127674,9.502141844,0.807602309,0.876923077,0.690909091,-1.510624475
+3585,27497.34254,818.5745856,687.7403315,1109.121547,24084.67403,662.6850829,995.5856354,1600.922652,13638.88398,536.5690608,1072.977901,1820.077348,18467.51934,1204.491713,2570.994475,2443.530387,6572.287293,1282.751381,310.8618785,2436.41989,13674.87293,412.2928177,419.5082873,710.7624309,16549.59116,938.679558,330.5745856,1806.491713,12752.40884,1751.359116,527.9226519,2802.320442,10957.23757,1168.740331,261.5966851,1580.497238,8139.066298,922.6464088,411.8895028,1326.729282,5934.867403,712.0497238,165.6961326,4892.160221,5551.220994,1302.563536,297.2983425,3226.635359,805.8674033,761.7237569,181,17.96306792,13.37196105,0.667718239,0.900497512,0.595394737,-1.213182822
+3586,23402.14667,888.0066667,696.4066667,1128.893333,21135.68,670.8133333,831.6266667,1620.62,11597.43333,584.84,1456.753333,1773.453333,15956.56,1241.22,2260.08,2404.733333,5784.886667,1347.14,314.0933333,2550.186667,11776.60667,404,442.3266667,731.12,14532.17333,1514.26,120.8866667,990.58,10963.86667,1475.726667,471.7866667,2792.746667,9589.433333,920.4066667,271.2066667,1449.073333,7098.1,1033.686667,422.9533333,1354.46,5047.4,710.3333333,165.54,2572.273333,4710.986667,1320.266667,260.06,3246.313333,835.2266667,759.1666667,150,17.67753046,11.1975486,0.773796733,0.882352941,0.607287449,1.46025363
+3587,28030.0339,844.4491525,566.6355932,1103.101695,25464.71186,680.7033898,602.2881356,1730.711864,10331.59322,488.9237288,704.6186441,1741.576271,16392.36441,1191.610169,5802.644068,3007.525424,6093.872881,1230.288136,303.8050847,2323.923729,12237.99153,453.9830508,884.3389831,791.2288136,15159.48305,464.720339,178.8474576,3515.949153,10890.82203,1820.016949,428.5677966,2802.983051,8475.864407,850.8474576,256.940678,1151.491525,5007.788136,933.7966102,380.3050847,1284.330508,2656.720339,728.2881356,155.1525424,3215.466102,2825.889831,1131.686441,1669.915254,3147.466102,1081.305085,760.1694915,118,13.43606063,11.24298739,0.547543735,0.967213115,0.648351648,0.915127693
+3588,35530.54128,853.0642202,458,1053.559633,33641.94495,698.2844037,513.6330275,1518.155963,18134.42202,549.4220183,551.9541284,1737.724771,23176.29358,1311.394495,2789.073394,2483.100917,8508.642202,1393.577982,332.0183486,2336.990826,18275.93578,416.2568807,493.0642202,479.7431193,22246.3211,521.6972477,134.4678899,1729.743119,16980.37615,1592.972477,512.7614679,2831.036697,15122.22936,648.9174312,307.6330275,1322.431193,10639.54128,1241.93578,442.6422018,1302.59633,8113.642202,766.9357798,178.8623853,3473.761468,7220.366972,1429.614679,256.9816514,3289.055046,378.2752294,760.5504587,109,15.75648348,9.748380921,0.785635103,0.858267717,0.534313725,-1.426537662
+3589,25935.06122,874.1938776,610.9591837,1049.122449,23386.20408,682.7040816,1055.72449,1496.836735,13010.13265,538.1122449,1600,1811.377551,17038.55102,1306.153061,2534.591837,3537.632653,6189.408163,1366.102041,328.2244898,2568.673469,13482.64286,445.7244898,1622.663265,1082.122449,16439.39796,1275.632653,170.7959184,996.3673469,12055.29592,1746.734694,659.8571429,2819.806122,10834.83673,764.255102,281.9897959,1451.428571,7929.632653,1582.571429,440.8877551,1389.520408,6128.428571,1020.255102,171.2653061,3274.153061,5495.479592,1382.010204,605.0816327,3185.071429,556.6122449,761.255102,98,13.58107701,9.442916634,0.718720075,0.98,0.538461538,0.797945379
+3590,30286.99167,766.5583333,494.6666667,1047.741667,27757.99167,637.8166667,442.5583333,1509.125,15756.71667,503.7666667,533.55,1750.808333,20654.23333,1192.283333,2818.858333,2281.375,7227.233333,1435.658333,333.8333333,2356.225,15802.99167,425.15,535.1583333,528.4583333,19548.425,394.6166667,114.9416667,2026.183333,14596.575,1536.175,660.8916667,2792.016667,12898,909.5416667,259.8833333,1501.683333,9494.716667,929.2166667,383.4916667,1293.841667,7116.35,745.9666667,150.3333333,2212.233333,6492.783333,1268.366667,977.65,3255.5,650.4833333,759.7666667,120,15.47514724,10.7661938,0.718324073,0.875912409,0.576923077,-0.986335142
+3591,31635.83158,808.7052632,525.0368421,1052.994737,29102.18947,656,709.9947368,1525.094737,16322.27895,536.5947368,657.5473684,1728.857895,21874.44737,1233.315789,5020.452632,3597.921053,7468.105263,1518.926316,385.7052632,2428.978947,16962.36842,482.1736842,816.0473684,543.9842105,20907.32105,656.3473684,128.6157895,2807.952632,15519.31579,1745.589474,775.9157895,2805.157895,13671.18421,649.2842105,267.4473684,1647.978947,10336.9,1020.2,390.9789474,1300.189474,7500.194737,782.8,152.7,2344.594737,6828.510526,1331.031579,629.8052632,3245.7,668.9842105,764.4210526,190,21.99107514,11.52911451,0.851556193,0.859728507,0.616883117,0.173794001
+3592,25578.77778,791.1333333,421.0555556,1087.788889,23208.07778,644.5,1011.244444,1538.955556,13676.08889,520.0222222,880.3666667,1750.644444,17514.5,1200.788889,1812.233333,1838.255556,6349.388889,1471.555556,378.7111111,2530.055556,13641.38889,4268.8,178.0444444,704.4,16656.42222,753.6777778,709.5777778,1118.644444,12828.24444,1606.866667,581.4444444,2777.877778,11489.74444,569.1666667,258.5666667,1400.355556,8430.933333,900.1,393.5777778,1301.711111,6267.055556,665.2777778,153.4666667,2258.2,5903.955556,1286.066667,268.8555556,3278.055556,678.9777778,761.6333333,90,13.17677678,9.064717149,0.725775812,0.957446809,0.692307692,0.52166876
+3593,28313.11236,881.4157303,818.3595506,1139.808989,24193.23596,690.505618,895.494382,1654.280899,14246.58427,538.505618,542.258427,1783.910112,18532.5618,1312.101124,1469.303371,1269.853933,6132.134831,1614.876404,429.1460674,2454.382022,14110.24719,445.8651685,275.3258427,493.5393258,17080.4382,580.6516854,124.5280899,870.0786517,13388.02247,1456.853933,562.8426966,2800.921348,11618.70787,738.3033708,283.9101124,1674.449438,8618.94382,1152.58427,430.8764045,1323.370787,6296.539326,662.8426966,160,1183.865169,5864.775281,1400.460674,180.8988764,3264.797753,740.7191011,761.1573034,89,11.23081768,10.71107893,0.300689494,0.927083333,0.674242424,-0.247510524
+3594,22019.27922,760.9415584,607.6818182,1077.818182,21222.44156,632.5194805,778.9935065,1563.064935,11126.17532,483.6233766,1472.714286,1798.162338,15038.56494,1136.058442,4325.863636,3331.331169,5821.538961,1210.935065,289.9350649,2571.590909,11423.85065,399.3116883,249.5779221,1678.051948,14355.66883,481.961039,171.1883117,3102.87013,10854.36364,1938.876623,484.6233766,2856.246753,9095.149351,1051.558442,257.5454545,1681.577922,6533.831169,1063.668831,388.6298701,1308.798701,4249.376623,625.7272727,154.5584416,4134.62987,4051.448052,1191.746753,1205.12987,3178.012987,939.4155844,762.7077922,154,15.22928834,13.84483671,0.416593616,0.922155689,0.603921569,1.207452886
+3595,38215.3,868.4666667,503.5166667,1096.166667,33428.76667,703.8666667,840.15,1663.466667,19274.63333,568.9166667,2177.716667,2106.066667,25167.4,1298.3,4438.233333,3412.133333,9643.9,1335.15,329.5833333,2848.166667,19064.5,425.3833333,431.0833333,1503.383333,23930.95,495.2666667,140.3,2270.6,18899.13333,2501.816667,459.2333333,2778.183333,15721.7,645.1666667,286.35,1234.6,11140.13333,1530.983333,429.8833333,1343.333333,6685.883333,682.6333333,167.2333333,3111.983333,6686.683333,1303.1,282.7833333,3250.166667,965.85,758.15,60,11.62451017,6.584129654,0.824130056,1,0.779220779,1.183541862
+3596,19792.76608,872.4736842,553.3567251,1057.526316,17789.19298,670.9649123,483.0409357,1385.374269,9473.046784,526.9005848,534.5438596,1718.233918,12084.22807,1225.573099,1173.824561,1090.023392,4547.005848,1278.432749,290.4444444,2355.28655,9685.777778,438.3216374,249.8596491,524,11809.5731,506.8070175,122.4502924,968.2573099,8919.444444,1428.923977,584.5438596,2895.74269,7824.754386,753.9649123,258.5263158,2485.783626,5850.789474,847.9005848,410.8888889,1323.77193,4590.421053,654.1520468,160.2105263,1822.263158,4133.730994,1330.140351,485.5438596,3290.660819,496.1695906,765.5321637,171,19.18396192,11.47545257,0.801362151,0.93956044,0.7125,0.070933138
+3597,29978.07317,940.3170732,702.0731707,1119.04878,26328.14634,736.8170732,744.1097561,1660.487805,14708.80488,561.3658537,516.8536585,1756.95122,19221.96341,1344.865854,1289.97561,1879.95122,6804.878049,1454.658537,332.402439,2386.243902,14700.43902,458.4512195,240.2439024,460.0731707,18053.85366,481.304878,128.1707317,1682.914634,13527.62195,1515.646341,673.9390244,2800.719512,12097.18293,676.804878,311.9512195,1846.317073,8861.146341,872.1585366,457.6463415,1322.195122,6898.536585,667.9878049,176.4268293,1335.804878,6196.731707,1460.47561,227.6463415,3274.47561,538.2804878,760.5121951,82,12.22702522,9.253590873,0.653629637,0.854166667,0.525641026,-0.960100367
+3598,35125.47682,825.7350993,510.602649,1078.821192,32593.56954,688.8940397,735.0397351,1660.046358,16279.62914,502.4569536,1247.834437,1740.139073,22744.13245,1188.735099,5135.496689,3011.529801,8439.476821,1305.622517,309.4635762,2490.81457,16850.45033,414.0728477,471.0529801,884.5430464,21249.40397,767.9668874,130.1258278,3461.417219,16045.40397,1875.97351,545.7152318,2808.993377,13254.49669,613.615894,275.1523179,1431.423841,9007.337748,1211.423841,401.9403974,1286.649007,5373.582781,702.6821192,159.7284768,5539.483444,5279.536424,1238.258278,501.8940397,3255.364238,1007.92053,762.9072848,151,17.92098369,11.89261093,0.748075404,0.862857143,0.559259259,-1.381723479
+3599,47769.0625,916.7083333,490.3958333,1122.75,44335,764.75,761.2708333,1674.520833,25207.64583,615.0208333,1396.666667,1801.708333,30981.0625,1403.895833,3611.3125,3386.75,11545.54167,1512.9375,353.8958333,2327.4375,24676.52083,456.3333333,180.5208333,1266.958333,29754.58333,633.0833333,145.8333333,2156.395833,23224.85417,2052.458333,500.2083333,2838.4375,20784.08333,654.8541667,338.125,1309.145833,14430.25,1340.6875,473.5,1321.020833,10719.875,683.7916667,188.25,2207.833333,9779.375,1530.166667,183.1875,3344.416667,367.0833333,760.3125,48,9.198938212,7.396345358,0.59457064,0.905660377,0.533333333,1.304946063
+3600,23973.97656,923.234375,829.140625,1112.640625,21919.32813,684.1953125,504.28125,1620.507813,12421.5625,547.3515625,477.0703125,1776.164063,15756.73438,1245.46875,4809.765625,2802.328125,5642.148438,1345.140625,314.796875,2387.84375,12085.89063,450.234375,268.7265625,485.09375,15027.10156,484,117.15625,2327.273438,11134.97656,1477.75,622.78125,2789.742188,9829.117188,746.671875,260.609375,1781.351563,7145.867188,868.109375,378.609375,1308.484375,5508.882813,666.4609375,155.3984375,2449.078125,5004.078125,1302.617188,305.5234375,3340.90625,639.359375,764.4375,128,14.72642464,11.1469059,0.653493345,0.955223881,0.711111111,0.10038108
+3601,33529.17614,934.2613636,536.0852273,1094.125,30617.82386,751.3352273,840.7670455,1594.318182,17577.19886,566.4318182,1402.375,1742.664773,23122.33523,1379.039773,1988.647727,2977.198864,7641.272727,1545.232955,405.2670455,2502.181818,17453.86932,451.9090909,131.4204545,877.8238636,21611.06818,906.0681818,193.0795455,977.2215909,16375.11364,1662,529.2840909,2791.113636,14419.1875,710.7045455,285.9772727,1446.829545,10770.51136,1523.965909,418.3409091,1308.977273,7853.886364,632.5454545,167.4375,1652.397727,7201.443182,1430.056818,857.9431818,3216.579545,702.8011364,763.6931818,176,17.18968395,13.51475293,0.6179556,0.926315789,0.785714286,1.3807378
+3602,26644.40645,915.1677419,606.0258065,1106.077419,24444.57419,717.5354839,666.8129032,1599.141935,13837.13548,538.483871,429.2516129,1713.651613,18141.95484,1372.2,2040.883871,1917.135484,6086.987097,1561.735484,413.516129,2372.251613,13867.94194,444.883871,259.3032258,476.6129032,17162.09032,464.7032258,125.5612903,1729.045161,12938.10968,1449.651613,701.2645161,2797.019355,11263.2129,660.0193548,288.5741935,1637.8,8395.451613,1020.477419,413.9483871,1321.283871,6253.348387,651.883871,166.6580645,1520.63871,5622.935484,1437.406452,1517.812903,3193.819355,717.6322581,763.6258065,155,16.16270534,12.60676877,0.625790418,0.928143713,0.688888889,0.731686344
+3603,28003.88095,786.1309524,484.7142857,1058.154762,24139.75,677.9761905,1092.142857,1556.880952,14047.29762,501.8809524,1757.52381,1806.214286,18038.71429,1197.27381,4623.5,2958.738095,6627.535714,1241.571429,301.8214286,2681.488095,13999.44048,520.5833333,100.6666667,1930.285714,17174.28571,735.5238095,646.702381,1413.511905,13144.09524,2227.154762,488.8333333,2803.785714,11643.36905,610.5714286,273.0952381,1450.583333,8478.678571,1264.488095,409.4047619,1315.142857,6111.797619,594.3214286,158.6071429,1980.297619,5775.083333,1294.738095,398.5238095,3213.345238,785.297619,760.202381,84,13.99044423,7.825760475,0.828921676,0.943820225,0.7,-1.563630353
+3604,32930.66848,823.3097826,568.3423913,1085.923913,25520.00543,648.0706522,908.6902174,1634.63587,11259.63043,465.923913,2702.777174,1778.027174,16569.56522,1135.923913,10942.13043,4072.559783,6417.668478,1161.896739,285.1902174,2526.559783,12833.04891,453.3152174,1108.657609,1825.005435,15702.28261,503.1304348,227.6304348,1714.206522,11605.43478,2861.293478,422.8043478,2832.875,9416.271739,569.3043478,244.826087,874.923913,5826.396739,1844.173913,366.4293478,1292.282609,3100.836957,815.0706522,159.2282609,2945.173913,3349.380435,1089.418478,393.576087,3121.092391,1065.070652,763.9021739,184,18.68010319,12.87882899,0.724341846,0.93877551,0.773109244,-1.184543313
+3605,28922.66827,902.4086538,555.2644231,1100.610577,26975.21635,724.3125,916.8461538,1613.048077,14752.77885,570.1634615,1270.591346,1764.899038,18597.11058,1301.975962,3279.024038,3892.456731,6631.067308,1649.951923,331.7115385,2526.403846,14618.91827,507.7932692,1104.519231,876.7019231,17629.81731,814.8461538,171.7884615,2010.927885,13295.1875,1726.086538,600.5096154,2811.918269,11823.62019,741.1971154,307.7115385,1588.75,8610.951923,1364.447115,455.4278846,1389.355769,6563.735577,1070.634615,175.7115385,4750.552885,5809.384615,1429.634615,267.7403846,3257.735577,446.7019231,767.7115385,208,21.011014,13.74268006,0.756433773,0.822134387,0.576177285,1.188282674
+3606,33761.4,844.7111111,607.5555556,1088.311111,31495.57778,710.2,838.6222222,1492.022222,17420.46667,531.9555556,1267.444444,1815.355556,22223.91111,1268.444444,3097.777778,3495.222222,7993.6,1873.466667,328.7555556,2451.422222,18008.35556,447.4222222,756.5777778,1144.244444,21723.68889,546.8888889,418.2,2218.666667,16936.55556,2006.488889,570.0888889,2782.177778,14839.55556,735.1777778,296.4222222,1524.577778,10962.31111,1120.244444,451.3333333,1360.4,8198.888889,825.7555556,178.5111111,4359.511111,7663.244444,1398.355556,241.2666667,3264,452.3555556,760.9111111,45,10.16858013,5.81623762,0.820266664,0.957446809,0.642857143,1.224823143
+3607,17930.12879,862.4848485,456.3181818,1040.333333,16674.53788,694.1742424,427.3560606,1387.371212,9305.174242,525.2045455,410.8409091,1694.265152,12039.16667,1323.30303,1184.19697,1782.454545,4314.015152,1324.757576,324.8636364,2308.060606,9673.590909,405.3333333,240.5909091,453.8560606,11666.23485,427.8257576,130.5833333,1087.901515,9074.492424,1488.492424,674.5075758,2826.121212,8096.234848,673.3863636,288.0984848,1512.522727,5947.492424,850.9393939,441.530303,1324.030303,4588.515152,656.7878788,182.5833333,1939.068182,4245.863636,1516.045455,7392.515152,3125.19697,415.0757576,766.5606061,132,15.20727323,11.37702637,0.663551515,0.936170213,0.733333333,-0.144377432
+3608,25036.24701,1057.486056,635.0079681,1077.904382,22093.23904,757.2350598,598.9003984,1509.689243,12535.94821,601.3187251,556.8605578,1850.14741,15678.05578,1316.14741,2773.430279,2192.338645,5667.61753,1480.59761,314.3585657,2326.641434,12186.31076,411.1952191,433.123506,499,14734.20319,434.6175299,125.9083665,2511.752988,11045.88048,1552.541833,569,2839.840637,9872.135458,973.5697211,286.3426295,1639.912351,7174.25498,856.4820717,426.1035857,1322.087649,5477.888446,735.2310757,170.0756972,2836.541833,4907.932271,1344.972112,1286.545817,3501.940239,471.6972112,769.1992032,251,21.66443156,14.94134614,0.724122155,0.940074906,0.629072682,0.671078153
+3609,31170.11321,936.8396226,829.5471698,1167.641509,27199.4434,744.3867925,802.9811321,1693.632075,15517.82075,568.1698113,477.9622642,1760.584906,19466.76415,1372.103774,1078.698113,1248.311321,7109.773585,1473.990566,338.2641509,2352.801887,15346.81132,504.9245283,172.8679245,463.1509434,18479.42453,481.7075472,133.4811321,1338.698113,14079.34906,1515.084906,581.490566,2830.90566,12431.04717,678.754717,307.1792453,1883.037736,9087.886792,861.5566038,469.3584906,1330.113208,6962.264151,643.2075472,177.6415094,1722.584906,6280.45283,1470.443396,409.490566,3275.820755,507.7075472,764.3962264,106,13.26512319,10.5796837,0.603244405,0.929824561,0.679487179,-0.479822028
+3610,24441.85246,921.3114754,643.4262295,1087.360656,22151.4918,717.3032787,923.1721311,1565.196721,12327.44262,557.7540984,733.4016393,1768.590164,16130.77869,1281.885246,1993.401639,1628.131148,5738.934426,1358.336066,316.352459,2328.204918,12510.70492,648.2213115,206.9262295,699.7622951,14838.37705,713.3196721,127.5491803,939.5409836,11385.05738,1500.065574,565.7295082,2821.754098,9991.147541,795.2704918,291.8606557,1570.655738,7351.934426,955.2540984,432.9754098,1331.754098,5828.180328,634.7131148,163.5737705,2428,5109.614754,1378.639344,523.7459016,3334.065574,517.0491803,766.6229508,122,16.40111898,9.846432579,0.799736428,0.903703704,0.625641026,-0.529287844
+3611,37769.75556,996.1777778,565.8222222,1101.866667,32873.76111,770.0444444,803.0222222,1607.761111,19021.88889,585.4611111,1577.772222,1843.088889,24517.86667,1375.016667,3592.25,3834.094444,8347.338889,1410.816667,336.1388889,2478.516667,18818.57778,465.6722222,465.9,1716.422222,22666.78889,500.3222222,341.5666667,2304.994444,17180.68333,2105.883333,654.7833333,2817.811111,15246.04444,777.9444444,317.4444444,1531.183333,10823.10556,1282.538889,446.9333333,1331.811111,8215.366667,739.6333333,169.0944444,2463.677778,7294.544444,1408.033333,585.1777778,3516.638889,573.2222222,768.0555556,180,17.63884055,13.11947738,0.668420679,0.932642487,0.676691729,-0.109727503
+3612,29793.80734,922.3394495,664.0642202,1117.091743,26353.74312,730.2293578,863.2568807,1627.954128,14536.74312,549.266055,623.9908257,1795.376147,19236.89908,1332.495413,1565.733945,1708.752294,6701.587156,1379.724771,313.8073394,2374.522936,14590.33945,485.440367,115.6788991,631.4311927,17754.21101,453.0091743,125.9724771,1224.009174,13259.9633,1634.926606,564.587156,2827.834862,11752.72477,891.3761468,290.6422018,1504.330275,8460.220183,936.7522936,432.8256881,1316.211009,6384.027523,612.0275229,161.6513761,1161.055046,5921.798165,1403.137615,508.7889908,3385,586.7522936,765.3944954,109,12.42804724,11.43061836,0.392519421,0.947826087,0.698717949,0.034887678
+3613,24402.41748,759.7572816,524.9223301,1033.951456,23096.1165,627.4271845,938.3106796,1442.718447,12783.87379,505.6213592,1349.058252,1832.281553,16793.75728,1165.68932,4616.184466,3267.106796,5977.048544,1424.495146,359.9223301,2423.31068,12807.24272,403.8252427,1738.359223,534.5145631,15667.23301,411.8932039,115.7669903,1257.76699,11737.16505,1947.708738,750.6699029,2789.07767,10274.60194,623.2912621,263.9514563,1289.242718,7637.834951,1230.504854,381.2524272,1301.417476,5792.174757,1004.330097,144.9223301,2246.15534,5286.524272,1254.019417,339.5145631,3178.330097,658.8640777,765.961165,103,13.31442535,10.1157639,0.650203959,0.980952381,0.624242424,-0.053044121
+3614,25047.98919,902.9513514,800.2756757,1138.756757,21871.11351,719.7297297,891.0216216,1670.183784,12562.94054,569.8324324,436.4378378,1733.924324,16849.66486,1277.2,1330.362162,1791.459459,6086.594595,1383.924324,322.7621622,2379.702703,12425.25946,549.3837838,469.2108108,480.1189189,15240.79459,498.427027,125.6432432,1356.821622,11676.70811,1465.340541,507.3081081,2791.551351,10093.85946,1545.567568,277.1135135,1821.556757,7501.32973,813.4972973,430.8486486,1326.508108,5356.102703,739.8810811,169.5459459,2138.021622,5093.302703,1377.859459,249.6324324,3271.124324,819.4648649,767.4540541,185,17.42488941,13.65266921,0.621372366,0.925,0.680147059,-0.479802576
+3615,30253.37226,1038.284672,531.729927,1094.160584,27301.92701,680.189781,404.0072993,1714.678832,14657.45985,533.8175182,508.729927,1769.635036,18488.86861,1256.919708,4405.291971,3942.525547,6772.686131,1302.321168,314.9051095,2301.751825,14450.9562,389.1605839,576.4890511,487.7810219,17611.63504,403.6861314,130.1678832,3851.963504,13418.12409,1568.620438,426.9124088,2825.540146,11545.57664,660.4014599,288.7591241,1518.532847,6741.854015,795.4525547,423.7518248,1334.832117,5058.540146,731.189781,168.3868613,5255.919708,4473.233577,1272.357664,163.1824818,3260.890511,252.4525547,769.0364964,137,17.7869436,10.27388487,0.816314119,0.878205128,0.691919192,-0.009009491
+3616,28554.06,817.6533333,484.3466667,1074.886667,26792.05333,680.3733333,707.7133333,1598.6,14869.3,540.9866667,1184.88,1817.24,18136.72,1232.94,3675.406667,3132.573333,6848.433333,1338.746667,309.76,2372.22,14671.29333,400.3866667,883.3066667,983.4266667,17574.94,783.3133333,140.3466667,2004.92,13474.93333,1546.086667,442.7933333,2870.18,11911.35333,1002.1,294.0133333,1375.293333,7835.293333,1174.186667,437.3866667,1326.48,6018.4,825.24,169.1133333,3469.62,5515.366667,1358.206667,2973.02,3277.36,313.3466667,768.2333333,150,17.38754712,12.07307954,0.719635454,0.810810811,0.588235294,1.233952173
+3617,39868.25217,883.4956522,515.7913043,1100.930435,37626.23478,725.426087,847.7043478,1626.913043,20582.11304,585.2347826,1870.113043,1792.773913,25328.55652,1330.391304,4067.930435,4322.756522,9456.669565,1437.956522,342.9826087,2443.06087,20390.49565,432.2782609,219.9478261,1327.269565,24032.8,786.8434783,136.6956522,2107.626087,18666.61739,1956.626087,526.1217391,2818.304348,16640.12174,660.1826087,316.7913043,1175.295652,11465.6,1642.591304,457.3130435,1308.686957,8751.669565,666.5478261,177.5565217,2503.73913,7684.495652,1428.347826,331.6086957,3321.973913,362.1565217,767.1826087,115,15.72575061,9.646875379,0.789737825,0.912698413,0.58974359,0.551448548
+3618,23276.44444,1035.420635,656.7936508,1105.222222,20362.28571,762.4206349,842.9126984,1601.801587,11386.92063,577.8809524,1080.722222,1780.944444,14655.12698,1308.960317,2827.595238,2798.666667,5081.388889,1306.698413,312.3333333,2369.896825,11060.96032,430.2698413,774.2301587,856.1428571,13205.71429,670.4365079,148.3015873,1458.888889,10051.70635,1857.896825,636.9126984,2810.84127,8795.960317,830.6666667,287.968254,1907.904762,6482.34127,1025.984127,431.7857143,1345.730159,4986.936508,782.8253968,169.6031746,3079.380952,4205.928571,1331.722222,547.2222222,3288.007937,528.3095238,766.7539683,126,14.48586938,11.66630392,0.592789386,0.90647482,0.605769231,-0.307266451
+3619,29842.54118,826.1647059,618.3529412,1088.752941,25662.95294,661.8,871.9647059,1574.847059,14642.23529,528.6,1610.152941,1771.2,19977.92941,1206.741176,3006.294118,2632.552941,6979.764706,1267.035294,301.0117647,3289.894118,14867.22353,602.0588235,133.4352941,1312.894118,17528.32941,477.6705882,118.3176471,1503.988235,13619.21176,1892.211765,542.9882353,2793.729412,11783.04706,1398.729412,272.6823529,1530.188235,8701.458824,1203.6,410.7058824,1369.105882,6212.835294,610.6705882,161.6117647,1970.870588,5780.235294,1294.917647,333.9647059,3240.235294,794.6588235,766.1882353,85,13.31458267,8.702174428,0.756855527,0.904255319,0.544871795,0.402553137
+3620,22760.46154,889.7032967,528.9120879,1071.978022,19367.40659,682.5054945,469.1648352,1469.186813,10912.52747,752.1098901,460.2417582,1691.538462,14945.1978,1181.43956,3448.747253,2320.802198,5251.021978,1221.934066,297.2637363,2375.813187,10636.91209,372.2747253,1320.923077,503.5824176,12988.36264,586.1758242,114.6263736,2094.285714,10055.18681,1620.692308,528.5384615,2777.186813,8458.527473,1290.659341,266.1428571,1384.912088,6286.043956,773.1868132,388.4725275,1388.208791,4383.505495,999.9120879,159.6923077,3978.32967,4070.901099,1216.065934,744.5494505,3291.901099,845.978022,765.5934066,91,11.67814012,10.37542974,0.458975714,0.928571429,0.583333333,-0.85910489
+3621,33403.00752,863.2180451,484.6165414,1086.015038,30096.09023,688.2781955,770.7894737,1585.413534,16715.6391,514.3082707,1259.857143,1782.496241,22192.87218,1225.413534,4883.390977,3900.037594,8166.834586,1280.87218,316.7218045,2407.819549,16682.56391,400.4586466,150.8947368,1658.744361,20755.17293,464.075188,168.8796992,2638.81203,15838.26316,2072.75188,515.7669173,2800.353383,13508.69925,604.9849624,279.518797,1439.210526,9572.744361,1179.849624,408.5263158,1305.225564,6312.360902,624.4661654,162.406015,3439.917293,6088.225564,1286.87218,267.7819549,3299.87218,912.9924812,767.1503759,133,19.1297108,9.736746648,0.860775055,0.826086957,0.554166667,1.050551501
+3622,28765.98058,1002.621359,656.0582524,1175.029126,27818.18447,803.4757282,656.223301,1759.61165,13890.61165,602.4854369,1693.446602,1873.145631,19105.30097,1466.485437,3623.533981,3528.980583,7170.61165,1457.165049,380.2815534,2443.165049,14412.03883,505.3009709,358.0873786,1610.805825,18409.36893,535.6796117,156.1941748,1474.533981,13907.64078,2842.582524,446.8446602,2806.029126,11689.41748,653.407767,321.1941748,1186.951456,8194.902913,1668.475728,456.6213592,1332.15534,5210.524272,697.9029126,184.0970874,1981.048544,5119.203883,1452.941748,225.1067961,3342.601942,964.0291262,765.9029126,103,14.39544477,10.14003814,0.709811041,0.837398374,0.536458333,-1.50257903
+3623,34375.75,915.4684211,547.3342105,1083.902632,31134.72895,691.7184211,963.4315789,1605.7,16172.21053,506.2210526,1789.094737,1795.439474,22471.45789,1219.194737,5105.605263,3932.265789,8218.571053,1328.331579,307.0184211,2582.102632,16590.81579,419.4342105,550.4368421,1590.339474,20720.98158,465.25,231.6473684,2502.581579,16155.05263,2361.073684,513.0421053,2803.334211,13421.39474,681.55,273.8552632,1213.786842,9231.965789,1375.089474,412.7157895,1304.434211,5575.226316,700.6394737,157.3368421,3220.542105,5531.873684,1259.318421,566.7315789,3204.089474,989.7578947,772.0763158,380,23.84895544,20.6526788,0.500081511,0.913461538,0.688405797,1.117972865
+3624,28907.29771,1038.465649,562.389313,1063.549618,23644.84733,624.4580153,359.8931298,1545.152672,12153.31298,506.2519084,502.0534351,1731.854962,15328.51145,1207.641221,6253.969466,3422.832061,5663.954198,1198.633588,285.2671756,2276.564885,12046.16794,379.0610687,755.3816794,452.5801527,14633.55725,383.6641221,127.6564885,5163.969466,10965.29771,1502.465649,410.2748092,2804.59542,9271.183206,584.8473282,258.8778626,1408.396947,5386.335878,754.3969466,396.0610687,1324.778626,4081.740458,746.4274809,157.7938931,4447.305344,3604.587786,1178.984733,263.9923664,3302.244275,241.4885496,767.7633588,131,13.80650274,12.67659812,0.396206527,0.929078014,0.71978022,-1.07248595
+3625,26826.17757,1071.990654,566.4392523,1103.373832,25144.27103,808.2523364,575.4766355,1551.747664,13258.76636,624.0093458,908.5140187,1723.560748,16617.41121,1531.925234,1894.252336,2243.869159,5710.280374,1468.065421,370.1962617,2403.186916,12949.16822,462,243.1121495,743.5514019,15358.45794,1004.056075,145.1401869,1299.757009,11676.3271,1657.542056,561.2429907,2831.663551,10372.28037,684.3925234,323.4766355,1414.915888,7350.028037,1220.271028,483.9626168,1333.53271,5780.056075,688.9906542,196.8971963,1711.551402,5044.457944,1596.233645,3011.317757,3222.028037,404.3551402,768.682243,107,14.33166564,10.15845234,0.705397738,0.914529915,0.594444444,-0.397436902
+3626,23915.22018,964.9266055,758.3302752,1133.40367,21734.02752,737.3761468,806.8256881,1680.009174,11870.24771,562.9724771,672.0091743,1741.504587,15507.30275,1348.247706,1521.752294,1710.449541,5625.917431,1365.623853,329,2383,12061.72477,475.5504587,309.266055,600.146789,14374.30275,610.587156,131.4495413,1112.357798,10807.91743,1480.100917,606.587156,2833.917431,9740.733945,1047.247706,299.9541284,1693.614679,7163.082569,954.2201835,450.2018349,1336.743119,5471.256881,671.6880734,178.1651376,1545.550459,4881.412844,1430.440367,959.4770642,3398.110092,549.0091743,768.733945,109,16.19620086,9.999935381,0.786629944,0.893442623,0.486607143,-0.490902134
+3627,37406.76923,928.7692308,530.4307692,1077.353846,32321.12308,701.7846154,650.2461538,1598.707692,19274.18462,557.6923077,972.8153846,1778.707692,24374.01538,1299.692308,3345.538462,3256.646154,8120.138462,1471.815385,396.1230769,2425.184615,18984.73846,401.1538462,114.4769231,1126.923077,23100.6,897.0307692,126.6,2662.307692,17388.18462,1768.784615,544.2307692,2801.846154,15275.24615,751.3076923,291.6923077,1679.215385,11389.52308,1050.892308,410.5692308,1306.615385,8002.553846,603.0769231,159.7384615,2473.246154,7416.523077,1339.046154,197.1384615,3343.138462,761.1846154,765.4615385,65,10.45607208,8.503937162,0.581842738,0.928571429,0.590909091,0.556823146
+3628,28903.28182,912.4,610.6818182,1096.527273,26419.3,726.6636364,877.7818182,1621.909091,14767.05455,554.9272727,1220.9,1797.863636,20036.22727,1307.563636,4227.863636,2635.963636,7123.572727,1346.372727,312.2454545,2377.745455,14298.61818,427.7727273,143.2454545,1179.672727,18260.99091,498.5,307.0181818,2633.281818,13898.30909,2022.063636,484.0818182,2802.027273,11741.08182,746.4090909,292,1569.609091,8705.145455,1204.245455,423.1636364,1316.236364,6023.745455,629.9727273,168.4818182,3159.936364,5658.481818,1367.127273,953.9181818,3387.227273,864.2636364,766.6272727,110,12.43762898,11.31079775,0.415919481,0.956521739,0.705128205,-0.144355854
+3629,35907.58182,849.7054545,513.4290909,1079.189091,31814.89818,706.5163636,730.6181818,1599.927273,17977.51273,519.1309091,1084.563636,1739.476364,23470.21818,1264.549091,3301.247273,3192.178182,8594.083636,1312.156364,320.8727273,2335.934545,17853.57818,412.2218182,152.6727273,1012.403636,22102.04364,506.8690909,218.4836364,2095.334545,17096.52727,1752.549091,524.7018182,2801.752727,14584.27636,704.2181818,281.8,1351.927273,10302.45818,1086.432727,422.9490909,1297.210909,6720.167273,621.3927273,163.1236364,2477.338182,6452.450909,1328.498182,540.2618182,3207.083636,903.8763636,775.9054545,275,29.07976753,12.52667976,0.90246194,0.856697819,0.592672414,0.2813854
+3630,39434.56522,868.5,541.7173913,1108.086957,17946.97826,558.326087,743.6304348,1429.923913,8287.282609,417.5108696,2073.369565,1794.652174,12135.55435,988.2717391,6202.815217,3215.51087,4715.315217,1045.913043,249.6956522,2439.173913,9190.086957,343.3152174,144.3043478,2736.532609,11332.76087,636.7717391,115.0434783,1556.423913,8579.184783,2459.130435,379.3586957,2784.271739,6896.108696,516.0543478,218.0217391,820.8478261,4579.206522,1439.402174,348.2934783,1298.347826,2522.413043,537.5326087,137.326087,1953.75,2674.021739,988.3695652,193.1413043,3075.25,1050.967391,767.7065217,92,12.94551181,9.291016449,0.696350631,0.968421053,0.597402597,-0.439366335
+3631,27868.49776,989.3901345,626.8699552,1098.26009,25132.19283,690.0672646,765.044843,1617.914798,13632.59193,565.5336323,1556.618834,1824.336323,16685.99103,1251.928251,7833.932735,4106.636771,6220.7713,1301.991031,309.793722,2372.381166,13320.40359,425.7040359,678.955157,1526.318386,15961.64126,722.8071749,319.7309417,4753.7713,12303.08072,2132.600897,499.2466368,2822.26009,10884.92377,620.9641256,284.6502242,1306.278027,6895.201794,1210.421525,431.5426009,1309.681614,5128.044843,742.9372197,167.6278027,5715.32287,4564.90583,1283.883408,258.632287,3284.914798,278.2914798,773.2556054,223,23.91418814,12.7614605,0.845714561,0.861003861,0.633522727,0.29637448
+3632,34477.72816,885.4854369,557.5339806,1063.718447,29319.92233,720.3203883,1131.087379,1556.640777,16682.76699,595.5728155,1612.203883,1780.815534,20663.82524,1246.61165,3651.07767,3976.563107,7753.84466,1302.805825,305.1747573,2624.854369,16361.09709,442.1165049,234.5728155,1034.679612,19608.8932,1520.873786,190.6213592,1468,14693.32039,1630.640777,539.1747573,2799.805825,12619.59223,1113.417476,271.7281553,1526.116505,9249.466019,1264.359223,402.1359223,1329.466019,7185.417476,638.9805825,153.2427184,2435.708738,6140.38835,1314.563107,959.7281553,3324.660194,605.7669903,767.8932039,103,12.18769435,10.85120865,0.455293554,0.971698113,0.66025641,-1.14499747
+3633,29060.19444,865.1666667,532.2777778,1071.935185,26505.86111,689.0462963,937.4722222,1607.759259,14430.13889,522.0185185,2364.212963,1846.388889,19046.72222,1217.527778,5025.814815,4338.712963,6921.638889,1280.694444,308.962963,2748.157407,14207.44444,399.962963,356.4907407,1662.324074,17658.97222,458.6666667,140.9722222,2334.37037,13407.83333,2512.287037,451.6388889,2812.194444,11278.15741,615.5648148,264.7037037,1165.101852,8051.268519,1225.416667,406.0925926,1305.194444,5222.490741,638.4907407,158.6574074,4057.805556,5026.361111,1221.898148,353.4351852,3312.398148,925.8148148,767.9444444,108,12.73780147,11.83068675,0.370617438,0.9,0.692307692,-0.582548171
+3634,36504,896.4207317,540.3170732,1097.280488,34234.43293,753.3536585,781.1585366,1655.335366,18780.76829,578.8536585,1149.847561,1791.530488,22797.66463,1300.54878,5242.054878,3696.128049,8242.213415,1410.042683,355.2804878,2403.292683,18151.13415,416.8719512,2144.128049,556.2256098,20987.83537,705.8780488,137.0609756,2501.22561,16610.18293,1869.054878,475.5243902,2826.530488,14725.81707,634.9573171,306.3963415,1238.341463,9571.926829,1352.115854,449.6097561,1366.640244,7217.530488,1114.02439,176.2439024,3092,6538.402439,1384.652439,493.3414634,3350.939024,325.9146341,772.2926829,164,21.18678039,10.91760515,0.857008242,0.815920398,0.585714286,-0.26456585
+3635,40559.28708,1005.497608,571.0239234,1147.555024,12876.53589,513.4019139,291.4449761,1456.980861,6352.564593,420.076555,681.4593301,1673.215311,8186.779904,984.291866,5461.842105,2139.502392,3313.885167,1056.052632,256.5502392,2286.732057,6729.889952,302.4641148,561.6315789,473.2440191,7973.004785,327.6698565,115.7320574,2687.899522,6088.210526,2156.626794,368.354067,2798.325359,5360.555024,516.8899522,252.7464115,1013.272727,2939.440191,854.1818182,377.8421053,1281.502392,2205.770335,831.9473684,149.4497608,1822.191388,2084.61244,1130.837321,121.6363636,3112.167464,216.7655502,771.1100478,209,24.19371407,11.66036748,0.876194014,0.916666667,0.552910053,-0.921048038
+3636,46631.65563,987.8013245,540.0596026,1121.715232,43833.33775,774.7483444,815.9271523,1682.642384,24617.96026,611.7350993,1722.231788,1770.211921,30689.38411,1425.721854,3838.847682,4060.84106,10952.6755,1511.476821,357.2317881,2404.291391,23927.68874,457.5629139,226.7284768,1105.708609,28447.23841,658.3377483,298.6622517,2422.569536,22392.33113,2119.066225,528.0397351,2836.708609,19610.64901,667.8344371,343.0794702,1426.794702,13709.25166,1386.655629,486.8145695,1327.331126,10274.07285,684.4039735,187.4966887,3155.84106,9225.880795,1515.980132,339.9470199,3312.649007,373.8940397,773.6357616,151,17.81112131,11.84158739,0.746983719,0.877906977,0.503333333,0.301116314
+3637,28851.89247,912.0967742,511.2365591,1079.55914,27617.49462,717.2795699,508.1935484,1503.763441,14874.76344,565.1505376,540.8064516,1753.83871,18987.43011,1326.010753,3166.827957,2578.591398,6776.634409,1369.860215,323.344086,2303.247312,14702.21505,406.6451613,595.6666667,496.1935484,17601.44086,460.0537634,137.7311828,2002.494624,13574.55914,1704.247312,593.5376344,2826.397849,11907.98925,666.6989247,304.9569892,1449.752688,8286.247312,1180.83871,439.5698925,1311.989247,6408.27957,733.7096774,173.6236559,3467.956989,5646.569892,1378,525.2365591,3318.860215,383.4516129,768.8602151,93,12.58579465,10.18961825,0.586964562,0.902912621,0.553571429,0.942189317
+3638,26691.92222,985.2666667,788.7666667,1142.455556,23524.14444,764.1666667,903.2333333,1709.022222,13578.78889,583.6111111,792.0666667,1798.477778,17242.78889,1380.144444,2846.755556,2096.422222,6142.388889,1469.177778,342.1333333,2415.3,13458.46667,2794.344444,156.2777778,631.0666667,16077.32222,528.1,141.9888889,2046.977778,12503.95556,1676.411111,536.8666667,2834.822222,11076.84444,1278.955556,308.9666667,1884.677778,8020.833333,1071.322222,475.4888889,1343.655556,6161.466667,707.2888889,180.8555556,2745.466667,5725.544444,1475.7,240.9222222,3350.977778,486.9888889,771.0444444,90,12.77196437,9.754714603,0.645500403,0.849056604,0.584415584,0.319620298
+3639,37198.01299,932.7662338,655.2077922,1118.909091,31204.44156,742.7142857,768.4935065,1637.324675,18973.77922,578.2857143,478.1558442,1752.701299,24162.53247,1382.597403,2376.077922,2381.337662,8340,1432.532468,349.1818182,2370.896104,18023.42857,485.3376623,159.8181818,451.2337662,22316.49351,465.4675325,135.1818182,2202.311688,17081.2987,1508.181818,779.6233766,2827.792208,14970.51948,721.3896104,315.974026,2042.909091,11066.66234,930.7922078,488.6103896,1339.441558,8104.896104,656.8571429,179.1688312,1503.220779,7686.519481,1496.61039,365.1168831,3273.168831,540.4805195,769.5844156,77,12.34642319,8.58065061,0.719018622,0.93902439,0.592307692,-0.334552108
+3640,24081.60784,797.1764706,492.4411765,1078.45098,21627.35294,651.372549,668.372549,1537.558824,12409.96078,518.1960784,656.2745098,1735.411765,16228.42157,1237.058824,3059.205882,2327.372549,5620.215686,1594.333333,399.5196078,2472.294118,12606.82353,422.0882353,905.3431373,590.2352941,15605.23529,448.9607843,126.8137255,1338.470588,11684.14706,1547.764706,737.0392157,2827.490196,10099.01961,653.2254902,261.8137255,1717.166667,7693.95098,1207.480392,389.9803922,1306.607843,5706.284314,832.9411765,161.9803922,2856.196078,5244.568627,1312.872549,283.9313725,3169.558824,729.8333333,768.3137255,102,14.3878183,9.292147764,0.763477537,0.935779817,0.6375,-1.270018595
+3641,24578.96154,954.5128205,756.8653846,1149.115385,21463.19872,744.3846154,857.6153846,1683.692308,12391.25641,569.8653846,439.9166667,1770.128205,16454.69231,1354.038462,1408.038462,1186.416667,5996.224359,1330.025641,320.2307692,2361.75,12079.33974,455.1858974,225.9230769,465.525641,14514.20513,529.8782051,126.1602564,1331.897436,11463.94872,1414.814103,455.0897436,2803.615385,9900.012821,921.2307692,284.3653846,1522.198718,7221.096154,803.8589744,425.9358974,1314.141026,5122.634615,648.6538462,167.6602564,1329.910256,4788.660256,1382.878205,332.775641,3237.955128,834.724359,770.5320513,156,19.34595247,10.50955549,0.839575439,0.945454545,0.666666667,1.121144866
+3642,15667.86842,680.4605263,420.2434211,1020.717105,14233.09868,558.6973684,374.2105263,1393.592105,7799.006579,443.2039474,371.5263158,1697.421053,10476.78289,1074.710526,1699.631579,906.8618421,3958.315789,1139.052632,263.6644737,2281.611842,8015.625,330.9276316,116.5328947,472.2368421,9762.578947,409.6052632,112.2039474,1074.723684,7578.348684,1255.631579,427.4934211,2838.230263,6589.888158,569.3815789,234,1137.657895,4825.578947,692.5328947,370.0855263,1296.539474,3278.875,606.4473684,147.2105263,2445.967105,3154.453947,1156.736842,2196.184211,3085.197368,883.2828947,770.9736842,152,16.29169421,12.07540742,0.671284012,0.938271605,0.730769231,-0.218915401
+3643,25904.4031,867.9922481,534.7364341,1066.96124,23155.91473,695.1317829,695.8914729,1535.046512,12909.81395,604.2945736,1259.635659,1725.310078,15979.08527,1272.410853,2807.139535,2599.364341,6019.271318,1312.75969,301.2170543,2542.294574,12612.02326,669.4418605,490.7829457,897.0542636,15057.91473,1124.271318,172.0852713,1508,11523.84496,1547.031008,568.2635659,2817.341085,10266.07752,665.0620155,270.124031,1550.604651,7428.178295,1153.426357,392.2403101,1337.224806,5643.728682,718.875969,157.9302326,3261.44186,5219.930233,1334.100775,434.8992248,3189.728682,617.3255814,770.8217054,129,15.4391937,11.64528528,0.656566996,0.854304636,0.661538462,-1.000438791
+3644,28926.46154,1029.397436,1050.705128,1182.25641,25104.05128,677.7948718,603.8461538,1645.705128,14086.74359,545.474359,501.8333333,1757.769231,18196.65385,1243.769231,2902.038462,1312.205128,6224.666667,1303.858974,306.3461538,2379.538462,13534.11538,439.0769231,165.8974359,483.5,16566.32051,518.3717949,114.5769231,1730.961538,12321.76923,1422.628205,549.8974359,2767.679487,10863.64103,614.0384615,255.8717949,1567.74359,8009.679487,791.6410256,386.9102564,1313.307692,5967.141026,616.1538462,156.7051282,1670.333333,4987.692308,1222.846154,232.2692308,3267.307692,629.9102564,770.2692308,78,11.02313045,9.384762331,0.524565687,0.906976744,0.709090909,1.460173637
+3645,43908.71429,892.7619048,619.8095238,1107.333333,36967.28571,721.047619,756.2142857,1689.357143,22701.57143,564.3333333,545.5952381,1759.97619,28992.42857,1337.904762,3101.928571,3260.047619,9390.952381,1599.142857,441.0952381,2452.47619,22364.07143,424.7619048,245.4047619,718.9047619,26727.69048,723.7857143,126.9047619,2125,21111.57143,1463.238095,620.3809524,2784.02381,18363.71429,991.9761905,310.4285714,1583.833333,13492.19048,1057.261905,446.0714286,1319.880952,9612.761905,646.8333333,174.2142857,2214.547619,9071.190476,1439.142857,198.6666667,3267.928571,754.6904762,769,42,7.757784921,7.634388862,0.17764905,0.933333333,0.583333333,1.105238507
+3646,18617.50962,885.5961538,965.4903846,1140.134615,17948.85577,714.6153846,905.1923077,1653.653846,9252.067308,520.9038462,919.0384615,1773.961538,12658.71154,1287.105769,1941.144231,1521.5,4496.163462,1381.721154,310.9326923,2595.644231,9749.576923,482.8942308,118.8269231,781.8365385,12176.27885,526.7211538,129.3557692,1502.730769,8732.519231,1656.269231,484.7211538,2807.471154,7660.826923,888.1442308,273.6538462,1693.605769,5793.778846,1005.576923,433.2019231,1336.038462,4391.326923,603,164.8942308,1437.605769,4014.192308,1380.067308,243.3846154,3256.182692,784.3653846,768.9807692,104,16.50273535,8.447713768,0.859046362,0.881355932,0.611764706,1.268081719
+3647,43348.01282,896.5769231,529.2179487,1098.820513,39153.94872,718.9230769,1153.717949,1659.307692,21939.02564,761.5641026,2850.448718,1833.858974,28250.70513,1285.435897,4354.230769,4433.871795,10585.74359,1350.346154,347.8461538,3420.897436,21667.65385,439.1538462,842.6282051,1852.025641,26964.94872,479.0897436,134.7435897,1622.333333,20844.14103,2691.884615,437.7820513,2837.666667,17798.87179,668.7179487,286.7307692,1137.666667,12489,1425.692308,437.7820513,1421.217949,7556.641026,783.3974359,170.6153846,2846.551282,7482.205128,1350.461538,320.9102564,3304.794872,950.4615385,769.3717949,78,11.59625202,9.036068951,0.626746486,0.896551724,0.6,-1.415360666
+3648,34241,832.3716216,458.5743243,1082,31256.27027,684.9459459,805.7364865,1613.256757,16815.93243,521.9864865,1780.027027,1742.506757,22695.7973,1220.898649,4009.925676,2553.864865,8428.040541,1292.135135,310.3378378,2436.844595,16706.66892,574,555.2432432,1252.22973,21376.09459,464.3716216,169.1081081,1275.094595,16539.73649,2102.121622,465.3445946,2820.574324,13729.90541,628.8310811,273.1756757,1083.087838,9589.290541,1266.695946,415.8108108,1298.108108,5882.182432,720.9459459,162.0337838,2426.155405,5849.993243,1302.459459,744.4459459,3218.283784,971.9864865,774.1621622,148,16.55130097,12.0093865,0.688131864,0.925,0.669683258,-0.345844981
+3649,27631.70833,795.875,507.1041667,1066.958333,25608.0625,658.7708333,1077.520833,1579.583333,14235.8125,509.9375,1593.791667,1826.166667,18672,1217.645833,4408.520833,2848.520833,6522.479167,1412.666667,373.625,2436.0625,14040.79167,399.6041667,513.2083333,1517.583333,17563.72917,455.2708333,322.5208333,1695.916667,12972.10417,2065.083333,591.1458333,2794.916667,11460.72917,643,260.1041667,1375.604167,8512.729167,1213.5,389.2291667,1288.520833,6423.833333,746.125,157.375,2099.833333,5941.25,1282.270833,425.3541667,3222.020833,651.4583333,770.125,48,11.36848871,6.094780825,0.844146995,0.827586207,0.444444444,1.027609033
+3650,32036.44604,973.2805755,670.1870504,1088.517986,28589.38129,707.1007194,702.2877698,1575.446043,15799.30216,718.7841727,1164.302158,1760.223022,21883.21583,1303.510791,4392.928058,3153.208633,7006.647482,1422.884892,377.1007194,2398.316547,16155.20144,400.1366906,314.323741,955.1366906,19260.02158,1118.820144,120.4460432,3161.309353,14608.97842,1677.47482,536.5467626,2805.496403,12672.54676,646.1438849,269.3165468,1610.316547,9369.834532,1108.280576,399.7266187,1341.100719,6712.057554,678.5539568,162.2589928,4106.676259,6125.805755,1292.992806,155.8489209,3340.453237,767.7482014,772.2661871,139,16.52206205,11.44438973,0.721251569,0.902597403,0.551587302,-0.9690617
+3651,31771.56364,826.1909091,535.8090909,1093.2,30009.78182,674.1636364,742.3363636,1668.854545,14361.67273,498.7636364,580.7272727,1747.709091,20252.78182,1207.790909,6731.890909,3391.045455,7710.681818,1568.845455,380.5636364,2369.718182,15289.38182,500.8727273,2069.272727,601.3272727,19203.44545,496.6818182,132.0181818,3609.863636,14669.53636,1809.063636,597.8454545,2805.436364,12025.2,719.3454545,270.8545455,1141.654545,8229.072727,956.0727273,403.7727273,1316.009091,4670.236364,1084.809091,162.4636364,3365.454545,4736.581818,1228.918182,594.6,3199.581818,1024.081818,770.7909091,110,13.11033279,10.83277094,0.563263484,0.93220339,0.769230769,1.277111115
+3652,34030.66102,899.1864407,583.2881356,1107.364407,30673.55085,729.0338983,739.7288136,1654.576271,17180.83051,566.4576271,1712.423729,1837.40678,21031.08475,1311.440678,5702.90678,4535.305085,7780.389831,1381.118644,329.9576271,2351.728814,16479.22881,595.5508475,302.3050847,1178.313559,19739.09322,458.6271186,161.6694915,2250.881356,15412.85593,2296.398305,791.8728814,2814.271186,13501.69492,741.4745763,304.2118644,1293.542373,9146.279661,1246.559322,445.220339,1306.059322,6871.855932,663.6355932,173.7966102,2672.694915,6146.559322,1352.830508,201.4322034,3337.262712,354.0338983,773.9067797,118,13.20579558,11.4902484,0.492890511,0.929133858,0.648351648,0.023605136
+3653,21595.90295,732.1561181,571.0337553,1054.953586,14497.94937,540.0253165,583.8059072,1417.147679,5413.616034,475.7383966,446.5527426,1681.337553,8948.704641,985.5907173,4160.628692,1473.101266,3319.561181,1046.594937,250.7974684,2285.514768,6282.28692,337.2995781,1347.151899,526.4852321,7520.160338,403.1940928,106.9957806,1918.21097,5552.35865,1803.683544,503.5527426,2786.49789,4414.270042,574.257384,208.7679325,812.835443,2294.991561,749.4556962,335.0759494,1281.046414,1262.270042,781.6160338,133.8101266,1590.181435,1420.223629,953.7848101,675.0295359,3051.662447,1099.097046,776.1223629,237,18.9627017,16.19268071,0.520399931,0.951807229,0.658333333,0.470884102
+3654,34964.81818,824.5454545,508.9090909,1090.311688,31798.12987,703.038961,835.1558442,1683.597403,16142.02597,503.6493506,1933.766234,1810.402597,21931.15584,1212.649351,5351.532468,3603.935065,8269.714286,1407.935065,318.0519481,2562.558442,16479.11688,427.2207792,589.9090909,1345.675325,20642.35065,1080.818182,149.6883117,3354.558442,15841.49351,1844.636364,498.1688312,2826.831169,13115.45455,612.3766234,273.5064935,1132.558442,8851.558442,1533.818182,413.3376623,1297.116883,5110.155844,751.1948052,161.0909091,4287.207792,5200.974026,1238.805195,570.8441558,3243.701299,1008.519481,771.3246753,77,15.41973833,6.728019442,0.899789072,0.885057471,0.641666667,-1.353550678
+3655,32845.37805,824.5365854,476.1585366,1053.45122,29300.91463,672.3414634,695.2560976,1555.560976,16282.56098,542.6097561,749.8780488,1768.121951,19948.03659,1206.963415,4593.560976,2076.280488,7269.109756,1307.621951,306.2073171,2355.743902,15393.65854,376.5487805,239.1585366,961.6707317,19125.32927,472.7073171,143.8658537,2089.560976,14712.71951,1595.829268,394.2926829,2815.987805,12872.82927,589.1707317,289.2804878,1102.097561,7735.341463,908.6341463,418.7439024,1301.304878,5790.341463,636.5365854,162.2439024,2428.902439,5329.731707,1283.585366,150.8780488,3221.853659,269.1829268,774.8780488,82,12.22969242,8.773730526,0.696648934,0.953488372,0.573426573,0.350007143
+3656,32878.47573,844.9029126,753.0485437,1147.213592,28211.97087,681.0582524,661.9514563,1691.417476,16413.03883,524.4368932,497.407767,1750.242718,21498.70874,1275.087379,1223.106796,1834.339806,6981.31068,1513.398058,406.5533981,2371.786408,16351.02913,420.6116505,167.1067961,560.1747573,20130.59223,453.0291262,120.4951456,1315.174757,15252.33981,1431.660194,564,2793.796117,13245.39806,886.3106796,278.7572816,1572.15534,9860.640777,991.4563107,408.5728155,1311.932039,7059.106796,633.407767,156.8640777,2261.825243,6511.592233,1333.145631,155.3495146,3206.669903,738.961165,775.1067961,103,13.66496258,9.998740016,0.681619985,0.887931034,0.668831169,-0.087415654
+3657,27826.80357,900.7053571,518.2410714,1088.875,24516.51786,710.1696429,649.7321429,1538.089286,13804.39286,541.7857143,409.5357143,1684.482143,18689.64286,1343,1434.5625,1043.741071,6595.9375,1329.142857,321.6696429,2301.410714,13618.16964,429.6964286,109.8392857,511.3571429,16947.5,445.9732143,131.3571429,1294.089286,13062.04464,1438.080357,447.7767857,2813.330357,11196.88393,643.25,288.4107143,1298.857143,8113.446429,851.6428571,426.3035714,1307.678571,5590.285714,618.4732143,168.7232143,1667.678571,5356.5625,1432.580357,3388.098214,3133.357143,871.7321429,774.75,112,12.87886912,11.26250034,0.485035413,0.973913043,0.717948718,-0.978649908
+3658,32811.46575,811.5479452,504.3835616,1068.246575,30446.31507,676.7123288,1158.39726,1619.753425,16817.68493,522.5068493,2470.753425,1816.630137,21465.0411,1182.520548,4888.424658,2835.808219,8179.260274,1262.356164,303.1917808,2521.890411,16653.63014,525.7671233,208.6438356,3375.90411,21069.58904,468.5479452,956.3972603,1968.246575,15976.83562,2324.561644,449.1780822,2841.424658,13677.58904,615.4657534,267.1917808,1130.90411,9505.712329,1024.753425,405.6986301,1309.671233,6122.876712,616.1506849,160.3287671,2928.561644,5947.739726,1234.150685,281.109589,3255.109589,940.9315068,773.8493151,73,10.5195456,9.675388005,0.392496691,0.901234568,0.506944444,1.51609009
+3659,34687.71756,821.9618321,484.3816794,1094.885496,19754.29771,539.5954198,564.6870229,1432.053435,8967.717557,410.0152672,1197.519084,1720.923664,12920.51908,997.7328244,7159.290076,2184.641221,5004.412214,1037.641221,244.389313,2369.839695,9769.870229,1988.534351,150.8244275,1616.526718,12182.51145,413.610687,146.8931298,1651.091603,9109.351145,1963.603053,394.6793893,2795.083969,7290.633588,537.7633588,222.5725191,838.7862595,4857.923664,1041.435115,344.2977099,1266.625954,2662.763359,554.8549618,139.0992366,1815.992366,2761.038168,996.1221374,238.1068702,3027.748092,1041.183206,775.1068702,131,13.53352079,12.63227712,0.358820553,0.95620438,0.623809524,0.861043488
+3660,30693.71354,1210.65625,620.0729167,1177.90625,20620.76563,853.8020833,496.015625,1941,10311.73958,643.625,759.375,1736.729167,13322.375,1411.3125,6302.729167,2693.942708,5245.213542,1432.854167,346.0572917,2504.505208,11112.97396,452.890625,628.2604167,592.3802083,13271.36458,459.8385417,153.1354167,4595.088542,10102.45313,3945.833333,383.4270833,2820.703125,8771.328125,662.7864583,345.0885417,1313.864583,4705.3125,1031.546875,462.3333333,1321.416667,3449.880208,1146.244792,179.8072917,2490.046875,3293.557292,1424.973958,194.234375,3310.088542,220.78125,781.703125,192,22.84980378,12.30016339,0.842750104,0.872727273,0.491048593,-0.512846772
+3661,19288.29655,1143.896552,562.4413793,1053.448276,14902.91724,701.5655172,397.3724138,1388.689655,6899.406897,587.1241379,735.8965517,1694.593103,9110.082759,1256.386207,5526.02069,3177.406897,3390.255172,1214.37931,281.2689655,2340.731034,7360.089655,344.1724138,839.2275862,472.9517241,9109.517241,397.3448276,121.3034483,5107.275862,6366.186207,1675.234483,433.0206897,2816.103448,5508.662069,533.2965517,244.9448276,1295.351724,3209.331034,842.8206897,371.7103448,1301.793103,2578.434483,782.2758621,150.337931,3577.751724,2251.158621,1099.634483,257.7931034,3341.448276,231.4896552,780.0275862,145,20.09271826,9.692860422,0.8759474,0.911949686,0.604166667,-0.203625889
+3662,26796.68504,799.3228346,518.8188976,1078.188976,25221.9685,657.1574803,460.9606299,1563.755906,14017.82677,519.4251969,468.496063,1787.755906,16924.83465,1195.23622,5078.559055,2358.527559,6114.015748,1370.023622,349.2992126,2337.204724,13318.31496,381.2283465,479.6220472,436.0629921,15609.92913,407.8110236,125.7952756,3596.086614,12396.54331,1877.874016,665.2677165,2806.480315,10926.29134,615.976378,282.0787402,1218.181102,7214.992126,970.511811,417.1259843,1312.181102,5439.88189,691.1102362,165.8110236,2908.228346,5009.582677,1293.299213,365.9212598,3301.637795,335.007874,777.0708661,127,14.31514147,11.80831594,0.565303582,0.920289855,0.604761905,-0.519737356
+3663,33222.02703,1028.891892,533.7567568,1090.716216,29319.7027,782.027027,702.2972973,1599.837838,17335.17568,618.027027,767.972973,1764.851351,20950.94595,1376.959459,4047.189189,2425.986486,7927.310811,1411.081081,352.5,2342.891892,16316.83784,426.9054054,640.6486486,738.3108108,19950.18919,431.1486486,247.1216216,2304.216216,15301.08108,1883.959459,535.1081081,2827.689189,13396.5,653,311.6081081,1397.5,9546.972973,943.8513514,464.8783784,1347.135135,7013.945946,773.9189189,181.7432432,3492.22973,6500.459459,1430.310811,797.1891892,3393.324324,391.5540541,775.2837838,74,12.26088639,8.292636257,0.736581462,0.936708861,0.632478632,0.024836082
+3664,32448.67391,900.673913,808.2826087,1125.688406,28438.47826,701.9927536,827.6956522,1680.282609,15830.78261,535.9710145,605,1752.463768,20507.69565,1301.086957,2940.166667,2960.637681,7393.652174,1361.913043,306.9637681,2456.985507,15716.10145,561.9782609,155.3333333,721,19484.12319,458.8043478,123.4710145,2662.775362,14525.07971,1718.036232,700.6449275,2809.717391,12902.67391,729.615942,290.0869565,1750.905797,9243.34058,1047.210145,429.942029,1332.57971,7025.434783,613.9710145,162.9710145,2406.094203,6326.347826,1378.289855,552.0507246,3407.413043,584.5507246,777.5,138,15.74154341,11.9292737,0.652462401,0.867924528,0.676470588,0.467448285
+3665,29803.95767,1067.968254,522.5820106,1070.597884,27874.57143,731.5767196,630.2751323,1530.47619,15636.86772,574.7724868,1155.756614,1717.063492,20049.97884,1313.973545,3494.402116,2759.603175,6822.216931,1407.206349,358.3174603,2437.333333,15381.66667,415.7354497,125.5555556,876.3333333,19045.88889,607.1534392,291.1798942,1370.074074,14393.86243,1923.804233,524.1904762,2776.216931,12584.12698,611.2328042,261.021164,1293.37037,9094.910053,1262.962963,387.0899471,1311.248677,6878.42328,605.2804233,152.7566138,1955.079365,6224.21164,1277.402116,429.6984127,3298.73545,650.1269841,778.2169312,189,21.69924037,12.17529637,0.827752628,0.825327511,0.525,1.081123021
+3666,34525.4918,925.1147541,587.1967213,1108.04918,32416.96721,751.5409836,655.6065574,1662.180328,19261.34426,583.8032787,447.0163934,1753.852459,23888.60656,1389.721311,2096.95082,2470.770492,7865.688525,1624.983607,415.7868852,2411.918033,19155.65574,463.9836066,175.0163934,551.1967213,23987.70492,473.4754098,125.0819672,2258.704918,18228.96721,1515.42623,592.7540984,2815.442623,15962.2459,675.4590164,297.852459,1666.918033,11951.88525,1099.606557,440.2459016,1314.967213,8757.229508,650.9508197,169.704918,1473.459016,7882.721311,1495.098361,2202.491803,3214.52459,712.4590164,773.852459,61,10.24440349,8.39525508,0.57308387,0.884057971,0.554545455,0.445904025
+3667,21121.36232,1088.550725,775.8405797,1136.811594,19243.21739,780.6376812,706.3768116,1654.797101,10197.13043,606.1014493,1037.347826,1744.637681,12706.53623,1376.73913,2638.449275,2338.927536,4424.391304,1357.666667,342.0289855,2514.072464,9485.347826,445.6376812,213.3333333,679.6811594,11153.10145,447.1449275,121.3913043,928.9275362,8353.695652,1406.043478,471.7971014,2819.492754,7305.014493,654.884058,273.7101449,1398.913043,5291.101449,1014.463768,419,1352.57971,3876.681159,627.2608696,171.6811594,1881.391304,3222.855072,1344.391304,156.826087,3340.898551,777.6811594,776.0289855,69,11.24491057,8.251418527,0.67937486,0.907894737,0.530769231,0.194113331
+3668,28776.04167,825.1041667,502.2291667,1057.458333,25899.82292,668.90625,858.1666667,1530.645833,14104.94792,895.1979167,1601.385417,1739.135417,19390.20833,1221.28125,3546.385417,2634.3125,7250.395833,1308.291667,386.875,2417.708333,14289.98958,409.6041667,1606.270833,1365.979167,17896.53125,441.4479167,127.2604167,1308.395833,13963.13542,2236.40625,476,2785.40625,11938.875,736.4895833,277.5520833,1119.052083,8271.729167,1318.177083,416.90625,1391.739583,5191.489583,935.46875,160.6666667,2984.270833,5160.739583,1285.614583,349.03125,3171.208333,959.4479167,775.1979167,96,12.23602482,10.13786094,0.559951048,0.941176471,0.671328671,1.283718796
+3669,33719.34392,795.1640212,545.031746,1078.587302,25661.55026,599.8994709,668.2169312,1521.529101,11004.49206,441.8783069,1584.78836,1721.851852,16975.28571,1079.21164,5098.878307,2856.26455,6412.867725,1136.084656,278.6666667,2476.820106,13054.39153,387.8677249,660.3703704,1271.169312,15820.56085,839.2539683,116.4232804,2223.095238,12019.92593,1971.042328,394.015873,2797.42328,9718.582011,648.1058201,240.005291,843.1375661,5564.354497,1207.851852,362.7724868,1285.708995,3001.529101,665.8783069,143.3280423,2220.179894,3309.640212,1064.603175,1207.724868,3083.269841,1068.920635,779.3121693,189,18.72492161,13.26541756,0.705774576,0.908653846,0.63,-0.184115737
+3670,48907.8,1074.225,559.85,1130.85,44836.025,840.825,834.925,1691.075,25338.5,657.525,1794.275,1799.975,30869.125,1490.825,3225.875,4099.4,11084.175,1514.925,362.925,2463.5,24262.15,453.425,390.375,1453.75,29687.275,1165,552.275,1617.425,22448.675,2166.65,580.5,2838.675,19757.475,653.875,341.625,1399.1,13889.625,1207.025,499.675,1320.975,10686.125,728.925,187.425,2971.925,9044.85,1507.3,474.65,3392.4,398.2,776,40,8.982246515,6.346593381,0.707642326,0.952380952,0.571428571,-0.130173645
+3671,23525.87619,1035.609524,998.7619048,1180.752381,21859.6381,788.4952381,1037.142857,1750.542857,11922.67619,602.5333333,656.8571429,1768.114286,15455.28571,1411.571429,1649.190476,1251.52381,5483.266667,1451.333333,345.6190476,2412.866667,12024.97143,523.5238095,183.1238095,496.552381,14979.47619,540.2190476,163.5714286,1159.409524,11105.1619,1646.67619,641.0666667,2820.961905,9622.4,803.2666667,310.7142857,1953.019048,7228.228571,954.4761905,461.9619048,1368.190476,5642.657143,655.4952381,177.2095238,1441.904762,5052.847619,1467.504762,316.2285714,3444.895238,532.6666667,777.152381,105,12.02480735,11.17810133,0.368603464,0.990566038,0.673076923,-0.667065399
+3672,20650.56835,814.6043165,608.0503597,1068.741007,18947.35252,654.5755396,761.7482014,1536.374101,10323.28058,620.0071942,717.5683453,1719.683453,14103.03597,1210.647482,3529.28777,2131.366906,4901.496403,1625.273381,407.5827338,2419.589928,10856.31655,409.9064748,410.8705036,591.2374101,13236.34532,932.8417266,115.9640288,1321.266187,9974.280576,1414.805755,531.5395683,2791.964029,8776.223022,829.8705036,257.2661871,1391.884892,6549.820144,1142.597122,393.8920863,1321.244604,4914,667.9064748,150.5323741,2128.115108,4487.05036,1278.863309,234.9064748,3184.503597,749.1007194,778.2517986,139,15.90525745,11.64974414,0.680824998,0.896774194,0.579166667,-0.390426938
+3673,24754.26506,837.6506024,706.6144578,1114.26506,21314.98795,672.8313253,772.0481928,1607.807229,12277.77108,706.4698795,457.8674699,1736.192771,16328.68675,1224.807229,1867.674699,1231.73494,5851.481928,1326.180723,299.6987952,2357.289157,12295.9759,935.2771084,379.4457831,473.3975904,15426.12048,499.5180723,118.939759,856.3855422,11582.13253,1429.939759,475.6144578,2797.518072,10161.39759,2710.626506,266.1807229,1468.048193,7538.626506,922,412.0120482,1336.650602,5393.795181,681.1686747,158.0843373,1704.542169,5121.445783,1315.084337,272.3855422,3212.674699,804.2048193,775.0963855,83,10.7797939,10.37084852,0.272824885,0.943181818,0.628787879,0.630127271
+3674,37970.48529,796.8970588,486.5735294,1065.235294,28795.08824,629.9264706,780.9117647,1580.602941,13212.19118,466.8382353,2180.514706,1738.544118,19045.95588,1116.323529,7801.308824,3361.132353,7449.764706,1169.970588,289.7794118,2326.323529,15019.44118,382.8382353,483.6323529,1646.955882,18462.41176,592.5735294,126.7058824,1672.014706,13771.30882,2530.691176,413.3529412,2826.338235,11230.19118,551.1029412,250.9264706,835.5441176,6798.5,1516.882353,372.8970588,1288.838235,3609.764706,657.9705882,153.1470588,1845.058824,3968.823529,1102.367647,160.0588235,3148.529412,1059.382353,774.6470588,68,10.55349291,9.05199792,0.514108259,0.931506849,0.618181818,1.363689212
+3675,33622.77037,907.3851852,594.5037037,1098.214815,30807.68889,796.4222222,912.7481481,1671.014815,16960.85926,579.1925926,1633.540741,1862.140741,21120.45926,1312.659259,6093.474074,5104.340741,7609.459259,1398.466667,347.2074074,2387.4,16843.05926,428.0222222,1740.088889,1142.288889,19874.07407,690.6518519,321.6296296,4277.377778,15346.74074,2054.133333,468.5481481,2819.207407,13700.62222,726.6444444,315.5333333,1512.77037,8746.4,1334.844444,441.7851852,1339.185185,6729.37037,976.7407407,178.7851852,6776.17037,6056.133333,1427.192593,2863.733333,3360.992593,309.7925926,777.6074074,135,19.54454601,9.474179463,0.874653865,0.85443038,0.681818182,1.395680353
+3676,31618.96296,1049.555556,965.9506173,1198.777778,29529.7037,824.5308642,1101.975309,1811.950617,15836.92593,611.6790123,646.4074074,1845.975309,20561.67901,1475.518519,1688.851852,1898.320988,7352.802469,1546.975309,357.9753086,2427.148148,16287.08642,562.345679,241.5925926,588.0987654,19997.14815,705.5432099,141.7777778,1668.049383,14823.37037,1648.197531,568.2469136,2814.777778,12999.88889,1009.666667,329.1481481,1770.148148,9718.135802,943.691358,475.6296296,1352.296296,7536.024691,695.8641975,177.6666667,1643.493827,6704.37037,1552.197531,291.962963,3490.506173,552.7037037,777.1728395,81,11.25616624,9.501593509,0.536148913,0.952941176,0.669421488,-0.870713437
+3677,22667.74227,1017.164948,509.1237113,1050.505155,20880.52577,726.6597938,431.1958763,1455.742268,11692.3299,577.4536082,489.9587629,1692.134021,15013.3299,1358.927835,2036.762887,1557.247423,5176.412371,1464.154639,387.3402062,2320.443299,11125.72165,404.3505155,241.0721649,506.2371134,13564.52577,456.6701031,123.4020619,2080.793814,10214.4433,1449.237113,595.8865979,2775.329897,8855.742268,605.8453608,269.2268041,1414.701031,6466.041237,869.7938144,389.628866,1297.824742,4898.381443,622.6082474,157.814433,1072.226804,4239.020619,1293.082474,2135.587629,3247.896907,666.6391753,778.4536082,97,14.21464,8.966815618,0.775932839,0.950980392,0.577380952,0.68183435
+3678,34983.77439,962.4573171,595.0670732,1116.22561,31305.56707,744.6097561,780.4817073,1669.670732,18383.71341,577.0487805,792.1097561,1737.115854,23517.08537,1368.426829,2592.756098,2602.981707,7685.54878,1550.109756,421.5609756,2390.213415,17457.10976,442.6158537,230.152439,922.7987805,21350.0122,980.804878,128.2865854,2344.27439,16453.81098,1565.402439,683.5609756,2793.170732,14200.95122,671.0426829,297.6890244,1712.170732,10489.70732,1346.164634,430.3536585,1295.646341,7612.890244,666.695122,167.5,3058.932927,6601.402439,1412.054878,1826.457317,3248.579268,724.3902439,777.9817073,164,19.43111005,11.13945799,0.819359848,0.877005348,0.663967611,1.550711167
+3679,25266.30526,868.2105263,710.0947368,1127.378947,22346.49474,701.4736842,689.1263158,1633.515789,12467.09474,518.4105263,445.0631579,1719.673684,16006.57895,1284.873684,1347.210526,1114.242105,6082.284211,1353.768421,320.8315789,2350.147368,12420.81053,419.1684211,121.7263158,503.4210526,15159.62105,451.8421053,126.7052632,1148.452632,11811.88421,1424.157895,453.1894737,2806.221053,10156.07368,612.0105263,280.8842105,1186.768421,7044.947368,813.4210526,419.2631579,1307.263158,4825.094737,612.7578947,161.5894737,1214.473684,4566.515789,1343.957895,2505.736842,3218.757895,893.9789474,777.9789474,95,14.25856119,8.65510421,0.79469339,0.940594059,0.608974359,0.639025689
+3680,32213.33158,844.3421053,577.0105263,1081.410526,28900.25789,698.8684211,1276.852632,1614.810526,16139.9,524.0421053,2627.047368,1832.494737,21129.17895,1235.036842,4766.610526,3457.278947,7714.084211,1288.431579,310.3473684,2682.073684,15852.75263,807.8052632,177.5526316,1490.921053,19461.29474,458.2947368,839.9315789,3044.663158,15187.56842,2773.194737,481.1105263,2796.926316,12835.90526,605.6894737,275.3526316,1189.936842,9013.057895,1116.889474,412.7631579,1294.410526,5696.763158,631.2473684,159.8842105,4752.457895,5622.457895,1265.2,401.4210526,3250.989474,927.7684211,780.5263158,190,18.09400854,14.85759873,0.570735997,0.855855856,0.620915033,0.512422955
+3681,25016.82661,784.0201613,612.0040323,1090.427419,20693.29435,596.4677419,510.2177419,1624.733871,8133.524194,449.2379032,771.6451613,1717.25,13283.67742,1075.165323,3740.181452,2098.552419,4978.983871,1140.052419,265.358871,2295.258065,9696.165323,872.5524194,1019.153226,651.9233871,11674.18548,467.5241935,111.4959677,1495.875,8823.814516,1844.991935,428.1451613,2810.935484,6949.915323,1309.370968,237.0201613,881.2903226,3780.701613,1245.044355,352.108871,1286.620968,2035.197581,761.6290323,142.3709677,2555.83871,2247.649194,1044.189516,265.3225806,3127.737903,1081.258065,782.8427419,248,24.79679162,13.64928747,0.834870963,0.882562278,0.536796537,-0.607709071
+3682,27097.6069,909.737931,450.4896552,1033.268966,25623.27586,696.0758621,717.3793103,1468.813793,14512.71724,540.5310345,1177.944828,1669.813793,18514.82759,1342.137931,2446.427586,3151.510345,6351.4,1474.082759,393.6,2790.068966,14091.04138,409.9724138,115.9448276,1341.2,17490.17241,775.8,117.8137931,1382.786207,13234.47586,1632.682759,572.5241379,2786.006897,11572.11034,588.2827586,269.3103448,1433.924138,8562.558621,1163.924138,401.2413793,1308.131034,6414.537931,602.5586207,164.0758621,1642.206897,5722.462069,1411.786207,3157.744828,3109.737931,706.1034483,782.5172414,145,17.86549437,11.39690788,0.770095604,0.90625,0.50877193,-0.339580596
+3683,31464.09091,861.5909091,544.530303,1102.484848,28529.59091,678.7424242,651.4090909,1622.939394,15973.43939,541.6666667,448.0909091,1774.136364,21013.93939,1248.348485,991.0606061,1058.757576,7629.166667,1293.530303,304.8636364,2339.954545,15963.43939,513.2878788,192.6363636,529.8636364,19683.15152,525.3484848,120.0454545,791.969697,14747.06061,1397.818182,479.5757576,2879.787879,13008.89394,1825.378788,287.6363636,1469.30303,9543.712121,970.2727273,418.6818182,1332.621212,7020.363636,658.7727273,163.8333333,1280.545455,6410.484848,1380.621212,396.6818182,3244.30303,795.6666667,777.6363636,66,10.38809552,8.735857334,0.541114567,0.857142857,0.66,0.821466009
+3684,20093,795.6899225,773.6899225,1090.379845,19230.24806,643.5813953,983.4418605,1591.627907,9848.116279,489.744186,1092.015504,1776.643411,13462.69767,1173.077519,6274.224806,2785.682171,5391.20155,1265.217054,290.627907,2407.348837,10059.0155,1460.891473,168.5581395,972.5116279,12671.68217,470.3565891,126.8062016,3095.868217,9530.193798,2004.108527,487.5503876,2797.348837,8133.48062,647.8062016,253.496124,1373.891473,5808.062016,1074.108527,395.2325581,1301.108527,3890.868217,631.9224806,154.7286822,3714.27907,3730.116279,1193.325581,257.0232558,3252.844961,915.6589147,782.4806202,129,19.18000171,9.069735314,0.881129746,0.934782609,0.678947368,0.177472434
+3685,34592.9375,869.046875,541.4166667,1081.21875,16147.10938,473.5625,367.359375,1283.651042,7383.8125,394.8385417,610.515625,1654.270833,10031.39583,941.2552083,6245.057292,2492.223958,3758.572917,987.2604167,226.828125,2344.958333,7498.6875,251.828125,164.2916667,416.2552083,8977.015625,361.3125,101.3697917,4212.59375,6417.947917,1399.40625,333.6770833,2790,5514.192708,470.0833333,210.9270833,972.2760417,2509.729167,642.109375,328.9947917,1262.234375,1867.8125,531.546875,135.4166667,1881.625,1799.317708,948.390625,124.1354167,3008.369792,191.8385417,780.53125,192,17.74282366,14.00628965,0.613871589,0.96,0.673684211,1.519801967
+3686,43668.02041,1028.306122,595.5,1126.153061,39921.5102,827.8163265,1043.479592,1654.316327,22609.4898,617.9387755,1252.897959,1786.132653,28202.44898,1433.969388,2818.918367,3248.55102,9952.714286,1595.734694,359.3979592,2520.234694,21602.96939,1191.693878,821.7959184,1117.755102,26645.05102,532.8265306,546.8061224,2389.887755,20379.77551,1892.081633,600.3673469,2815.857143,18011.37755,687.255102,342.755102,1624.530612,12802.10204,1090.622449,490.0408163,1365.653061,9603.030612,887,188,3785.030612,8475.642857,1540.520408,291.8571429,3359.877551,445.0306122,777.6632653,98,16.76519985,8.053194291,0.877075896,0.852173913,0.6125,1.373948419
+3687,30784.27536,967.5217391,870.9710145,1143.333333,26378.28986,766.5217391,798.8115942,1683.84058,15584.78261,590.5362319,469.8695652,1720.565217,20261.62319,1427.753623,907.3768116,941.0434783,7082.884058,1523.188406,344.2463768,2344.971014,15509.6087,492.7391304,209.7101449,490.0869565,18888.52174,471.2028986,132.4637681,791.2318841,14588.18841,1521.449275,480.0869565,2831.101449,12724.92754,697.7681159,311.6231884,1641.608696,9354.550725,865.3478261,452.4492754,1332.391304,6743.072464,671,176.4202899,1225.014493,6504.681159,1509.898551,159.057971,3316.231884,786,778.2173913,69,11.62506517,7.597690743,0.756873733,0.971830986,0.766666667,-0.62110477
+3688,22723.90625,989.578125,785.8125,1113.536458,19545.84896,706.9791667,839.4895833,1579.921875,10982.30208,569.03125,919.453125,1783.083333,14084.54688,1230.348958,2655.510417,2613.104167,5139.505208,1247.796875,293.9583333,2710.916667,10487.23438,4691.578125,359.2395833,865.5,12650.28646,1146.020833,121.3385417,1840.989583,9705.796875,1623.505208,475.9322917,2806.463542,8240.572917,1354.276042,259.4739583,1456.46875,5936.15625,1224.432292,388.5625,1323.598958,4176.338542,664.0520833,153.7708333,4587.494792,3855.302083,1195.34375,250.3333333,3394.401042,846.0416667,782.3229167,192,19.46786253,12.90889156,0.748542109,0.927536232,0.666666667,-0.481241409
+3689,35304.18462,936.6769231,549.2615385,1107.492308,29611.96923,776.4461538,1057.415385,1682.492308,17547.53846,562.7846154,2133.492308,1799.476923,21954.95385,1354.153846,3601.538462,2575.784615,7853.292308,1467.261538,315.3230769,2560.123077,16506.98462,441.9692308,203.7538462,3065.107692,20737.23077,540.4,1455.569231,1819.353846,15955.55385,2387.707692,496.4153846,2799.369231,13669.90769,674.2769231,292.2,1437.307692,9782.061538,1242.107692,437.9538462,1318.2,6632.061538,648.9230769,179.8615385,7974.169231,6061.892308,1366.415385,960.5230769,3318.569231,860,778.8461538,65,10.55892468,7.899831292,0.66351129,0.955882353,0.656565657,-0.615495073
+3690,33409.39216,782.4019608,507.4215686,1060.872549,30761.0098,809.5490196,1030.127451,1643.77451,15411.43137,492.2745098,2453.764706,1880.039216,20818.21569,1163.333333,6631.431373,3241.176471,7884.039216,1277.352941,298.4607843,2529.039216,15662.54902,399.2843137,384.3431373,2837.960784,19936.7451,540.8529412,649.2058824,3653.735294,15204.71569,2514.362745,481.3529412,2873.892157,12335.5098,581,268.4215686,1111.882353,8415.980392,1126.303922,391.7352941,1297.676471,4890.294118,685.8823529,158.2254902,5024.941176,4917.460784,1195.04902,406.0784314,3228.264706,1008.460784,779.0196078,102,16.78899404,8.367824705,0.866940687,0.935779817,0.566666667,-1.00545256
+3691,24117.56122,1003.234694,526.9897959,1032.102041,21573.62245,677.3979592,470.0102041,1517.193878,11382.64286,547.8163265,516.3877551,1722.642857,14717.16327,1244.255102,4932.306122,2731.285714,5430.010204,1273.234694,298.2857143,2313.755102,11371.7449,359.744898,256.744898,466.3979592,13951.30612,526.7857143,125.3367347,4226.265306,10285.93878,1458.785714,381.8265306,2807.938776,9004.142857,583.377551,264.3061224,1192.22449,5520.081633,784.9387755,406.2857143,1306.081633,4180.744898,634.2346939,156.8877551,2993.908163,3605.5,1189.755102,137.2142857,3404.673469,260.8877551,780.0510204,98,13.03062612,9.802142612,0.658890569,0.942307692,0.7,1.473707455
+3692,54093.69014,992.8732394,563.1830986,1146.056338,50499.23944,807.4366197,880.7887324,1745.774648,28410.98592,639.9577465,1112.112676,1771.408451,34699.59155,1489.239437,4405.084507,3861.549296,12385.11268,1546,367.084507,2418.042254,27093.39437,952.2957746,172.4507042,717.6056338,32257.61972,538.3661972,145.4084507,2268.774648,25615.67606,1980.661972,507.1126761,2842.943662,22377.26761,1089.985915,371.6056338,1239.661972,15661.69014,1154.788732,512.5211268,1317.690141,11729.84507,689.3802817,194.2253521,1971.56338,10420.85915,1552.676056,235.1126761,3426.830986,363.8309859,778.7464789,71,12.86389763,7.699885676,0.801073847,0.845238095,0.606837607,-1.32300983
+3693,19257.01875,815.2125,500.48125,1047.8125,17639.3875,664.31875,582.68125,1482.99375,9853.61875,505.8375,485.80625,1731.825,12476,1202.75,2578.15,1916.1,4537.5125,1377.675,300.5625,2346.9625,9829.1375,965.8125,576.56875,492.375,11836.63125,430.39375,126.275,1191.9625,9209.1875,1809.225,894.875,2810.21875,8102.14375,666.0625,273.175,1648.24375,5731.875,916.2375,421.88125,1372.6375,4436.29375,751.9375,166.35,3250.0875,4047.7125,1398.70625,4356.16875,3223.35625,414.64375,781.90625,160,16.37987766,12.58285969,0.640221826,0.958083832,0.769230769,-0.195288375
+3694,30409.64407,898.6949153,665.8813559,1087.355932,27157.01695,727.0508475,588.8474576,1577,15475.74576,546.3559322,1459.762712,1701.542373,18829.66102,1334.79661,2929.949153,4309.915254,7105.20339,1738.389831,333.0508475,2595.033898,15316.40678,427.2033898,461.9661017,1009.237288,19049.49153,1284.372881,136.9152542,3918.559322,14068.88136,1554.508475,615.0847458,2807.220339,12446.0678,605.220339,303.8135593,1739.338983,8958.915254,1195.813559,441.8305085,1342.220339,6721.59322,756.9322034,178.6440678,3893.745763,6158.644068,1488.254237,287.5084746,3182.813559,434.1694915,779.0677966,59,10.75232655,7.285233875,0.735477141,0.936507937,0.595959596,0.878243705
+3695,27206.7381,868.0079365,798.3571429,1124.111111,23525.19048,662.1984127,754.0714286,1578.357143,13185.52381,538.5634921,739.8492063,1777.277778,16656.90476,1222.619048,1636.063492,1608.722222,6247.468254,1302.65873,282.2142857,2389.690476,13029.57143,715.8730159,289,635.1111111,15895.7381,531.3968254,116.3571429,1022.785714,11815.96825,1517.849206,548.0873016,2809.5,10294.5873,836.8174603,263.6666667,1448.833333,7423.912698,1242.619048,395.3412698,1321.095238,5784.984127,633.3095238,149.8253968,2254.674603,5065.079365,1291.555556,364.6428571,3271.222222,595.2301587,782.484127,126,15.277467,10.71276225,0.712951598,0.90647482,0.763636364,0.024585528
+3696,29309.88506,941.4712644,685.2068966,1099.183908,25330,765.3563218,849.137931,1593.908046,14232.36782,614.7011494,1156.908046,1835.609195,18208.22989,1287.103448,3619.333333,2269.367816,6532,1305.747126,300.6666667,2411.747126,14172.27586,2079.45977,378.4597701,1227.229885,16931.34483,1026.862069,732.816092,2314.252874,13320.42529,2053.252874,547.7931034,2800.528736,11633.91954,709.5057471,271.5172414,1498.413793,8330.632184,1001.563218,406.2528736,1315.609195,6427.310345,690.2988506,155.7356322,3837.609195,5696.563218,1313.862069,392.3793103,3320.37931,618.4367816,780.4712644,87,11.88592826,9.80636497,0.565074488,0.925531915,0.659090909,-1.108554525
+3697,27086.24176,1124.78022,1141.252747,1173.912088,21648.67033,729.3626374,874.4725275,1716.395604,11974.76923,575.9010989,605.7582418,1794.868132,14981.36264,1313.824176,1917.252747,1476.956044,5382.263736,1301.483516,298.2307692,2421.868132,11410.17582,479.4175824,131.3516484,561.9340659,13488.98901,644.7252747,124.7252747,1786.934066,10264.65934,1517.527473,531.8791209,2799.021978,9149,662.1428571,260.6703297,1393.857143,6616.098901,809.4285714,388.043956,1317.10989,5042.692308,587.7692308,151.5274725,2271.692308,4359.549451,1232.076923,188.0989011,3394.175824,628.9230769,779.7582418,91,12.44342219,9.909457648,0.604821432,0.900990099,0.689393939,-0.926614349
+3698,36605.49587,846.446281,521.2975207,1073.421488,31862.06612,675.5454545,896.3636364,1546.842975,18706.34711,792.6363636,1532.603306,1763.520661,23999.04959,1262.818182,3787.016529,3395.181818,8026.661157,1533.214876,405.3305785,2454.07438,18601.24793,397.3636364,407.8347107,1202.396694,22393.41322,1185.14876,123.8264463,1245.066116,17353.54545,1810.173554,515.446281,2802.297521,15084.46281,690.3719008,276.9669421,1306.363636,11095.2562,1676.008264,415.107438,1370.553719,7874.487603,703.8016529,164.7190083,2942.661157,7456.008264,1333.264463,232.2644628,3206.214876,760.1487603,781.8016529,121,14.430144,11.48670664,0.605268186,0.876811594,0.576190476,1.089968967
+3699,18113.74138,872.7471264,729.9482759,1102.224138,16103.01724,679.4712644,853.7126437,1614.810345,9130.195402,572.3390805,456.6781609,1741.781609,12182.28736,1238.689655,1515.695402,1059.37931,4517.689655,1280.563218,307.5977011,2355.936782,9137.729885,423.2701149,409.9137931,505.4252874,11124.8908,464.2241379,119.5517241,836.7413793,8684.804598,1496.247126,460.408046,2807.103448,7516.982759,1023.264368,266.1321839,1381.212644,5584.390805,771.8793103,409.908046,1339.155172,4013.063218,687.9137931,156.6609195,1472.270115,3861.948276,1326.086207,664.454023,3220.304598,824.908046,781.9885057,174,15.97398337,13.99360173,0.482266495,0.945652174,0.682352941,0.927165565
+3700,24684.46875,789.1875,686.0625,1125.71875,22401.76563,636.484375,796.046875,1739.234375,11976.42188,483.671875,878.546875,1768.8125,16629.71875,1149.34375,2974.4375,1718.109375,6035.9375,1216.4375,285.6875,2394.625,12109.84375,7848.5,161.328125,1021.765625,14850.9375,494.484375,170.40625,3140.796875,11413.89063,1714.265625,496.140625,2807.71875,9599.28125,596.59375,258.421875,1163.65625,6819.4375,817.1875,393.03125,1295.265625,4332.703125,614.28125,154.0625,3565.828125,4203.3125,1208.203125,155.921875,3217.625,937.84375,781.71875,64,12.22500712,7.13392956,0.812075645,1,0.666666667,0.457337695
+3701,19839.32609,820.8913043,1095.652174,1156.891304,17598.25,652.4347826,967.4347826,1759.206522,9436.782609,903.5869565,909.0326087,1782.271739,13345.04348,1165.271739,2517.956522,2208.717391,4938.326087,1288.184783,392.0543478,2750.902174,9576.358696,441.0652174,1278.847826,876.2282609,11664.11957,453.6304348,124.4347826,1592.826087,9181.206522,1939.923913,436.3913043,2817.26087,7825.434783,730.2717391,262.1847826,1251.586957,5420.391304,892.75,405.8586957,1423.847826,3507.293478,868.8478261,154.1304348,2938.434783,3475.163043,1235.054348,202.923913,3321.728261,948.5869565,780.0108696,92,11.45253469,10.27551172,0.441571662,0.968421053,0.696969697,-1.086564678
+3702,26517.70085,720.6410256,494.1623932,1020.615385,19459.5641,549.6923077,690.5641026,1443.649573,8553.452991,419.7863248,2169.282051,1756.444444,12870.28205,1051.017094,7055.384615,3164.752137,4936.299145,1059.102564,246.957265,2390.675214,9837.034188,382.7863248,306.957265,1676.709402,12413.90598,454.7692308,110.0769231,2430.273504,9195.717949,2737.649573,427.025641,2787.179487,7356.324786,531.6239316,227.4700855,819.0598291,4645.162393,1337.111111,353.6324786,1276.350427,2554.333333,581.6752137,139.8205128,3514.581197,2751.683761,1013.982906,598.4358974,3102.034188,1054.017094,781.5897436,117,16.07475804,9.433450257,0.809696639,0.991525424,0.596938776,0.749711496
+3703,42566.78571,1087.650794,576.9365079,1107.269841,41739,815.6269841,1116.81746,1599.968254,23038.28571,629.3333333,982.6031746,1750.555556,28642.75397,1417.293651,3305.833333,2937.333333,10195.44444,1508.555556,357.047619,2375.65873,22290.94444,453.3650794,327.8492063,778.0555556,27079.79365,525.8650794,875.047619,2155.595238,21096.24603,2020.81746,620.4365079,2825.15873,18350.31746,657.8412698,329.7698413,1464.103175,12952.18254,1043.611111,482.5079365,1339.706349,9821.071429,717.0238095,184.0634921,2910.388889,8621.642857,1510.238095,2257.111111,3450.539683,401.1190476,782.6349206,126,19.94732197,8.677592831,0.900418154,0.887323944,0.570135747,-1.047604445
+3704,28600.5875,977.9375,667.95,1138,25927.725,752.4625,666.275,1626.2625,14296.8125,582.1,525.8875,1771.6875,18463.725,1363.8125,1905.2625,1977.2,6588.0375,1445.0375,325.725,2405.9,14169.7625,518.45,133.9125,462.475,17228.9625,500.6375,130.775,1837.3375,13145.2875,1471.825,559.825,2831.0375,11621.675,756.45,306.425,2118,8329.75,927.65,468.8625,1335.625,6528.2875,636.625,169.525,2053.8625,5640.2375,1426.8375,173.025,3374.0625,484.7625,780.7,80,11.31928732,9.556737649,0.535889814,0.941176471,0.555555556,0.962143343
+3705,37661.33155,801.9411765,505.9411765,1077.775401,31567.82353,787.4385027,926.486631,1593.898396,15271.77005,469.9839572,1823.823529,1820.705882,21444.29412,1114.203209,5948.893048,2655.764706,7977.786096,1212.336898,285.8449198,2470.609626,15936.1016,391.8663102,541.7326203,2089.262032,20023.72727,409.5347594,700.2834225,2754.588235,15563.48663,2261.994652,519.8983957,2830.957219,12509.19251,564.6417112,258.8823529,986.657754,8354,1025.508021,386.7165775,1293.508021,4795.176471,679.7326203,152.5989305,3745.802139,4897.994652,1143.86631,412.9572193,3180.395722,1015.224599,786.1390374,187,18.07846808,14.51125903,0.596407389,0.89047619,0.519444444,-0.716060437
+3706,24212.46409,747.7403315,466.6519337,1069.359116,22077.58564,630.6132597,465.4364641,1609.077348,10112.83978,458.198895,567.4640884,1729.033149,14390.61878,1100.022099,3996.044199,1788.740331,5619.430939,1167.690608,335.6298343,2404.78453,10768.48619,5392.513812,1515.281768,614.1767956,13676.22652,514.6629834,125.4475138,1974.143646,10208.39779,1654.254144,482.679558,2807.237569,8168.220994,643.5524862,249.4585635,953.7845304,5429.149171,804.679558,371.519337,1312.790055,3032.790055,914.7679558,147.3480663,2600.513812,3111.662983,1113.027624,677.4861878,3217.895028,1029.342541,782.6243094,181,16.59016751,15.14755334,0.407861013,0.923469388,0.560371517,1.062195603
+3707,25862.16197,922.5633803,577.5140845,1103.78169,24749.34507,741.8028169,944.7464789,1594.34507,13430.62676,577.0070423,1181.830986,1782.65493,16765.37324,1316.302817,5401.098592,4633.035211,6245.147887,1374.507042,330.0985915,2652.450704,13160.62676,449.3521127,529.028169,1089.626761,15590.17606,616.2676056,269.1126761,3847.93662,11788.40141,2049.971831,582.556338,2816.704225,10326.79577,779.6830986,305.1126761,1807.852113,7315.492958,1350.507042,456.8309859,1368.866197,5626.894366,733.1690141,178.4788732,5769.450704,4864.232394,1392.866197,616.7957746,3292.908451,383.3591549,782.6408451,142,16.56654765,11.38131902,0.726651664,0.959459459,0.657407407,-1.436475953
+3708,33973.36527,936.508982,826.9640719,1135.670659,30073.17964,753.0299401,956.4491018,1707.215569,17302.62275,581.7904192,1053.712575,1798.449102,21332.15569,1365.616766,2538.323353,2881.419162,7742.820359,1451.263473,338.8682635,2397.580838,16846.14371,584.7365269,169.0299401,899.6107784,20329.56886,823.6407186,132.6167665,2182.08982,15560.13772,1750.856287,615.9461078,2846.808383,13606.61078,727.508982,317.6167665,1911.802395,10189.32335,1118.532934,471.3413174,1335.419162,7434.167665,660.497006,174.3473054,4046.041916,6851.011976,1449.964072,351.3233533,3312.54491,542.9281437,786.3413174,167,19.65830996,11.26754494,0.819436789,0.878947368,0.73245614,-0.027300155
+3709,15879.70423,890.3521127,808.7887324,1139.873239,14867.57042,695.8591549,787.2957746,1581.619718,7764.471831,736.1126761,495.2394366,1741.492958,11254.19014,1294.429577,1581.725352,1083.612676,3948.823944,1346.056338,317.9084507,2345.915493,8049.732394,468.0070423,414.1478873,534.0633803,10141.91549,437.8521127,122.1408451,799.0211268,7576.894366,1523.612676,472.971831,2785.140845,6606.084507,1178.077465,268.0070423,1363.690141,4999.570423,814.415493,409.4929577,1346.183099,3725.915493,690.084507,162.2253521,1791.852113,3552.84507,1370.056338,234.971831,3187.971831,809.5211268,784.4366197,142,14.14226044,13.6240668,0.268217079,0.904458599,0.591666667,1.264710475
+3710,27314.89933,962.114094,562.0067114,1079.067114,24935.73826,705.7114094,698.5234899,1556.362416,13671.31544,574,1195.711409,1764.449664,16489.0604,1289.221477,5762.248322,3143.436242,6020.154362,1369.395973,413.0268456,2346.503356,12789.37584,540.0268456,483.8724832,724.1208054,15237.67785,996.2483221,127.1610738,1558.986577,11900.74497,2057.342282,650.0469799,2833.120805,10397.77852,838.6510067,286.4295302,1100.194631,6821.503356,1601.073826,427.9328859,1321.060403,5275.892617,698.1812081,168.0268456,3038.973154,4746.489933,1296.228188,685.6644295,3359.120805,345.9932886,784.7181208,149,15.92958836,12.20008081,0.642988942,0.943037975,0.591269841,-1.562318837
+3711,40879.23423,998.5585586,519.5675676,1101.081081,33270.45045,724.3423423,758.8738739,1565.891892,19486.97297,575.6936937,1368.216216,1717.864865,24538.47748,1354.477477,2868.126126,2896.477477,8407.135135,1450.36036,352.0810811,2565.18018,18565.44144,437.972973,112.5315315,816.5945946,22471.20721,898.3963964,125.1621622,1619.072072,17374.8018,1763.126126,558.1081081,2799.171171,15184.40541,607.6126126,289.6846847,1453.864865,10896.13514,1512.864865,409.0810811,1292.657658,8221.378378,618.9369369,157.9279279,1908.081081,7312.837838,1382.009009,1189.783784,3226.558559,643.7657658,785.3063063,111,16.89845735,8.760581959,0.85512313,0.925,0.528571429,0.877847504
+3712,32145.41558,1028.064935,487.2337662,1054.512987,29621.86364,771.7792208,545.6753247,1470.941558,16871.08442,589.474026,783.6818182,1708.032468,21886.64935,1457.850649,2045.837662,2524.383117,6973.311688,1519.766234,402.9415584,2384.253247,14281.4026,426.8961039,102.0194805,998.8896104,18139.05195,466.7272727,266.5194805,1606.935065,13448.74026,1825.116883,624.0909091,2792.11039,11834.53896,588.0454545,277.9090909,1474.948052,8746.902597,915.038961,413.0454545,1292.311688,6537.396104,616.7012987,163.6753247,1599.415584,5532.441558,1397.577922,556.7402597,3217.642857,687.1688312,785.7857143,154,15.60258114,12.70003081,0.580907105,0.93902439,0.641666667,-0.706457021
+3713,23787.85,832.7357143,703.5142857,1064.385714,21653.29286,654.9428571,597.7714286,1561.092857,11748.05714,842.6571429,1037.985714,1757.185714,15553.52143,1205.428571,3186.15,3039.85,5518.314286,1422.75,368.2285714,2416.657143,12155.84286,391.1714286,593.0642857,1045.157143,14480.57857,433.95,116.4214286,1763.914286,11001.43571,1719.921429,541.8785714,2793.264286,9534.557143,671.2,270.8357143,1572.164286,7136.421429,1100.007143,403.0928571,1368.564286,5194.928571,766.1928571,158.6428571,3474.964286,4839.985714,1293.357143,176.1142857,3209.271429,771.6857143,785.8928571,140,17.46379612,11.73494295,0.740588974,0.823529412,0.45751634,-0.694292664
+3714,26435.65517,829.2068966,468.0172414,1046.784483,22920.36207,668.7327586,632.3706897,1470.051724,13277.56897,517.2586207,992.4310345,1669.163793,17258.15517,1246.75,2592.672414,1493.965517,6459.896552,1259.362069,310.9224138,2282.431034,13241.93966,393.2586207,110.5431034,1209.543103,16279.56897,431.137931,124.862069,975.612069,12667.2069,1584.517241,442.9913793,2788.422414,10827.32759,623.6034483,272.8362069,1059.560345,7839.293103,1370.37069,403.7327586,1307.086207,5269.551724,604.0517241,161.862069,1656.12931,5095.155172,1356.87069,4172.577586,3120,886.9310345,784.9224138,116,12.54731283,12.07074446,0.272984993,0.974789916,0.591836735,-0.114094506
+3715,30610.62963,975.8395062,718.8641975,1119.765432,26150.37037,802.5432099,806.9876543,1637.123457,15794.85185,591.7654321,2021.506173,1797.259259,18847.97531,1362.580247,2195.876543,4621.283951,7011.901235,1803.098765,336.9259259,2468.45679,15763.35802,452.5061728,901.0740741,2107.839506,18797.71605,817.5925926,412.617284,2410.839506,14235.55556,2091.777778,591.0493827,2820.382716,12606.18519,671.0740741,312.4320988,1709.975309,9032.17284,1499.024691,469.8395062,1376.08642,6631.234568,917.8148148,182.2098765,3958.037037,6232.160494,1485.925926,394.2716049,3261.259259,427.2098765,784.4320988,81,11.24388874,9.483260448,0.537263188,0.964285714,0.5625,-0.7733684
+3716,35902.35165,915.978022,475.0989011,1085.857143,33274.47253,744.7912088,460.6263736,1668.241758,16855.47253,571.3186813,465.6483516,1734.351648,21855.38462,1413.483516,2009.142857,1923.967033,7852.494505,1393.395604,343.3186813,2292.285714,17065.03297,426.5494505,349.1648352,462.4615385,21056.78022,416.1098901,131.5494505,1625.989011,15790.56044,1603.054945,399.1428571,2841.472527,13735.52747,762.4615385,308.2307692,1236.428571,7784.241758,840.4615385,463.3296703,1365.615385,5898.505495,700.7802198,181.0769231,3401.923077,5196.164835,1420.142857,698.8021978,3242.791209,238.7032967,786.4835165,91,15.47384661,8.673817524,0.828122646,0.858490566,0.464285714,-0.878155985
+3717,36745.64,904.11,565.27,1111.67,32894.96,743.49,704.85,1709.98,18587.51,581.12,926.71,1816.06,22522.62,1339.54,4467.54,3617.57,8149.96,1426.52,345.8,2375.03,18145.32,446.99,521.95,672.61,21554.84,459.85,135.36,3475.46,16396.48,1906.23,474.41,2831.7,14561.83,648,313.52,1374.68,9144.86,1289.75,455.35,1324.38,7009.25,719.11,180.68,4846.25,6203.83,1387.44,1049.09,3308.17,301.18,787.13,100,13.59371786,10.576485,0.628212119,0.833333333,0.591715976,-0.665165012
+3718,28263.09804,1029.333333,737.0686275,1139.352941,24592.87255,782.5784314,767.745098,1691.490196,14239.2549,579.6960784,522.1764706,1775.764706,17875.11765,1409.539216,1162.205882,1173.823529,6457.862745,1457.911765,350.1568627,2402.990196,14206.12745,493.9705882,433.0392157,474.4313725,17189.29412,509.3137255,136.6078431,899.5588235,13257.78431,1620.990196,548.0294118,2811.588235,11792.81373,756.5392157,325.0686275,1839.705882,8355.539216,963.7941176,471.1372549,1349.333333,6404.705882,726.2843137,177.4509804,1400.352941,5833.656863,1505.823529,265.6470588,3435.578431,494.0980392,786.4607843,102,14.99069243,9.420605417,0.777865896,0.85,0.607142857,-0.457689303
+3719,29642.76364,904.4727273,709.0242424,1093.206061,25824.81212,663.8181818,609.8242424,1550.987879,14699.20606,527.1515152,746.8848485,1744.018182,18793.26667,1231.581818,3867.29697,4011.842424,6927.969697,1348.618182,306.3272727,2450.866667,14565.55152,420.0060606,104.4242424,664.2181818,17695.55758,1096.369697,120.8606061,3159.509091,13392.9697,1444.442424,699.0242424,2788.684848,11892.69697,599.8787879,261.5393939,1876.539394,8721.745455,1213.654545,400.6666667,1301.636364,6679.660606,606.5757576,156.5818182,3694.339394,6061.315152,1340.412121,421.2909091,3236.448485,634.6060606,790.1515152,165,16.53617208,13.95648521,0.536347364,0.868421053,0.539215686,0.687498929
+3720,17573.48889,937.1333333,453.8777778,1026.411111,16529.43333,710.6333333,581.3333333,1394.8,9286.988889,547.1111111,861.6222222,1684.811111,11905.3,1394.988889,2321.266667,1486.666667,4326.633333,1452.077778,394.6444444,2326.744444,8967.966667,416.2666667,102.0333333,802.9333333,10802.45556,907.9777778,128.4555556,985.2222222,8344.722222,1395.533333,517.1777778,2795.766667,7328.944444,663.3666667,276.9777778,1170.188889,5493.244444,1307.433333,395.7222222,1287.233333,4128.255556,602.7666667,165.4666667,1439.277778,3811.855556,1498.722222,5561.311111,3159.422222,661.7,786.6111111,90,11.17734464,10.57914575,0.322759161,0.967741935,0.576923077,0.823074031
+3721,30608.41016,820.1171875,449.140625,1062.988281,27069.10938,675.4804688,621.0390625,1504.855469,15216.16016,512.6835938,1068.363281,1727.621094,20566.86328,1255.210938,2801.132813,2888.316406,7401.832031,1274.015625,308.4921875,2374.535156,15042.63672,399.3007813,120.7226563,1397.90625,18884.42188,614.46875,296.4453125,1870.894531,14594.63672,1698.074219,503.2890625,2792.574219,12350.60547,605.1992188,271.6015625,1362.929688,8977.878906,1043.773438,408.8320313,1302.292969,6172.355469,605.0664063,163.9882813,2813.199219,5888.261719,1359.78125,2698.625,3130.707031,862.6992188,791.2304688,256,26.06630706,12.86954829,0.869618944,0.937728938,0.585812357,-0.648838742
+3722,28815.53043,1097.956522,768.8608696,1174.93913,25900.08696,852.9565217,883.5130435,1754.904348,14540.50435,635.4869565,728.1913043,1807.556522,18015.35652,1457.713043,3087.965217,3068.443478,6400.382609,1499.565217,351.7130435,2420.826087,14288.08696,469.6347826,242.5304348,673.2086957,17407.75652,474.6521739,140.1391304,2308.478261,12911.5913,1989.608696,586.373913,2813.304348,11606.18261,664.9652174,324.4173913,2144.669565,8080.608696,1045.113043,477.3913043,1341.269565,6240.121739,686.9217391,188.9826087,2785.495652,5396.86087,1480.86087,378.426087,3368.034783,463.8521739,786.9478261,115,14.01580148,10.63050293,0.651713105,0.92,0.737179487,-0.480746738
+3723,25749.71429,1019.302198,772.467033,1116.175824,23902.78022,716.8241758,703.7087912,1624.126374,13427.08791,550.0604396,465.0714286,1753.494505,17098.73626,1314.340659,1497.489011,1567.087912,6338.093407,1432.873626,323.3461538,2373.175824,13591.2033,458.6813187,276.4615385,452.7912088,16421.10989,459.1813187,129.5054945,1863.016484,12548.54396,1493.379121,558.8791209,2826.313187,11019.75824,874.6318681,306.1758242,2083.714286,7921.67033,883.6428571,455.0989011,1346.708791,6167.769231,672.8461538,173.9010989,2813.445055,5505.335165,1451.016484,369.6538462,3335.543956,477.0164835,788.6428571,182,16.49988321,14.28112211,0.500859368,0.952879581,0.669117647,1.112842346
+3724,22730.28689,949.7131148,650.9590164,1118.377049,20724.45902,742.1065574,660.8606557,1589.770492,11490.05738,557.1967213,481.4344262,1725.311475,14472.69672,1381.803279,834.3688525,861.1147541,5177.311475,1431.262295,333.6885246,2369.819672,11550.52459,467.5245902,193.2540984,465.704918,13924.78689,518.3606557,132.9590164,857.3770492,10501.66393,1497.540984,615.352459,2819.590164,9457.721311,756.3360656,306.5655738,2062.336066,6792.286885,851.557377,458.795082,1335.844262,5351,658.352459,176,1669.52459,4713.106557,1475.983607,436.647541,3334.942623,503.6803279,788.1967213,122,14.15050772,11.08539343,0.621528034,0.960629921,0.677777778,-0.247964178
+3725,38764.45455,859.1590909,520.3636364,1082.136364,34669.51136,698.6136364,1092.613636,1566.011364,20023.86364,633.2727273,1401.238636,1767.227273,26423.125,1287.545455,2757.522727,3127.738636,8408.090909,1532.738636,410.0227273,2403.261364,19997.42045,416.3295455,255.1704545,1719.068182,24698.61364,707.0681818,208.3522727,1301.522727,18962.04545,1915.920455,537.6590909,2788.465909,16244.26136,642.3181818,277.7045455,1326.386364,12217.46591,1823.386364,413.9545455,1312.75,8702.704545,667.4204545,157.5795455,2216.761364,8022.079545,1346.397727,177.25,3122.670455,735.6590909,785.3409091,88,15.27816617,7.719190568,0.862976965,0.846153846,0.55,1.524472109
+3726,30604.12821,865.3012821,628.2692308,1106.358974,25858.41026,702.3461538,844.5576923,1632.974359,15279.95513,742.1089744,455.9038462,1727.865385,19847.61538,1290.50641,1339.891026,941.6089744,7106.134615,1415.564103,318.525641,2323.224359,14618.07051,425.3525641,347.6730769,481.9679487,17817.34615,455.0064103,123.8461538,780.4487179,13871.98718,1540.403846,469.8525641,2803.00641,12043.46795,1002.737179,284.1282051,1362.102564,8709.891026,880.7115385,419.7564103,1345.673077,6236.346154,681.9294872,168.6858974,1376.038462,5923.480769,1378.512821,253.3205128,3240.205128,797.8333333,788.3589744,156,23.88749914,9.02470173,0.925887151,0.881355932,0.464285714,0.942913177
+3727,18397.82692,783.7596154,487.9038462,1049.913462,16997.625,622.25,503.7307692,1546.230769,8737.942308,470.5576923,383.1346154,1682.875,11895.46154,1152.490385,1172.394231,808.3461538,4502.451923,1189.307692,277.625,2303.317308,9288.903846,384.0576923,174.7884615,503.8653846,11404.51923,422.6153846,120.2307692,1009.903846,8767.596154,1351.509615,410.0096154,2981,7346.557692,661.1346154,248.0288462,1139.576923,5182.846154,731.0480769,382.8173077,1288.028846,3185.923077,587.6057692,154.6538462,2747.798077,3212.115385,1215.730769,761.1538462,3104.423077,973.8461538,786.2596154,104,12.80551465,11.09158386,0.49977231,0.859504132,0.619047619,-1.476918724
+3728,37620.2,887.3153846,513.3769231,1071.484615,34362.59231,698.1846154,852.9692308,1644.030769,17623.54615,527.6076923,1912.846154,1808.069231,23239.33077,1236.146154,4541.246154,2896.346154,8707.415385,1287.784615,309.4923077,2455.084615,18057.80769,430.8846154,244.3615385,1807.384615,22531,456.3076923,566.4692308,1369.5,17192.84615,2534.123077,438.7384615,2863.923077,14211.56923,641.9461538,270.3076923,974.0153846,9713.261538,1425.061538,412.6384615,1310.661538,5632.123077,632.2384615,156.7692308,2283.638462,5554.330769,1268.6,490.5230769,3206.723077,994.0615385,786.7615385,130,19.4304965,9.63052076,0.868528369,0.807453416,0.5,-1.284900586
+3729,28101.19014,746.4366197,475.2042254,1046.640845,23751.93662,625.0774648,936.7746479,1599.626761,11148.0493,460.2816901,2181.873239,1775.408451,15994.56338,1117.591549,7148.528169,3057.640845,6056.577465,1142.204225,278.5422535,2527.704225,12024.95775,1568.408451,236.3239437,1481.859155,14953.85211,467.1760563,462.1830986,2659.676056,11278.92254,2291.211268,398.0422535,2797.767606,8994.309859,600.971831,249.8802817,889.6478873,5630.246479,1118.197183,360.3943662,1284.288732,3028.873239,587.3169014,150.6760563,2833.140845,3305,1072.323944,1225.528169,3151.852113,1045.401408,787.8943662,142,16.21644693,11.81857452,0.684724794,0.946666667,0.556862745,1.017909848
+3730,36869.58919,898.7135135,549.8324324,1124.032432,21956.42703,527.4756757,292.5783784,1440.518919,10047.82703,430.1459459,604.3189189,1708.097297,13981.54054,1014.713514,5382.151351,2406.027027,5216.589189,1049.924324,247.3675676,2287.513514,10547.45946,284.6702703,413.6864865,561.8540541,12816.02162,333.6702703,106.2702703,4492.189189,9355.005405,1453.443243,314.4864865,2785.205405,8042.124324,496.0108108,226.372973,1116.805405,3716.578378,708.5621622,346.4,1266.183784,2674.47027,598.2972973,139.827027,1980.178378,2624.940541,1031.064865,110.4594595,3058.945946,197.8810811,791.427027,185,21.37403538,11.69089309,0.837154135,0.889423077,0.540935673,-0.795679689
+3731,41828.54601,1055.018405,643.9815951,1148.276074,35117.44172,727.5460123,566.7300613,1645.638037,17595.37423,574.9263804,484.7791411,1745.09816,22256.66871,1290.269939,6416.92638,3050.104294,7926.791411,1362.93865,318.8220859,2312.687117,17282.95092,387.9141104,187.9141104,457.2822086,21093.30675,421.1104294,128.8834356,7234.809816,16247.70552,1502.773006,427.4539877,2813.202454,14117.03681,588.6993865,293.6380368,1375.889571,8340.907975,820.6196319,422.595092,1302.319018,6251.196319,617.5889571,165.9386503,3215.993865,5563.325153,1278.503067,139.5092025,3321.97546,264.4723926,788.607362,163,22.41376918,10.10147653,0.892684697,0.819095477,0.554421769,-1.319925927
+3732,31130.68367,896.244898,588.7755102,1088.642857,28752.08163,830.4081633,1379.295918,1664.969388,15174.4898,547.2857143,2249.510204,1857.622449,18983.16327,1236.55102,6200.183673,2739.530612,6972.418367,1356.071429,326.6938776,2455.77551,15026.08163,440.122449,2169.040816,1053.806122,17861.05102,471.7653061,1100.602041,2091.704082,13370.41837,1974.112245,489.6530612,2819.27551,11948.14286,664.3469388,291.5,1109.591837,7473.826531,956.622449,420.6530612,1352.081633,5925.795918,1098.255102,169.8673469,3529.989796,5210.336735,1306.336735,1205.489796,3306.663265,320.3469388,787.255102,98,11.87191815,10.61038446,0.448589319,0.97029703,0.890909091,-0.250203094
+3733,39714.86585,1117.768293,632.6097561,1124.036585,36982.7439,807.902439,697.7682927,1643.963415,20280.76829,657.695122,687.1097561,1767.939024,25316.20732,1438.317073,4445.780488,3124.012195,8848.439024,1438.512195,346.8902439,2306.682927,19860.95122,1133.817073,219.2926829,523.6341463,23851.57317,513.2926829,136.1585366,3731.756098,18622.71951,1674.926829,503.7926829,2821.353659,16379.40244,989.4634146,342.1829268,1485.268293,11183.78049,1027.890244,464.9634146,1303.97561,8606.573171,668.8414634,171.4634146,2985.268293,7636.47561,1418.292683,398.597561,3402.04878,366.2682927,785.7804878,82,14.24687362,7.495138266,0.850428876,0.911111111,0.650793651,-1.433263001
+3734,16303.57692,969.8942308,797.1634615,1058.971154,15496.89423,698.4423077,626.9134615,1453.759615,8348.913462,563.5961538,1044.980769,1729.721154,11118.10577,1217.817308,3969.490385,4925.634615,3946.048077,1803.394231,287.375,2403.673077,8825.884615,401.6826923,1485.413462,813.75,10213.48077,884.5480769,127.2596154,5241.653846,8000.375,1690.711538,678.6346154,2793.971154,7195,674.6153846,267.7019231,2225.25,5146.211538,1221.442308,410.4230769,1362.548077,3991.519231,1019.990385,162.9326923,5088.951923,3619.230769,1333.625,230.875,3377.990385,441.8942308,786.1923077,104,16.07968736,8.551870136,0.846842936,0.936936937,0.722222222,-1.439110666
+3735,30563.01587,822.2698413,487.047619,1062.68254,26381.73016,676.2539683,1034.714286,1512.460317,15414.31746,528.7301587,1837.015873,1815.31746,19906.7619,1221.904762,3178.412698,3669.904762,7318.936508,1338.269841,320.5714286,2852.857143,15062.06349,451.2380952,297.4126984,2472.269841,18587.52381,737.7619048,195.6349206,1617.285714,14649.68254,2151,484,2779.603175,12505.92063,660.031746,276.5873016,1406.047619,8937.634921,2067.52381,409.8412698,1298.126984,6169.968254,663.7460317,159.1904762,4148.253968,5880.888889,1300.047619,914.6984127,3194.111111,853.6825397,787.6190476,63,11.58076694,7.205525566,0.782860223,0.9,0.572727273,-0.552762814
+3736,25580.0663,753.640884,533.6519337,1064.668508,12397.34807,450.3977901,401.8453039,1227.701657,4749.198895,359.9944751,835.0552486,1606.127072,7859.740331,873.160221,3260.530387,1728.364641,2911.093923,919.4640884,218.160221,2285.149171,5602.712707,275.480663,386.2541436,735.2154696,6673.563536,315.1767956,98.15469613,1653.01105,5070.41989,1824.298343,374.6629834,2771.79558,3991.801105,480.4198895,193.5082873,707.9447514,2093.911602,802.5690608,308.9502762,1263.961326,1154.099448,567.3701657,129.6187845,1896.906077,1276.165746,865.5801105,146.9779006,2909.104972,1090.298343,791.4917127,181,17.72354602,13.24849081,0.664252909,0.983695652,0.595394737,-0.54564602
+3737,17761.91262,829.368932,682.8640777,1073.902913,14483.51456,620.8058252,510.4271845,1556.475728,8070.223301,494.9417476,841.7087379,1788.320388,9930.524272,1147.737864,7844.718447,3690.15534,3756.961165,1272.980583,292.7864078,2407.631068,8061.203883,549.4174757,894.6019417,693.776699,9600.174757,412.9902913,142.6407767,9260.76699,7385.572816,1850.68932,417.8446602,2812.135922,6526.533981,737.9417476,259.2038835,1262.165049,4186.864078,915.7475728,402.3495146,1422.495146,3192.029126,764.6504854,173.3495146,10582.05825,2925.194175,1215.592233,364.7475728,3217.485437,290.2524272,787.9223301,103,12.95670718,10.24827415,0.611864165,0.971698113,0.715277778,-0.842441301
+3738,35056.42647,899.7647059,685.8676471,1130.617647,32512.39706,773.4705882,957.7058824,1747.338235,17728.13235,568.3382353,1657.882353,1851.75,21951.25,1301.161765,5575.102941,4449.794118,7944.558824,1436.161765,576.5588235,2397.911765,17418.30882,423.0735294,2202.705882,1156.044118,20150.39706,489.2352941,236.7647059,2098.014706,15496.91176,2441.735294,439.7205882,2816.455882,13790.70588,624.5588235,301.4852941,1251.779412,8610.191176,2008.897059,445.5735294,1371.25,6688.705882,1077.338235,167.8823529,3460.352941,5877.426471,1373.117647,309.1029412,3336.867647,311.1470588,787.4264706,68,11.61238957,8.088619468,0.717507461,0.871794872,0.686868687,0.23852232
+3739,27736.31915,856.6170213,791.1808511,1119.319149,25461.04255,699.5,1131.202128,1623.585106,14318.24468,543.7446809,1615.574468,1793.234043,18376.71277,1294.723404,2969.840426,3563.06383,6733.468085,1379.117021,316.3617021,2554.074468,14303.89362,618.9787234,128.712766,1589.12766,17505.51064,1301.404255,127.5744681,1698.404255,13274.93617,1467.234043,585.8404255,2801.882979,11577.29787,1165.308511,285.2234043,1598.06383,8648.659574,1355.478723,443.3723404,1320.276596,6583.414894,630.6276596,170.5319149,2126.468085,5961.765957,1386.978723,417.7446809,3238.734043,553.3404255,787.8617021,94,11.81791281,10.30420707,0.489658524,0.94,0.712121212,-0.646118348
+3740,16532.88,793.28,837.49,1077.9,15273.91,626.36,619.28,1542.07,7950.55,506.09,512.73,1697.67,10777.43,1183.04,1618.8,1327.99,4160.73,1226.75,290.67,2332.1,8277.38,499.32,254.38,725.84,10696.86,624.44,120.16,1102.02,8044.38,1370.89,439.36,2801.52,6940.83,685.93,252.24,1111.71,4823.2,764.58,396.79,1304.75,3105.35,610.83,156.36,2594.53,3146.72,1628.81,596.79,3104.65,953.96,789.11,100,12.84126624,10.07981554,0.619552839,0.934579439,0.699300699,-0.374078543
+3741,26904.91827,847.2019231,680.0384615,1093.182692,23495.98558,692.4038462,937.4903846,1593.918269,13606.52404,553.5576923,1751.586538,1810.817308,16907.75481,1252.923077,3716.730769,2816.889423,6153.442308,1313.274038,300.0576923,2540.168269,13096.90865,881.5769231,348.5721154,1039.019231,16040.625,486.0913462,321.2307692,1526.192308,12106.71154,1989.980769,592.7740385,2801.153846,10670.24038,936.2836538,278.2980769,1367.375,7686.399038,1346.764423,416.6057692,1351.408654,5799.932692,644.7451923,164.3509615,3623.721154,5224.115385,1330.384615,285.9182692,3321.793269,568.0384615,794.1826923,208,25.46019194,11.87716665,0.884521465,0.78490566,0.619047619,0.045800136
+3742,29840.46316,902.8421053,456.6105263,1076.273684,27239.41053,741.6947368,762.7578947,1558.526316,15993.13684,633.7473684,1319.652632,1781.378947,19204.44211,1325.431579,3283.894737,3269.136842,6632.778947,1532.168421,410.9578947,2354.894737,14680.09474,423.8210526,214.8105263,2075.578947,18334.32632,482.5578947,325.3368421,1301.178947,13806.11579,2015.063158,557.6421053,2835.021053,11842.54737,614.3789474,280.1473684,1255.336842,8696.378947,1608.389474,410.2631579,1313.536842,6423.315789,640.9473684,156.6105263,1921.410526,5739.789474,1319.926316,254.0631579,3190.694737,724.2210526,789.6315789,95,12.94383794,9.914811445,0.642856075,0.922330097,0.56547619,0.3804225
+3743,27763.23171,1123.817073,702.7317073,1098.52439,23952.45122,656.8780488,592.4512195,1567.365854,13597.10976,531.4512195,590.8658537,1772.792683,16241.04878,1207.439024,9465,3101.036585,6134.439024,1355.54878,387.0487805,2334.134146,13073.30488,388.195122,1161.707317,500.3414634,16122.53659,424.0365854,137.0121951,2693.792683,12123,2114.243902,708.3658537,2805,10871.36585,627.1341463,285.2804878,1220.5,7090.256098,1160.646341,425.8658537,1306.621951,5523.060976,846.1463415,172.0853659,3611.743902,5070.536585,1314.52439,936.6463415,3334.585366,335.0609756,790.1463415,82,10.95624669,9.77540367,0.451597177,0.976190476,0.621212121,-0.787196367
+3744,24602.9759,784.8915663,547.5903614,1064.951807,22179.36145,634.9036145,576.6626506,1516.409639,12102.71084,494.7951807,444.8072289,1734.831325,15452.72289,1201.168675,2949.409639,1852.795181,5676.13253,1318.46988,280.4819277,2330.216867,12073.73494,4557.891566,461.3253012,451.8433735,14951.6506,432.8192771,116.0963855,1162.228916,11125.78313,1679.13253,860.1204819,2806.975904,9879.590361,640.5060241,264.3975904,1395.518072,7107.698795,966.8554217,397.4578313,1301.566265,5474.590361,678.9518072,159.0240964,2680.626506,4842.493976,1288.481928,203.9879518,3241.349398,583.3975904,788.7228916,83,12.02947758,8.953228479,0.667874299,0.988095238,0.638461538,1.390265509
+3745,19920.54783,908.2956522,432.6086957,1023.26087,18560.44348,691.9826087,464,1387.904348,10550.13913,534.9913043,423.2608696,1673.886957,13588.85217,1308.252174,1936.417391,1479.104348,4652.634783,1429.226087,390.5391304,2335.904348,10111.41739,461.3217391,91.32173913,535.0347826,12489.23478,396.5565217,115.973913,1052.591304,9492.452174,1323.582609,541.9913043,2778.791304,8225.730435,890.226087,257.0173913,1221.173913,6108.852174,892.9565217,388.1130435,1283.008696,4573.4,579.773913,155.573913,1947.913043,4244.113043,1349.417391,6098.217391,3116.965217,712.2956522,791.3913043,115,14.10968275,10.60552119,0.659563951,0.958333333,0.631868132,-0.42860617
+3746,15306.99091,775.2181818,602.7545455,1047.745455,14214.59091,614.1090909,505.9454545,1471.390909,7315.3,492.0636364,381.8545455,1667,9944.809091,1173.018182,1070.218182,922.2545455,3873.981818,1188.790909,285.2090909,2300.4,7729.645455,414.4909091,438.9909091,473.6727273,9747.5,447.0272727,116.4545455,973.3454545,7489.118182,1355.109091,415.9272727,2834.181818,6415.863636,729.7363636,247.0727273,1050.163636,4485.345455,725.7909091,377.4090909,1293.536364,2806.427273,637.6272727,150.2363636,1706.881818,2861.509091,1196.663636,456.3818182,3031.590909,963.9272727,791.7727273,110,13.7898134,10.257723,0.668332854,0.94017094,0.714285714,-0.220860924
+3747,26166.23111,886.7911111,612.6711111,1134.804444,23327.91556,637.0222222,638.68,1501.226667,12862.00444,847.3333333,763.0488889,1733.56,17743.80889,1165.693333,2636.622222,2240.617778,5858.217778,1563.977778,401.5955556,2424.528889,12806.76,376.6177778,335.8133333,840.5111111,15552.84444,620.1155556,178.4622222,2079.475556,12187.33333,1706.413333,561.5688889,2788.493333,10413.35556,703.7155556,249.7511111,1310.293333,7792.444444,951.2088889,385.7822222,1330.022222,5568.324444,659.9866667,148.8933333,2126.693333,5160.52,1220.253333,174.6977778,3134.871111,742.9377778,797.3866667,225,22.11588762,13.21640614,0.801796016,0.933609959,0.681818182,-0.176800526
+3748,17050.59756,891.5365854,536.2560976,1142.853659,15296.85366,598.3414634,822.4268293,1439.463415,8590.756098,853.0731707,559.6829268,1705.121951,10908.20732,1103.756098,2018.158537,1251.268293,4081.256098,1494.963415,374.4512195,2447.792683,8588.914634,346.3170732,477.5853659,540.1585366,10120.90244,629.9512195,109.3658537,1068.280488,8062.963415,1581.841463,492.4146341,2825.219512,7062.804878,664.402439,254.8658537,1287.04878,5248.5,834.1707317,376.7560976,1345.158537,3793.54878,710.0731707,147.1097561,1779.463415,3585.280488,1192.414634,168.6463415,3155.390244,756.9634146,790.8780488,82,11.76722289,9.432942966,0.597822309,0.921348315,0.621212121,0.996895285
+3749,20035.25153,864.5521472,692.9570552,1104.220859,18156.22086,692.404908,767.2269939,1609.300613,9663.736196,715.797546,423.6319018,1713.417178,12898.64417,1250.417178,1188.276074,1133.944785,4774.214724,1354.165644,317.4294479,2363.662577,9680.828221,424.9693252,366.607362,466.9877301,11994.07362,446.5092025,119.2944785,826.2760736,8939.705521,1454.527607,472.9386503,2782.742331,7705.687117,1182.251534,272.8343558,1450.196319,5753.368098,947.190184,407.8343558,1349.374233,4277.773006,682.1165644,156.9325153,1370.815951,3954.97546,1324.96319,200.9202454,3284.04908,790.4846626,794.6809816,163,16.99479448,12.50761922,0.677016687,0.942196532,0.679166667,0.852818034
+3750,26054.36283,750.8938053,511.3362832,1038.159292,23628.83186,615.4513274,687.2477876,1504.362832,13087.9292,464.0707965,1020.690265,1755.389381,17588.79646,1139.274336,3790.663717,3396.486726,6341.884956,1231.584071,287.6637168,2359.380531,13131.23009,371.2654867,145.2212389,857.6902655,16110.48673,650.920354,119.8053097,2504.212389,12478.45133,1640.415929,508.6460177,2788.19469,10485.60177,738.8584071,256.9115044,1365.141593,7369.99115,1157.707965,386.6017699,1275.079646,4920.345133,601.1238938,146.7345133,3329.123894,4745.185841,1176.035398,497.2035398,3161.265487,905.6902655,794.2477876,113,16.96251021,10.8090493,0.770672274,0.773972603,0.474789916,0.517143812
+3751,26047.575,973.075,1027.8625,1173.65,22693.6,771.0125,945.0875,1724.0375,13156.85,579.85,989.7,1849.8,16330.65,1347.4875,2675.85,1949.2,5882.2,1402.375,330.375,2461.3625,12777.9875,505.1375,178.8625,816.0375,15809.6625,473.5125,173.4125,1568.2875,11782.625,1777.8625,650.5875,2813.8125,10215.9625,632.075,298.6625,1931.55,7508.85,914.55,451.5625,1342.675,5718.9625,634.575,167.125,2969.025,5250.925,1436.2625,294.025,3373.275,533.875,792.475,80,12.65222477,8.249921724,0.758173346,0.91954023,0.615384615,0.337489276
+3752,21956.55639,842.0676692,743.2781955,1101.781955,19244.88722,678.8045113,756.8796992,1560.857143,10650.31579,658.2030075,646.7969925,1764.112782,14394.67669,1217.721805,1192.308271,1481.233083,5015.857143,1341.052632,317.6541353,2388.676692,10852.54887,407.5639098,356.481203,633.4135338,12937.41353,502.9097744,115.9398496,846.0150376,9989.12782,1540.06015,496.1654135,2795.082707,8557.796992,861.8045113,265.4661654,1536.120301,6341.097744,952.9699248,402.1203008,1329.496241,4632.586466,685.9022556,155.0601504,1543.030075,4400.533835,1304.240602,199.3834586,3216.466165,777.3609023,794.9924812,133,15.68166564,10.98736801,0.713504572,0.95,0.692708333,-0.365834001
+3753,30374.19216,842.7372549,488.172549,1053.854902,26844.26667,687.7686275,794.9686275,1543.6,15291.89804,521.2078431,1365.439216,1770.352941,19665.21569,1215.062745,2680.623529,3677.639216,7354.231373,1272.403922,299.4823529,2331.843137,15179.9098,391.3058824,361.6588235,1564.717647,18698.93725,641.9490196,153.3686275,2059.101961,14404.24706,2016.760784,485.1215686,2792.160784,12279.22353,601.1333333,273.3137255,1264.85098,8629.729412,1476.623529,401.1568627,1297.898039,5769.968627,666.5294118,156.4,2593.411765,5517.713725,1269.729412,512.9098039,3217.878431,894.1137255,798.4588235,255,22.34493144,14.81809223,0.748484505,0.94795539,0.625,-0.196664493
+3754,24320.84524,874.7380952,711.25,1160.642857,22060.97619,695.452381,898.797619,1753.869048,11291.03571,505.1904762,750.5238095,1810.654762,14576.29762,1272.47619,2556.297619,1268.333333,5740.357143,1352.238095,313.5238095,2365.190476,11559.88095,430.9642857,273.4642857,984.8452381,14174.63095,464.547619,142.5357143,1085.857143,10936.84524,1808.809524,470.952381,2817.464286,9049.02381,986.1785714,273.2380952,1102.52381,6103.880952,887.3095238,414.7738095,1319.595238,3666.833333,620.1071429,162.6666667,2062.369048,3648.928571,1300.309524,608.452381,3229.035714,983.8571429,793.2738095,84,12.4375385,8.78150854,0.708163229,0.954545455,0.587412587,0.363301751
+3755,22917.05102,739.8469388,501.7244898,1053.714286,20426.27551,609.6020408,487.0612245,1591.265306,9588.826531,525.5918367,635.244898,1748.357143,13740.9898,1088.663265,4954.734694,2282.55102,5274.387755,1221.479592,290.9489796,2449.683673,10218.76531,745.9693878,593.122449,828.1734694,12778.65306,463.5510204,120.744898,3093.94898,9770.622449,1671.27551,446.9285714,2812.163265,7806.959184,911.7755102,244.7346939,1004.204082,5036.877551,842.8571429,362.9795918,1295.591837,2706.438776,705.5510204,152.255102,3139.887755,2931.989796,1085.285714,1112.77551,3172.020408,1037.510204,793.4693878,98,14.85394194,8.866174785,0.802322812,0.942307692,0.502564103,0.963940565
+3756,39668.08547,974.982906,587.042735,1098.794872,36572.80342,754.0683761,667.7435897,1686.435897,20796.63248,582.991453,925.1025641,1772.871795,25135.29915,1361.025641,4633.649573,3620.512821,9364.196581,1450.760684,347.1538462,2367.076923,19883.81197,439.8803419,215.008547,620.0940171,24518.35043,849,146.5128205,3180.316239,18807.70085,1712.598291,514.6666667,2829.264957,16544.11111,904.2136752,328.8376068,1562.555556,11591.30769,1183.444444,477.3333333,1320.179487,8590.897436,669.2649573,189.5128205,4009.34188,7864.025641,1471.735043,597.4273504,3358.589744,382.8034188,792.0769231,117,18.6589271,8.974027392,0.876747542,0.893129771,0.590909091,-1.270343426
+3757,17566.83333,1509.895833,643.5833333,1060.125,18595.08333,740.7291667,797.1875,1410.395833,9714.916667,630.875,1127.166667,1736.375,13163.47917,1291.041667,5726.9375,3001.333333,4682.583333,1287.916667,283.0416667,2625.041667,9711.833333,346.2291667,159.4791667,662.2708333,10800.3125,421.875,193.3541667,2159.25,8111.229167,1765.916667,473.125,2804.208333,7097.145833,555.2916667,256.5,1206.604167,4813.729167,918.5625,389.5833333,1308.020833,3895.395833,570.2291667,155.2083333,3273.666667,3198.145833,1113.125,425.5833333,3488.104167,395.6458333,792.1875,48,11.54691423,6.226234335,0.842170087,0.872727273,0.436363636,-0.774235041
+3758,34759.73171,900.7804878,702.9512195,1119.634146,31768.58537,708.0731707,1277.658537,1575.780488,17745.73171,577.3902439,2300,1798.902439,22587,1291.121951,2251.756098,6254.853659,8233.390244,1697.707317,325.0731707,2585.512195,18460.14634,421.5121951,671.6585366,1415.634146,22005.34146,2452.756098,146.9268293,2873.536585,17241.63415,1752.731707,619.5609756,2815.536585,15302.26829,627.9268293,313.0487805,1996.878049,10694.26829,2095.756098,457,1369.634146,8090.073171,805.9268293,186.2682927,4480.439024,7378.682927,1445.243902,292.5853659,3297.707317,431.2926829,791.0731707,41,8.203480827,6.635293068,0.588030525,0.976190476,0.569444444,-1.106412462
+3759,31364.91729,779.8007519,490.1654135,1054.93985,28489.33083,651.1315789,711.5676692,1582.090226,15214.08271,496.8646617,1794.796992,1770.120301,20308.34962,1171.834586,3930.43609,3099.093985,7541.007519,1239.827068,291.0676692,2372.338346,15376.6015,1373.669173,172.2857143,1624.932331,18989.07519,970.2932331,232.2067669,2238.778195,14603.34211,1983.695489,459.4924812,2801.774436,12370.3797,685.8646617,262.0225564,1144.360902,8479.984962,1443.278195,396.2218045,1294.112782,5329.071429,605.9398496,155.3233083,3741.417293,5203.609023,1199.31203,198.5075188,3209.041353,937.0526316,799.093985,266,24.5447984,15.11505752,0.787890703,0.828660436,0.532,-0.238508915
+3760,40482.3945,845.3302752,535.3761468,1088.559633,37263.09174,699.8899083,918.9449541,1692.357798,19007.87156,521.5045872,2155.082569,1839.321101,25953.6422,1245.440367,5260.229358,3274.055046,9666.697248,1301.733945,312.3853211,2423.954128,19466.73394,427.4678899,205.9633028,2538.357798,24071.27523,460.3761468,582.3944954,2082.623853,19039.04587,2413.844037,483.4862385,2844,15634.72477,672.0275229,280.0733945,1013.651376,10283.16514,1316.926606,412.0825688,1309.53211,6045.40367,614.1009174,162.6880734,2984.87156,6029.926606,1274.201835,299.8623853,3262.146789,995.1926606,795.3302752,109,22.1809719,6.7385761,0.952735875,0.838461538,0.409774436,-0.925409555
+3761,36622.255,1003.42,623.295,1119.77,34782.53,762.58,721.515,1688.97,19073.835,592.23,567.01,1758.27,23403.15,1388.775,6215.235,3817.175,8565.635,1449.215,334.085,2347.345,18520.99,1149.385,347.25,534.955,22183.47,472.24,141.57,3949.02,17016.86,1628.535,527.385,2815.195,15059.925,886.395,320.805,1654.16,10089.015,982.065,467.19,1316.6,7709.01,713.53,183.315,4772.92,6855.675,1448.085,497.045,3370.1,364.05,794.945,200,21.58496296,12.64282302,0.810510839,0.917431193,0.732600733,-1.545837393
+3762,37753.67219,992.281457,532.8543046,1085.34106,34907.77152,828.5993377,776.8509934,1602.933775,18949.92715,600.486755,1433.92053,1763.642384,23381.03642,1351.400662,2233.996689,2903.983444,8316.152318,1451.350993,336.2649007,2440.854305,18111.68874,443.3410596,341.589404,997.9271523,21966.23179,453.281457,396.9834437,1467.178808,16909.85099,1926.556291,519.2317881,2822.655629,14797.40397,720.9635762,308.6523179,1536.927152,10149.10927,1143.94702,454.6192053,1361.344371,7759.811258,704.1821192,176.0397351,3245.582781,6821.599338,1433.463576,1928.774834,3331.291391,400.6423841,802.7913907,302,28.26013988,14.0669919,0.867310249,0.898809524,0.567669173,-0.388414313
+3763,35927.46154,867.5128205,525.1282051,1089.064103,30993.55128,697.4871795,649.9230769,1564.641026,18589.52564,547.9358974,602.7820513,1762.884615,22757.65385,1299.358974,2902.974359,2409.294872,8076.25641,1334.602564,302.3205128,2317.75641,17295.29487,620.525641,244.3205128,477.974359,21625.84615,425.7564103,158.0128205,2562.987179,16684.37179,1569.205128,694.9102564,2828.384615,14502.25641,628.1923077,297.0897436,1554.397436,10246.23077,938.9487179,429.4102564,1325.807692,7674.653846,651.0512821,167.0641026,1956.282051,6998.487179,1362.564103,228.1923077,3292.128205,576.7307692,795.1282051,78,11.98483002,8.639062967,0.693108611,0.928571429,0.6,0.149961191
+3764,21656.04669,817.0622568,442.614786,1030.692607,19850.29572,663.0583658,452.8287938,1366.509728,11290.61868,505.0038911,688.5525292,1657.509728,14598.45914,1293.136187,1419.793774,1641.540856,5030.159533,1437.894942,384.9961089,2346.696498,10868.15175,399.9299611,93.85214008,923.688716,13610.12451,427.4669261,114.7198444,1110.2607,10179.96109,1402.140078,541.2840467,2785.81323,9068.653696,618.2607004,254.5058366,1386.280156,6759.381323,940.770428,394.5058366,1286.583658,5086.276265,602.8988327,158.1712062,1458.392996,4748.743191,1464.797665,7686.684825,3130.478599,671.2490272,802.6303502,257,29.9609469,11.68539199,0.920806054,0.823717949,0.633004926,-0.065736937
+3765,14087.09901,786.7821782,940.0891089,1097.960396,13151.66337,618.3960396,755.6732673,1570.950495,7315.722772,595.2178218,470.7920792,1782.980198,8760.742574,1123.584158,2335.782178,2120.623762,3613.188119,1286.871287,270.5742574,2431.287129,7140.940594,393.1386139,771.4059406,536.3861386,8655.940594,584.1386139,113.0594059,2998.09901,6710.019802,1509,493.0990099,2795.29703,5959.782178,949.2970297,256.0792079,1479.910891,4321.376238,806.6336634,390.9108911,1332.70297,3026.871287,798.8217822,153.7227723,3573.217822,2925.207921,1203.376238,216.5049505,3163.752475,832.8217822,794.1089109,101,14.07883296,9.613283747,0.730588304,0.971153846,0.597633136,-0.561630157
+3766,22464.11409,724.8926174,491.5167785,1064.724832,19290.79195,549.1610738,437.3758389,1593.557047,8360.362416,426.4228188,628.5771812,1689.993289,11983.8255,1087.013423,4169.832215,1371.744966,4541.087248,1069.637584,254.5167785,2306.302013,8861.597315,5727.322148,328.6241611,609.5167785,10944.04698,468.6174497,112.1208054,2988.979866,8137.872483,1658.107383,452.6375839,2767.503356,6489.563758,532.2416107,228.147651,832.9597315,3823.181208,816.8590604,348.147651,1287.90604,2013.187919,612.8926174,140.8389262,3919.42953,2191.644295,990.114094,861.1073826,3138.57047,1056.61745,795.6778523,149,15.4760202,12.2931562,0.607478977,0.961290323,0.760204082,-0.836916034
+3767,28578.02564,886.034188,511.0512821,1088.675214,26988.24786,717.3589744,460.5470085,1608.247863,13470.08547,560.3760684,435.0854701,1737.735043,17868.80342,1345.965812,2554.615385,2469.34188,6654.17094,1372.692308,329.5299145,2299.760684,14417.92308,419.2820513,610.0854701,458.2991453,17402.89744,421.6239316,132.2051282,2871.470085,13231.13675,1629.401709,382.5213675,2853.384615,11593.80342,743.9401709,298.2136752,1411.948718,6532.837607,803.5982906,440.034188,1373.786325,4895.153846,737.4273504,178.6581197,4723.179487,4383.529915,1395.128205,669.1623932,3230.358974,238.0940171,796.2905983,117,17.3061795,9.073026244,0.851555098,0.9,0.557142857,-0.840873569
+3768,16692.79167,890.8802083,532.6041667,1072.390625,15161.61979,689.3229167,524.4583333,1471.807292,8515.364583,534.3854167,419.7708333,1723.744792,10589.95833,1290.947917,899.4739583,1153.03125,3888.244792,1305.776042,308.125,2310.307292,8620.890625,426.8958333,239.125,467.6875,10338.91146,532.4322917,122.625,962.390625,7871.828125,1396.833333,736.109375,2837.552083,7054.494792,663.6614583,284.125,1958.567708,5060.546875,811.90625,430.171875,1319.6875,4014.4375,673.3489583,171.3697917,2477.848958,3613.057292,1364.75,655.0052083,3220.411458,523.859375,797.4375,192,16.920436,15.13505663,0.447100273,0.918660287,0.564705882,1.221564319
+3769,26799.48276,964.0689655,671.75,1109.758621,23947.4569,719.7413793,878.1034483,1625.12069,13537.00862,678.5775862,477.3275862,1741.887931,17153.96552,1337.491379,1483.491379,1277.905172,6087.939655,1348.025862,315.1896552,2347.241379,13376.7069,486.1551724,497.7586207,515.4396552,16007.12931,456.4310345,122.9655172,1056.577586,12099.81034,1523.887931,529.9655172,2813.543103,10841.5431,677.7155172,283.4913793,1457.465517,7717.5,823.2327586,413.2758621,1342.655172,5750.698276,720.6034483,164.2155172,1833.922414,5333.353448,1394.025862,263,3248.974138,603.5775862,796.1465517,116,13.92351966,10.77220847,0.633588858,0.950819672,0.637362637,0.826023493
+3770,34901.46535,824.9108911,492.5346535,1076.386139,31283.36634,687.1881188,810.9009901,1546.594059,18155.10891,559.009901,1120.742574,1776.90099,23129.84158,1263.158416,3247.871287,2978.287129,7694.930693,1529.287129,402.8712871,2405.376238,17411.12871,416.1980198,123.2475248,1450.940594,21477.83168,438.5247525,171.7722772,2405.108911,16869.28713,1894.19802,627.5742574,2787.613861,14373.50495,616.3861386,280.5742574,1281.326733,10549.65347,1505.178218,406.2970297,1300.386139,7652.524752,620.9207921,154.2376238,1835.039604,7041.118812,1322.653465,196.3564356,3161.534653,731.7326733,796.049505,101,15.85873467,8.338808515,0.850597088,0.918181818,0.655844156,-0.442755986
+3771,33194.27848,801.4050633,697.5443038,1065.670886,29741.67089,664.8607595,652.7721519,1608.582278,16680,507.7468354,947.4177215,1721.35443,20813.59494,1203.974684,3108.886076,2724.911392,7939.620253,1279.189873,303.0126582,2442.696203,16468.31646,423.1772152,195.9873418,873.6075949,20629.75949,424.2405063,135.9367089,1897.810127,15542.39241,1718.949367,471.0632911,2791.936709,13293.77215,591.2658228,274.8227848,1173.962025,9325.632911,933.6835443,411.0253165,1306.683544,5713.911392,614.4556962,160.164557,1772.860759,5614.341772,1253.848101,445.7721519,3201.873418,927.0126582,794.5189873,79,11.33302231,9.316371588,0.569407593,0.94047619,0.658333333,0.046177155
+3772,36455.86765,1089.960784,674.8480392,1137.215686,28689.82843,673.1078431,480.6715686,1590.710784,14411.58824,545.9264706,626.1764706,1761.142157,18357.03922,1225.843137,8397.789216,3898.328431,6625.367647,1313.372549,300.9166667,2316.745098,14115.31863,375.872549,348.1568627,557.2696078,16821.23039,419.1960784,124.4166667,7679.245098,13231.37745,1497.367647,451.5294118,2819.147059,11340,574.0196078,280.0980392,1524.764706,6514.686275,850.8235294,411.0931373,1303.666667,4730.764706,659.3578431,156.9656863,3607.553922,4246.671569,1242.269608,155.7843137,3325.95098,254.3186275,800.7058824,204,18.66317113,14.17437404,0.650526346,0.962264151,0.596491228,0.643544928
+3773,18692.03704,835.7654321,694.3333333,1086.666667,16292.08642,637.8271605,671.691358,1571.814815,8614.604938,509.0987654,2212.91358,1905.259259,10391.08642,1126.271605,8453.283951,5600.950617,4019.358025,1276.814815,301.3950617,2389.407407,8612.530864,417.3580247,868.4197531,1507.320988,9913.703704,452.2962963,174.7407407,5160.814815,7380.061728,2399.641975,444.308642,2817.222222,6640.493827,556.2592593,258.7530864,1491.469136,4243.641975,2006.938272,392.7901235,1311.45679,3388.444444,759.9876543,156.5555556,6076.469136,2858.641975,1219.061728,235.1358025,3201.703704,305.6790123,797.6790123,81,14.66990974,7.191586202,0.871594782,0.952941176,0.578571429,-0.420347702
+3774,22191.73256,882.5,547.5348837,1052.732558,20999.15116,681.127907,776.6976744,1506.174419,11223.37209,578.4418605,596.5116279,1786.767442,13913.74419,1210.348837,6279.872093,2144.662791,5220.604651,1482.94186,327.2674419,2339.837209,11036.52326,528.4767442,1043.918605,753.3023256,13213.73256,453,167.9418605,2051.709302,10056.81395,1870.05814,990,2840.77907,9071.511628,651.0348837,279.8255814,1177.94186,5800.918605,1017.139535,415.6976744,1305.988372,4617.534884,815.7325581,156.2906977,2053.232558,4156.813953,1265.104651,262.3372093,3329.267442,341.744186,797.1627907,86,13.10863445,9.610778114,0.680051935,0.826923077,0.477777778,-0.066729088
+3775,25934.13131,929.4545455,623.7171717,1091.353535,22733.0101,728.2323232,736.5454545,1576.111111,13310.33333,556.7777778,1495.888889,1789.979798,16173.31313,1321.181818,3053.393939,3912.141414,5962.717172,1718.090909,316.6565657,2403.464646,13068.35354,409.4747475,1061.929293,779.7272727,15911.0202,784.3636364,141.0505051,1995.767677,12192.42424,1793.787879,546.2626263,2816.878788,10739.17172,630.6666667,302.4242424,1481.080808,7614.848485,1502.323232,443.1717172,1356.080808,5709.040404,908.9090909,182.3030303,3268.828283,5208.333333,1425,276.4848485,3225.151515,424.2929293,796.6262626,99,12.92027738,10.47382745,0.585530529,0.933962264,0.589285714,-1.435991659
+3776,21729.16514,928.6055046,749.7247706,1113.082569,20292.81651,707.8165138,979.0458716,1596.220183,11443.6055,566.3027523,1104.587156,1846.513761,14404.19266,1268.348624,4734.724771,4012.678899,5062.201835,1963.394495,311.559633,2380.807339,11539.66055,410.8623853,1632.183486,1027.201835,13699.20183,613.9541284,127.3394495,2984.431193,10819.38532,2157,655.293578,2837.33945,9557.706422,739.5321101,287.6605505,1619.440367,6654.87156,1551.477064,438.3211009,1366.917431,4985.605505,1090.678899,171.0275229,5700.256881,4700.917431,1498.330275,267.0825688,3297.46789,438.3577982,796.559633,109,12.9933179,11.18176116,0.509318977,0.923728814,0.644970414,-0.556586039
+3777,24432.37427,931.3859649,635.6549708,1084.011696,22114.23977,741.1345029,571.9707602,1580.274854,13558.50292,584.9122807,577.2807018,1772.380117,16820.1462,1348.672515,2253.280702,3033.421053,6338.730994,2171.602339,339.245614,2348.175439,12359.68421,427.6842105,997.8011696,545.9883041,15096.33333,465.4678363,130.2280702,2327.953216,11451.50292,1743.672515,739.8362573,2828.122807,10302.73684,755.502924,294.1520468,1841.584795,7233.175439,1019.157895,448.7660819,1339.666667,5412.596491,895.6432749,178.4619883,3821.777778,5057.976608,1437.461988,1019.146199,3282.789474,451.2573099,797.6959064,171,15.28268513,14.29084042,0.35438369,0.966101695,0.7125,-1.014185281
+3778,31249.39779,777.0607735,504.9060773,1044.088398,27138.45304,666.2209945,683.2983425,1517.342541,15354.10497,500.4751381,810.5082873,1724.18232,19920.34807,1169.226519,2761.635359,2687.403315,7305.922652,1267.917127,288.5138122,2366.237569,15119.9337,417.9447514,181.5911602,802.3149171,18522.75691,545.6353591,327.3425414,2837.679558,14316.60221,1611.790055,496.839779,2795.640884,12414.45304,682.6850829,262.6353591,1617.331492,8925.414365,1005.232044,395.3867403,1306.447514,6165.906077,630.9171271,157.2541436,3706.618785,5837.828729,1238.889503,292.1325967,3173.40884,842.3977901,799.3977901,181,17.69730244,13.52617368,0.644852445,0.918781726,0.558641975,-0.883078843
+3779,40067.78481,855.7721519,598.3797468,1104,36753.29114,743.721519,940.4810127,1763.582278,18241.26582,530.5189873,2081.379747,1816.493671,25346.07595,1239.455696,7407.607595,4469.658228,9504.962025,1310.253165,306.1392405,2664.405063,19258.22785,461.5696203,211.4177215,1837.835443,24089.41772,463.6835443,209.3417722,3896.329114,18770.46835,2879.367089,549.9113924,2819.481013,15191.51899,594.7468354,292,1257.632911,10095.01266,1267.936709,415.1139241,1294.734177,5946.810127,626.7088608,160.8481013,4055.835443,5894.898734,1252.455696,231.9620253,3241.822785,1002.962025,797.1518987,79,14.28537763,7.387402509,0.855906647,0.918604651,0.552447552,-0.706982219
+3780,33985.25,896.3557692,533.6346154,1086.038462,28855.50962,690.4903846,686.0673077,1619.586538,13754.85577,566.7307692,1699.221154,1736.75,18994.08654,1162.278846,6602.634615,2820.423077,7159.836538,1217.163462,290.5384615,2467.596154,14293.28846,438.0192308,998.0961538,1117.125,17362.65385,449.5865385,155.625,1463.701923,13874.08654,2438.951923,442.7115385,2808.942308,11052.08654,578.6730769,260.0096154,885.0961538,6975.634615,1578.269231,378.4134615,1293.711538,3977.836538,782.2596154,154.0480769,2964.307692,4076.182692,1126.951923,320.6057692,3259.721154,1020.076923,798.4230769,104,16.85072653,7.952878827,0.881619647,0.928571429,0.577777778,-0.492125594
+3781,29855.59036,970.4819277,712.9879518,1070.698795,24365.84337,641.8554217,562.6746988,1498.216867,13403.68675,495.8795181,683.5542169,1742.072289,16492.10843,1141.855422,6422.409639,3205.638554,5997.566265,1308.554217,277.1927711,2379.26506,12987.10843,353.3012048,1887.795181,603.1325301,15495.90361,385.5421687,193.5783133,4126.831325,12043.85542,1709.915663,593.6987952,2810.855422,10650.6747,587.0481928,268.6385542,1196.831325,6795.39759,955.5542169,395.2168675,1302.86747,5281.240964,1033.795181,159.5903614,3091.108434,4778.373494,1225.73494,1665.337349,3220.746988,324.9277108,797.939759,83,14.3858286,7.537232578,0.851758529,0.922222222,0.58041958,-0.465398699
+3782,32931.25882,974.6588235,712.4470588,1128.858824,29629.25882,779.2823529,751.0705882,1643.741176,17218.17647,593.2352941,520.1176471,1745.411765,21482.45882,1404.752941,1704.341176,2741.917647,7789.658824,1499.776471,378.6823529,2396.082353,16974.75294,483.9529412,467.4117647,518.5058824,20559.61176,484.5058824,138.6,2215.188235,16089.6,1875.070588,673.3176471,2829.823529,14144.70588,730.4470588,323.7058824,2282.035294,10013.97647,1092.823529,480.6823529,1362.6,7598.611765,756.8470588,192.6,3258.752941,6830.764706,1568.541176,199.0117647,3379.776471,467.7058824,798,85,13.31438134,8.500636068,0.769658984,0.923913043,0.50295858,-0.844371415
+3783,26956.19444,872.4166667,589.2638889,1105.125,23187.63889,711.6527778,877.2361111,1609.736111,13612.90278,562,615.1527778,1745.305556,16568.69444,1287.430556,2252.583333,1635.763889,6227.555556,1443.486111,325.0555556,2547.541667,13493.25,462.7777778,512.5972222,613,16451.43056,834.6666667,127.2222222,958.2222222,12575.93056,1597.569444,605.5,2840.375,11156.48611,723.9722222,292.8333333,1694.583333,7739.888889,1083.027778,452.5555556,1367.25,5994.375,698.6527778,167.8194444,1785.847222,5477.930556,1409.430556,197.2361111,3276.375,489.6805556,797.4583333,72,12.12779977,8.506884861,0.712731674,0.857142857,0.6,0.001611032
+3784,29485.75,843.3085106,692.5691489,1096.792553,25883.54787,722.8829787,815.1117021,1569.12766,15351.17553,542.4574468,1421.308511,1874.707447,19093.93617,1277.808511,3415.643617,3362.271277,6797.898936,1348.718085,309.6968085,2402.154255,14830.07979,523.7393617,220.5904255,1239.611702,17938.03723,516.9680851,170.6755319,1592.031915,13813.81383,2008.441489,679.537234,2814.462766,12107.8617,1196.255319,289.4840426,1367.276596,8737.287234,1400.521277,440.1702128,1322.595745,6504.75,639.9148936,167.9946809,2944.861702,5978.473404,1370.010638,273.8723404,3265.696809,558.1542553,802.1010638,188,20.58368423,12.11038493,0.808607288,0.917073171,0.723076923,-0.128260042
+3785,26707.33566,805.3706294,470.6293706,1059.202797,24127.86713,657.020979,522.3356643,1453.65035,13682.54545,597.7972028,820.7832168,1716.986014,17310.75524,1250.335664,1768.076923,1749.629371,6236.461538,1277.48951,299.3426573,2407.076923,13301.01399,498.1328671,358.4125874,628.034965,16310.15385,442.3426573,194.8951049,1269.692308,12586.13986,1638.244755,578.4055944,2828.377622,11303.92308,713.5594406,274.0699301,1448.055944,8033.538462,1031.377622,410.0699301,1351.433566,5959.573427,651.5034965,154.2377622,2495.993007,5657.223776,1314.559441,317.0699301,3161.902098,587.027972,799.6713287,143,16.97274561,11.85826954,0.715448604,0.87195122,0.567460317,-0.350181845
+3786,15199.83203,908.9375,457.6875,1019.808594,14053.23828,658.7109375,442.2734375,1350.140625,7906.015625,517.9765625,371.7382813,1666.441406,10436.16406,1224.210938,931.9609375,1059.347656,3722.769531,1393.148438,371.6328125,2317.289063,8006.59375,385.1484375,171.7695313,483.8476563,9875.410156,560.8632813,111.2421875,1091.425781,7596.402344,1300.75,542.4921875,2825.496094,6610.5625,569.125,244.0273438,2107.746094,4992.214844,732.4648438,371.6796875,1305.6875,3776.980469,654.9257813,147.2695313,1828.695313,3582.289063,1317.035156,5808.300781,3189.347656,691.0039063,803.5898438,256,27.23401162,14.08427196,0.855890281,0.823151125,0.463768116,-0.932994609
+3787,15562.91333,660.1866667,409.6733333,1017.16,14337.22667,557.76,467.5,1388.706667,8233.846667,516.0533333,507.6666667,1694.553333,10393.38667,1102.42,1772.826667,1351.426667,3847.966667,1429.7,359.2066667,2350.766667,7847.346667,4571.493333,208.5933333,620.7933333,9768.326667,398.6333333,104.7533333,861.62,7520.133333,1358.553333,588.3333333,2781.413333,6558.113333,1350.88,227.0266667,1140.86,4856.206667,1027.34,353.8,1296.706667,3597.446667,599.42,138.2133333,2151.12,3328.666667,1156.546667,1022.4,3134.393333,720.4066667,801.2333333,150,16.80228605,11.83128739,0.710053749,0.931677019,0.555555556,0.451359327
+3788,22445.72093,850.6744186,690.6162791,1097.976744,18791.68605,656.1162791,665.6976744,1520.081395,10967.46512,655.744186,455.4186047,1724.988372,14377.86047,1240.302326,1927.046512,1374.860465,4972.639535,1443.046512,355.2790698,2370.767442,10690.98837,389.5697674,243.4651163,499.244186,12814.55814,477.7790698,114.4651163,1019.906977,10146.46512,1449.313953,485.6976744,2806.011628,8559.05814,612.3953488,260.7674419,1364.860465,6366.511628,814.8953488,394.3255814,1300.616279,4558.906977,609.4883721,153.9534884,1495,4449.511628,1293.209302,324.0697674,3112.372093,764.8139535,797.3604651,86,11.90292633,9.560779286,0.59566994,0.945054945,0.651515152,1.353976296
+3789,16862.81609,739.6321839,427.4942529,1038.402299,15242.56322,595.5287356,382.1149425,1427.482759,8520.408046,460.2758621,374.7356322,1700.810345,11161.40805,1130.425287,1431.218391,912.3218391,4203.212644,1170.965517,275.7068966,2283.132184,8441.126437,355.9827586,130.5804598,476.6494253,10577.51724,389.8448276,115.1724138,902.5574713,8158.45977,1289.247126,454.2988506,2831.528736,6959.528736,572.3045977,245.3275862,1169.16092,5066.471264,728.9367816,375.1609195,1296.454023,3440.517241,623.2816092,154.1206897,2029.229885,3394.925287,1377.982759,3630.126437,3095.701149,873.2068966,801.1896552,174,19.21283111,11.61439076,0.796595884,0.945652174,0.654135338,-0.427350828
+3790,16896.725,980.55,903.45,1171.533333,15444.71667,733.7,1187.533333,1802.858333,7864.9,557.1833333,529.0666667,1802.425,10568.61667,1261.391667,1055.966667,1030.825,4011.866667,1408.691667,312.2333333,2427.391667,8013.6,471.35,676.3166667,540.5083333,9953.558333,508.5083333,129.125,1048.675,7735.5,1581.616667,399.7583333,2824.691667,6473.383333,916.3333333,274.275,1204.9,4423.516667,908.4416667,420.05,1344.325,2700.25,709.275,159.3833333,1410.941667,2790.508333,1302.108333,375.3666667,3289.333333,974.3916667,798.1,120,13.41748382,11.49594205,0.51566845,0.952380952,0.714285714,-0.328706801
+3791,42690.55,869.7833333,554.4666667,1118.25,37751.46667,725.1833333,870.35,1797.533333,19023.41667,554.65,1850.583333,1796.216667,26023.88333,1245.2,5941.133333,2989.366667,9753.85,1314.3,314.3833333,2766.466667,19768.4,676.3666667,879.3333333,936.9,24201.15,486.7833333,454.35,3196.833333,19306.95,2540.583333,543.8,2811,15258.46667,633.4666667,292.9333333,1133.783333,9981.333333,1275.016667,415.3,1323.2,5730.933333,749.4666667,159.0333333,2786.016667,5784.35,1245.683333,447.65,3302.033333,1011.533333,797.6333333,60,11.78672097,6.848672864,0.813867944,0.869565217,0.576923077,0.179848863
+3792,38820.54717,918.8301887,602.245283,1121.292453,25999.12264,612.8962264,350.7358491,1593.924528,11662.06604,478.4056604,543.3867925,1729.707547,15884.96226,1109.226415,7267.726415,3697.990566,6024.386792,1159.481132,278.5660377,2291.716981,12318.67925,348.4716981,349.1509434,619.0471698,14697.77358,392.6792453,120.8301887,6797,10898.88679,1437.113208,378.1886792,2800.764151,9182.169811,570.8018868,256.5660377,1440.783019,4439.867925,775.754717,376.745283,1284.245283,3121.141509,629.2924528,149.5660377,4735.707547,3021.018868,1135.188679,192.3584906,3141.59434,203.2924528,800.6415094,106,16.76651581,8.404109262,0.865306202,0.905982906,0.479638009,-0.579384306
+3793,27066.79762,1018.988095,738.8333333,1141.940476,14445.7619,462.9404762,200.1785714,1184.488095,7550.619048,400.5238095,459.9761905,1678.059524,9882.22619,940.2142857,6010.595238,1199.380952,3581.714286,1075.166667,231.5952381,2281.47619,7496.940476,255.5,132.7142857,385.0357143,8870.380952,437.6785714,102,2632.892857,7324.142857,1188.809524,341.4404762,2764.964286,6252.690476,472.4404762,204.2857143,915.7380952,3778.107143,626.3928571,337.7619048,1270.666667,2728.488095,531.297619,134.7857143,1360.547619,2661.488095,1029.071429,123.6785714,3083.202381,267.0357143,797.1428571,84,11.93545017,9.230281164,0.633979241,0.933333333,0.646153846,-1.441520668
+3794,27767.76923,805.7472527,501.043956,1048.89011,25571.21978,660.7802198,752.5824176,1603.934066,14172.91209,540.4945055,1583.274725,1800.956044,17169.15385,1227.648352,7073.868132,3304.131868,6426.384615,1379.538462,308.043956,2451.032967,13889.25275,394.1428571,497.5274725,1256.78022,16782.38462,499.7912088,128.3736264,3125.868132,12798.3956,2033.274725,375.967033,2810.21978,11237.64835,613.5274725,286.5274725,1148.527473,6915.78022,1284.824176,417.8571429,1303.714286,5364.021978,687.3076923,163.1318681,4177.747253,4826.549451,1292.373626,290.2967033,3247.120879,296.2527473,797.1758242,91,13.06466095,9.954627695,0.647635016,0.858490566,0.65,-1.476809297
+3795,35938.53147,909.3146853,622.1958042,1118.664336,26301.76923,634.986014,528.2517483,1515.566434,15093.45455,510.1608392,1566.160839,1787.475524,18130.27972,1163.258741,8238.167832,4377.804196,6555.93007,1339.482517,285.3426573,2375.244755,14240.46853,370.1398601,911.6713287,1116.685315,16647.79021,551.1748252,132.1678322,4505.825175,13177.79021,2056.748252,494.972028,2811.839161,11654.02797,571.7412587,276.0699301,1201.538462,7275.692308,1296.41958,408.951049,1303.06993,5495.048951,779.1048951,161.5454545,3295.818182,4940.51049,1239.062937,208.3846154,3230.811189,314.0559441,800.4265734,143,18.51824958,10.27528345,0.831934823,0.877300613,0.525735294,-0.680584141
+3796,20854.87356,887.091954,465.3793103,1036.574713,18871.44828,702.3908046,474.2873563,1453.390805,11054.75862,536.4942529,539.6206897,1683.16092,13658.68966,1343.747126,2053.701149,2914.954023,4830.057471,1453.034483,393.6666667,2387.54023,10694.02299,418.6896552,100.6321839,538.7471264,13333.7931,765.8275862,119.7701149,1752.344828,10062.02299,1353.287356,634.091954,2804.08046,8914.252874,566.2873563,273.4827586,1688.609195,6669.241379,838.1034483,398.9770115,1287.252874,4944.770115,600.7011494,162.2298851,2257.850575,4510.597701,1426.643678,1704.471264,3106.517241,684.5632184,797.2183908,87,14.44225729,7.90874008,0.836732996,0.90625,0.69047619,-1.19909708
+3797,24934.89157,774.2771084,679.4638554,1068.536145,22257.57831,630.9879518,623.9216867,1602.740964,12331.25301,480.7349398,627.5060241,1732.391566,15946.90361,1173,3585.463855,2477.277108,6024.313253,1230.271084,281.3915663,2371.626506,12152.61446,411.9156627,174.1807229,722.126506,15526.93976,426.6746988,131.6325301,4051.096386,11468.30723,1539.078313,543.2228916,2810.831325,9782.89759,659.2831325,259.3493976,1398.283133,6745.385542,847.3855422,401.6626506,1300.861446,4413.674699,613.2409639,153.5542169,2983.373494,4269.23494,1185.415663,218.1746988,3192.138554,917.5722892,800.4156627,166,16.20261611,13.27106584,0.573694554,0.943181818,0.737777778,0.813475818
+3798,32606.34737,964.0631579,551.9157895,1104.305263,30290.92632,783.8315789,813.8631579,1639.863158,16587.86316,589.7684211,775.9368421,1777.347368,19913.56842,1366.863158,5675.884211,3524.126316,7220.873684,1426.884211,320.0210526,2359.410526,15555.85263,1664.357895,243.6,818.5894737,18888.47368,485.2526316,490.6210526,3858.968421,14318.04211,1656.715789,577.4105263,2817.684211,12792.18947,635.5368421,304.3263158,1758.484211,8221.715789,877.4842105,454.4526316,1313.421053,6358.505263,665.6315789,178.8315789,4864.642105,5753.157895,1378.673684,335.2526316,3306.989474,350.9157895,799.7473684,95,12.80510982,10.18305143,0.606303381,0.931372549,0.664335664,1.36990296
+3799,30859.93333,1002.588889,547.7222222,1085.222222,28921.72222,749.3222222,800.1111111,1585.766667,15935.98889,596.3666667,1088.233333,1781.388889,19336.4,1325.511111,3603.355556,3020.833333,7069.4,1414.7,328.6555556,2733.777778,15055.28889,412.4,154.3777778,642.5222222,17863.15556,592.6777778,158.8888889,2321.744444,13831.33333,1851.722222,499.0666667,2875.866667,12092.7,1534.255556,305.8555556,1536.888889,8382.977778,1055.422222,441.1444444,1312.711111,6320.433333,638.6111111,172.9,3777.811111,5659.177778,1380.933333,946.8666667,3355.888889,388.3666667,799.2888889,90,12.83327749,10.26745193,0.599913762,0.849056604,0.576923077,1.401199931
+3800,18750.98039,783.1078431,574.5,1089.598039,16602.23529,626.8529412,651.2647059,1531.539216,9569.558824,502.2156863,456.5784314,1774.235294,11934.41176,1214.392157,3500.578431,1930.490196,4470.578431,1320.715686,292.7254902,2389.745098,9881.411765,598.9215686,1159.803922,455.7254902,11746.66667,458.2941176,121.1078431,1337.441176,8740.127451,1743.911765,887.1862745,2810.803922,7875.901961,623.4607843,274.3137255,1744.205882,5582.803922,900.2156863,426.2254902,1352.137255,4341.401961,842.4313725,166.7843137,2445.156863,3953.617647,1309.117647,159.7058824,3330.421569,497.5196078,801.3235294,102,14.8941029,9.148797351,0.78910654,0.902654867,0.579545455,-0.134652211
+3801,32946.53939,841.7272727,529.9939394,1093.430303,29148.64242,683.8,555.9515152,1598.812121,17171.10303,532.3272727,600.3575758,1760.036364,21133.72727,1254.709091,3061.866667,2356.581818,7595.387879,1358.478788,310.2787879,2352.915152,16728.13939,4617.418182,202.2,561.9393939,20066.87879,656.2606061,130.0242424,1923.551515,15614.31515,1508.054545,637.0484848,2794.745455,13579.63636,658.8666667,285.9636364,1447.133333,9922.054545,960.230303,436.4484848,1313.490909,7392.921212,662.7878788,168.0424242,2782.690909,6725.757576,1357.806061,369.5454545,3275.10303,545.630303,800.9878788,165,18.56618996,14.40427657,0.630937405,0.812807882,0.509259259,1.366391141
+3802,9944.892157,730.872549,415.4705882,975.745098,9195.862745,580.745098,419.372549,1251.235294,5369.411765,453.9411765,344.7156863,1655.382353,7156.911765,1155.352941,861.9803922,902.5588235,2742.852941,1364.029412,374.9705882,2322.852941,5603.254902,363.7352941,93.38235294,450.6372549,6828.382353,490.2647059,106.2254902,882.5588235,5386.990196,1206.313725,525.6568627,2787.578431,4778.617647,588.5588235,233.5294118,1831.911765,3609.519608,712.1862745,363.9019608,1318.098039,2693.137255,591.3921569,141.2647059,1809.705882,2675.990196,1422.843137,15369.9902,3134.764706,704.8431373,801.2058824,102,14.69512925,8.957465205,0.792745053,0.980769231,0.755555556,-0.083266431
+3803,24972.93884,808.8562691,563.0917431,1051.810398,19612.20795,564.4281346,729.3058104,1473.373089,9211.370031,498.3547401,1442.055046,1737.623853,13284.22018,1022.75841,8985.675841,2535.697248,5072.366972,1163.64526,262.7217125,2928.590214,10011.63914,356.7094801,770.4311927,1564.547401,12454.33028,401.4648318,196.351682,2101.556575,9577.033639,2436.941896,506.6788991,2796.721713,7687.003058,554.440367,232.9541284,865.7522936,4860.654434,1150.599388,356.0122324,1295.103976,2687.938838,708.1926606,142.9357798,3681.186544,2851.847095,1033.076453,386.8593272,3140.724771,1031.363914,805.8348624,327,22.31655737,19.30449968,0.501719518,0.928977273,0.648809524,-0.243869203
+3804,24689.74615,854.4076923,558.4692308,1065.423077,22427.01538,682.8307692,999.1076923,1587.561538,12261.46154,557.1769231,1873.569231,1827.115385,15098.45385,1239.123077,8652.9,4034.907692,5566.684615,1372.515385,305.6153846,2527.315385,11889.01538,456.0846154,865.4692308,1269.361538,14081.24615,467.6,777.3461538,4004.923077,10836.83077,2428.969231,590.7538462,2821.523077,9695.492308,637.0307692,286.4,1287.192308,6177.715385,1311.892308,417.6923077,1316.869231,4845.107692,781.5923077,169.7076923,4464.323077,4373.076923,1308.2,1003.292308,3291.692308,334.2461538,803.1076923,130,17.09579736,11.04927035,0.763070714,0.838709677,0.509803922,1.053178812
+3805,25568.01075,895.3655914,901.5591398,1142.763441,23438.32258,719.5806452,854.6021505,1691.806452,13048.91398,551.7849462,521.1397849,1763.849462,16005.45161,1302.612903,1506.827957,1804.462366,5968.505376,1393.150538,316.2258065,2438.516129,12991.34409,1485.462366,295.0967742,495.4408602,15796.91398,506.7311828,127.7741935,1312.182796,11925.53763,1483.688172,534.1182796,2838.139785,10438.77419,1286.741935,302.2258065,1935.086022,7357.397849,913.3010753,455.9032258,1353.623656,5791.354839,651.2795699,169.1505376,3005.322581,5065.698925,1472.88172,400.8709677,3375.655914,480.7634409,800.5913978,93,11.72550325,10.19485977,0.494002792,0.96875,0.768595041,-0.87385533
+3806,27731.84615,820.8736264,586.6483516,1058.346154,25330.18681,677.7967033,826.5659341,1542.862637,14510.24176,679.3351648,1085.027473,1775.615385,17923.3956,1222.521978,2428.043956,2156.137363,6573.082418,1303.186813,287.6703297,2397.56044,13778.36813,428.7417582,380.7802198,885.7582418,16545.51648,423.478022,220.0549451,1010.56044,12644.65385,1879.703297,530.4505495,2802.554945,11298.46703,707.2472527,270.7582418,1238.307692,7975.593407,1163.027473,398.8296703,1333.82967,6032.961538,664.6538462,151.7472527,1962.802198,5509.06044,1294.868132,272.489011,3251.494505,597.0934066,806.2417582,182,17.05326135,14.25287673,0.549055368,0.933333333,0.631944444,0.068290298
+3807,32053.27891,818.7687075,510.6734694,1079.414966,28657.63946,673.047619,817.0408163,1540.884354,16045.20408,524.0544218,1441.122449,1784.646259,20728.91156,1245.571429,4381.469388,3329.122449,7385.102041,1277.571429,288.8027211,2439.816327,15800.31973,442.6802721,126.047619,1632.972789,19111.35374,1260.197279,427.5782313,3658.265306,14606.2381,1887.29932,643.8503401,2786.931973,12752.44218,628.1428571,259.0408163,1517.877551,9260.251701,1290.129252,390.829932,1308.789116,6981,609.3061224,155.1156463,4380.489796,6368.517007,1320.020408,1033.782313,3230.088435,630.0544218,803.7006803,147,15.32165353,12.67318453,0.561992849,0.936305732,0.6125,0.656807468
+3808,15142.10784,703.5,403.9901961,1001.676471,14128.4951,581.9215686,456.0980392,1369.617647,8110.754902,453.9754902,443.1029412,1677.544118,9887.181373,1131.372549,973.2647059,943.5343137,3905.509804,1341.303922,320.2794118,2315.52451,8156.151961,359.5196078,105.9754902,544.5490196,9883.063725,419.9460784,105.1421569,845.122549,7678.784314,1307.926471,529.25,2804.181373,6994.759804,715.7892157,231.4803922,1498.480392,5152.362745,767.5343137,366.9313725,1297.014706,3907.666667,615.6421569,144.4019608,1322.068627,3636.955882,1334.161765,7701.480392,3129.887255,657.4705882,806.0588235,204,20.83058386,13.49429521,0.76180053,0.927272727,0.566666667,-0.709031711
+3809,36325.5625,859.2625,543.2875,1085.05,32625.9125,701.6625,632.3625,1679.925,15475.775,536.1625,2023.35,1756.25,21102.3625,1258.0875,7062.025,5291.3,8405.875,1312.725,318.9625,2342.8125,17319.8,386.3,272.7,1671.3375,21435.6625,472.875,167.3625,6084.925,15983.25,2260.425,397.95,2818.0625,14019.7625,663.575,311.925,1590.175,7346.3625,1660.125,437.2375,1298.35,5123.2,660.8375,166,3932.625,4973.4625,1309.9875,248.75,3271.1125,213.9625,802.225,80,11.29925294,9.170298959,0.584235004,0.952380952,0.615384615,1.33921625
+3810,25527.78205,899.4102564,689.1666667,1121.230769,23679.25641,719.6923077,729.1923077,1621.051282,13040.47436,554.1282051,453.6538462,1723.910256,16496.60256,1329.730769,1421.333333,1208.782051,5868.128205,1403.987179,324.6282051,2379.089744,13075.96154,469.4230769,643.8717949,458.4358974,15790.30769,455.6666667,131.8076923,1029.25641,12213.55128,1525.987179,510.8205128,2818.423077,10684.48718,863.4487179,301.4102564,1766.576923,7463.24359,851.2051282,459.9102564,1344.820513,5768.717949,772.5769231,181.2307692,1776.615385,5112.948718,1438.141026,320.9871795,3285.769231,471.6538462,805.3717949,78,11.81300784,9.667067203,0.574733162,0.821052632,0.464285714,-1.517464959
+3811,29394.83333,945.8571429,666.202381,1112.666667,25467.04762,735.2380952,561.2738095,1604.821429,15024.95238,561.4761905,459.9285714,1736.22619,18192.57143,1337.059524,3351.630952,2846,6624.261905,1385.892857,323.25,2376.666667,14676.27381,450.9166667,231.7380952,441.9047619,17463.59524,449.1785714,131.297619,3623.857143,13312.4881,1537.214286,954.0238095,2817.619048,11979.59524,646.7380952,295.7380952,1841.738095,8149.357143,954.3928571,444.25,1328.166667,6306.488095,653.702381,166.1309524,1667.369048,5719.130952,1397.416667,158.9285714,3312.666667,506.1309524,805.797619,84,14.71305254,9.996485038,0.7337406,0.730434783,0.428571429,0.574942633
+3812,25782.20202,966.3030303,641.4040404,1095.848485,23545.62626,756.0707071,646.5959596,1593.464646,13389.42424,584.7474747,445.7979798,1740.79798,16350.19192,1384.676768,1609.151515,1138.242424,5876,1387.484848,331.3636364,2339.363636,13190.42424,469.040404,236.8787879,482.1616162,16092.26263,509,136.3838384,1754.949495,11991.0404,1488.525253,642.4949495,2816.454545,10734.52525,632.0808081,307.959596,1903.434343,7372.606061,1003.333333,449.969697,1341.707071,5858.989899,656.8080808,172.3030303,1552.020202,5205.727273,1459.727273,579.1717172,3236.363636,514.8080808,805.040404,99,13.8418492,9.304603276,0.740362248,0.99,0.634615385,0.727959861
+3813,26319.7868,1007.030457,618.5279188,1100.517766,20584.04569,642.7106599,404.2741117,1508.888325,10033.51269,529.0609137,517.5685279,1769.715736,13175.73096,1182.314721,5270.954315,2718.15736,5044.928934,1245.096447,285.4670051,2312.598985,10451.79695,2237.873096,610.5380711,507.6243655,12746.3401,431.786802,120.5837563,6406.279188,9810.949239,1504.243655,402.3502538,2818.741117,8520.213198,605.6192893,256.5177665,1347.807107,4831.771574,775.0507614,389.8020305,1312.51269,3532.477157,720.6040609,152.1269036,3315.492386,3227.411168,1186.969543,182.5888325,3346.472081,243.6040609,808.3350254,197,19.57889434,13.55182941,0.721739101,0.933649289,0.648026316,0.998681495
+3814,18649.82955,782.7386364,549.4318182,1059.375,16516.47727,636.9772727,779.4545455,1548.204545,9007.977273,510.4090909,1869.329545,1892.772727,10981.61364,1148.852273,6986.272727,4788.238636,4261.011364,1273.011364,291.1477273,2547.886364,8854.772727,351.1590909,1304.761364,1891.670455,10579.84091,428.7045455,223.7954545,3774.284091,7840.965909,2082.090909,400.1704545,2801.284091,6912.022727,642.4545455,260.1818182,1407.136364,4302.931818,1211.318182,396.4772727,1338,3338.272727,868.0909091,177.5795455,5073.056818,2926.102273,1215.022727,717.5454545,3277.488636,293.3863636,805.7840909,88,12.3373778,10.38006361,0.54048932,0.88,0.483516484,1.293745112
+3815,27533.2381,870.5714286,569.5767196,1094.730159,25754.83069,680.015873,687.9417989,1595.031746,14315.86772,533.5608466,900.3280423,1807.201058,17193.47619,1237.873016,5288.407407,4168.312169,6440.661376,1369.507937,304.8095238,2364.259259,13873.80952,399.4973545,307.7724868,723.0793651,16352.4127,679.6719577,126.9417989,3827.608466,12652.22751,1649.391534,474.6613757,2823.566138,11286.18519,627.2275132,286.1322751,1530.497354,7532.185185,1630.777778,437.5555556,1312.978836,5825.026455,830.994709,174.2592593,5537.52381,5129.746032,1349.597884,361.7936508,3298.396825,364.9100529,807.994709,189,18.16591626,14.93926907,0.568939968,0.832599119,0.552631579,-1.210706395
+3816,30525.46739,1033.065217,689.4565217,1090.271739,26880.76087,758.1304348,617.2934783,1608.315217,15263.5,594.7608696,669.6630435,1745.228261,18694.3587,1327.978261,4411,4461.891304,6652.804348,1614.347826,317.0434783,2327.847826,14424.57609,404.6956522,723.2065217,576.5543478,17076.01087,561.8152174,125.173913,3719.48913,13461.32609,1658.98913,617.4021739,2817.434783,11696.80435,637.326087,294.7934783,1787.532609,7954.532609,1024.195652,422.1521739,1320.380435,5917.521739,803.4891304,169.5978261,3299.478261,5309.043478,1334.402174,206.0869565,3380.195652,429.6195652,804.6195652,92,14.17951401,8.660580509,0.791799427,0.92,0.575,-1.492783073
+3817,35659.295,838.875,528.43,1075.72,32250.755,695.66,666.98,1580.56,18516.65,527.895,827.37,1737.555,22368.705,1257.585,2605.755,3127.67,8306.755,1328.055,288.245,2359.82,17653.42,452.095,129.15,993.495,21661.16,422.535,142.545,1834.6,16579.18,1651.64,603.005,2781.66,14591.54,615.075,275.625,1361.175,10461.835,1074.565,401.3,1288.51,7964.115,614.99,155.98,1946.48,7181.265,1356.67,721.735,3181.785,622.465,811.715,200,22.44274695,12.0881723,0.842547102,0.904977376,0.588235294,0.610582942
+3818,20929.37864,800.8446602,688.3592233,1079.834951,18550.95146,651.1067961,634.7378641,1537.631068,10273.34951,739.5339806,428.3980583,1743.582524,13685.76699,1198.213592,1215.873786,1147.213592,5044.854369,1367.796117,293.0194175,2354.514563,10329.25243,401.407767,278.3106796,472.5339806,12935.60194,530.6796117,117.5145631,1007.728155,9729.067961,1439.378641,473.6213592,2806.902913,8463.407767,718.961165,257.0582524,1476.84466,6325.514563,844.2330097,395.9902913,1344.786408,4584.23301,642,153.8737864,1405.378641,4321.757282,1297.300971,207.8058252,3217.029126,797.2718447,806.8349515,103,12.64128043,10.9640708,0.497746071,0.895652174,0.66025641,0.045661028
+3819,24282.90714,820.3714286,514.1357143,1052.342857,19749.73571,652.1071429,542.1357143,1460.65,10604.25,507.5785714,761.8214286,1697.892857,14822.36429,1209.635714,2369.642857,2330.914286,5289.9,1239.65,292.2285714,2305.571429,10935.99286,809.2071429,116.1142857,750.9642857,13388.70714,518.6285714,280.6642857,1405.864286,10326.07143,1592.764286,470.8928571,2799.364286,8811.257143,721.2,264.5357143,1437.642857,6415.678571,956.9214286,400.4857143,1299.992857,4523.907143,588.4642857,162.6571429,3186.428571,4333.392857,1314.842857,2275.785714,3147.4,849.6928571,810.0214286,140,16.82083674,11.28842022,0.74136917,0.939597315,0.566801619,0.123935617
+3820,38847.02542,822.9237288,493.0338983,1088.288136,34707.01695,754.1949153,1062.991525,1757.194915,17138.51695,522.2881356,2607.415254,1826.923729,24001.26271,1214.610169,6554.067797,3731.59322,8981.788136,1294.466102,308.940678,2542.322034,18040.19492,469.5932203,320.0169492,2321.70339,22314.05085,473.5677966,792.9830508,1481.830508,17687.94915,2528.016949,409.7118644,2813.720339,14302.16949,612.4067797,276.3474576,1004.211864,9273.415254,1451.720339,406.8559322,1306.20339,5360.118644,638.8474576,153.1525424,3920.118644,5398.135593,1225.5,495.4067797,3332.364407,1003.805085,806.7966102,118,16.83750417,9.174849086,0.838497446,0.907692308,0.567307692,-1.049711759
+3821,28494.84116,832.5018051,619.5306859,1090.33213,21882.08664,624.7220217,796.3826715,1654.393502,9608.126354,585.3249097,1972.00722,1753.483755,14379.14801,1136.375451,7716.310469,3068.151625,5430.606498,1467.960289,283.9783394,2898.732852,10895.36823,821.8086643,850.0252708,1460.714801,13635.08664,540.6245487,117.2166065,2121.436823,10014.1083,2481.090253,403.5018051,2807.375451,8021.924188,609.3971119,246.8519856,849.4079422,4821.252708,1245.288809,369.7509025,1308.945848,2557.862816,746.2815884,146.9061372,3033.844765,2815.158845,1085.772563,1233.111913,3169.400722,1051.216606,809.3790614,277,23.37721887,15.58490155,0.745352589,0.899350649,0.669082126,-1.413992428
+3822,21089.82,935.38,578.97,1072.98,19695,676.9,608.51,1530.23,10712.2,564.48,859,1745.25,13730.76,1240.06,1275.88,1852.55,4934.39,1540.68,392.51,2360.23,10297.5,429.07,186.34,1234.17,12730.5,401.55,128.26,941.12,9783.33,1635.31,507.9,2818.99,8375.9,641.42,268.84,1313.47,6201.15,1144.11,395.76,1304.66,4682.84,622.44,151.02,1528.01,4184.05,1318.35,963.26,3166.82,733,808.22,100,12.29654922,10.58397266,0.509066722,0.925925926,0.641025641,1.106887391
+3823,14157.32031,830.0859375,683.828125,1099.304688,12413.76563,619.9375,612.1640625,1511.3125,6911.546875,623.0390625,490.6875,1702.257813,8984.640625,1174.679688,1266.460938,1100.234375,3321.648438,1402.125,345.3984375,2336.9375,6899.625,445.6875,271.0546875,554.4921875,8455.5,422.5234375,109.2578125,854.4453125,6547.476563,1399.796875,472.9765625,2782.164063,5639.734375,991.46875,246.3671875,1543.390625,4300.8125,775.625,375.0078125,1323.125,3058.320313,628.5234375,157.1640625,2212.976563,2982.210938,1267.0625,537.8984375,3201.140625,760.4140625,808.0078125,128,14.01477513,11.69794587,0.550725137,0.962406015,0.761904762,-0.132509226
+3824,32667.58291,847.1105528,625.8542714,1087.437186,29053.31156,694.2261307,929.6834171,1620.19598,16843.66332,580.0753769,1419.01005,1777.38191,21086.56281,1255.025126,3273.386935,3837.884422,7884.633166,1303.286432,312.6934673,2402.839196,16313.88442,413.5829146,489.9045226,892.3467337,20377.43719,1435.231156,152.2361809,2505.442211,15584.00503,1752.155779,543.9648241,2789.130653,13581.80402,640.5376884,274.120603,1502.316583,9928.703518,1290.603015,417.6683417,1314.567839,6863.778894,745.7788945,160.4170854,3131.075377,6492.025126,1339.266332,359.6532663,3236.472362,818.1809045,811.1457286,199,19.02480123,14.07687287,0.672692449,0.876651982,0.663333333,-0.447166646
+3825,31904.05755,912.7553957,622.2446043,1114.115108,25177.09353,652.352518,716.381295,1611.302158,13017.41727,515.9568345,1220.834532,1739.726619,17431.89209,1176.748201,5323.172662,3348.561151,6615.093525,1236.604317,294.1582734,2356.453237,13501.76259,461.2877698,432.8992806,1190.014388,16806.88489,440.8848921,134.5395683,3910.388489,13170.45324,1993.568345,451.9640288,2791.726619,10814.08633,671.5251799,265.3381295,1232.258993,7127.107914,1010.625899,393.3381295,1300.884892,4177.086331,655.3381295,154.057554,4529.827338,4275.05036,1193.345324,205.0143885,3317.453237,989.8129496,807.618705,139,17.61650794,10.50022302,0.802951387,0.885350318,0.668269231,-1.036376252
+3826,38082.84677,963.4032258,557.5887097,1113.782258,35218.49194,742.2822581,804.0806452,1649.201613,19173.5,593.1532258,1461.129032,1763.548387,23233.54839,1352.112903,3890.209677,3400.854839,8538.209677,1436.798387,338.25,2353.919355,18531.40323,427.1854839,266.9274194,869.0645161,22661.16935,945.6854839,141.1854839,2551.435484,17196.28226,1537.370968,533.7419355,2853.233871,15089.26613,1025,314.8870968,1434.564516,10296.27419,1033.758065,454.7016129,1318.806452,7919.435484,673.266129,176.8387097,2180.91129,7109.806452,1452.596774,705.4112903,3322.177419,383.7741935,808.0725806,124,15.782879,10.43260927,0.750378854,0.905109489,0.645833333,-1.491376684
+3827,16209.9845,977.0310078,535.1627907,1032.426357,14630.42636,675.4573643,540.0620155,1401.930233,8042.775194,545.7906977,582.9767442,1717.062016,9558.914729,1189.581395,2240.627907,1711.193798,3798.054264,2481.829457,274.379845,2364.829457,7820.255814,402.3100775,697.0542636,535.6356589,9190.054264,399.372093,113.2093023,2371.72093,7139.937984,1508.503876,464.2635659,2826.775194,6283.806202,691.6124031,245.5426357,1231.860465,4431.395349,765.2945736,387.4108527,1321.550388,3459.813953,767.503876,153.3023256,2410.573643,3018.062016,1168.209302,300.0387597,3429.031008,419.7364341,810.6046512,129,15.36565195,11.74558963,0.644735725,0.87755102,0.505882353,0.245512289
+3828,25612.04545,831.0454545,721.1477273,1174.397727,22401.15909,642.2954545,694.125,1754.613636,12372.80682,564.5454545,518.3977273,1779.272727,16218.05682,1182.477273,3078.772727,3833.261364,5817.068182,1245.534091,292.0909091,2322.613636,11941.59091,481.8409091,521.4886364,526.1477273,14454.46591,486.9204545,117.8181818,2789.375,11221.04545,1456.136364,545.4204545,2787.784091,9721.352273,871.0340909,259.2613636,1572.363636,6998.534091,874.4545455,391.1818182,1299.204545,4841.602273,722.8068182,154.9204545,3471.375,4601.647727,1243.590909,512.2840909,3235.715909,828.7840909,809.4318182,88,15.63814105,7.403385349,0.880837624,0.897959184,0.698412698,-0.16876625
+3829,36421.75148,871.4556213,573.6390533,1093.491124,31442.93491,714.5266272,1330.35503,1672.35503,16889.39645,532.260355,1622.47929,1770.887574,22093.22485,1215.017751,3432.591716,2715.852071,8257.751479,1275.828402,304.5147929,2784.887574,16784.02367,4537.816568,167.7810651,1719.455621,21202.84615,544.5029586,548.8579882,1330.035503,16146.33728,2424.905325,428.443787,2835.372781,13769.07692,681.1597633,266.9940828,1081.727811,9074.615385,1468.840237,417.4201183,1307.313609,5610.83432,613.147929,160.1597633,2450.822485,5581.899408,1250.011834,285.1301775,3344.970414,941.2189349,813.6213018,169,25.0848162,10.38993907,0.910189372,0.754464286,0.469444444,-0.713883676
+3830,38853.15278,997.8194444,621.2361111,1127.916667,35626.125,722.4444444,491.4583333,1751.152778,16591.75,541.2083333,775.8194444,1762,23049.66667,1266.361111,4559.194444,4343.847222,8534.666667,1323.055556,315.7361111,2326.333333,18015.68056,397.7777778,222.0972222,817.8333333,21655.08333,443.3194444,132.0416667,5223.055556,16444.56944,1881.180556,445.9305556,2831.958333,14121.22222,609.6805556,301.8333333,1631.986111,6981.111111,1043.236111,422.5972222,1307.819444,4720.597222,636.6111111,166.7916667,4004.666667,4580.236111,1298.472222,221.2638889,3255.458333,206.5555556,809.0694444,72,12.40459229,7.745937452,0.781071887,0.947368421,0.553846154,-1.202855278
+3831,29075.31694,882.420765,540.6557377,1076.306011,28977.72131,694.6502732,468.1748634,1583.47541,13042.56284,538.3879781,654.0437158,1717.442623,18796.57923,1300.398907,4607.174863,3210.622951,7032.021858,1322.699454,317.5956284,2354.68306,14891.5847,395.3661202,379.4644809,559.863388,18003.1694,542.1584699,130.1202186,3872.409836,13563.61202,1534.234973,431.1803279,2808.852459,11789.95082,616.9344262,294.0054645,1432.863388,6130.830601,864.3442623,418.8196721,1299.677596,4366.213115,677.8032787,166.715847,3630.73224,4207.857923,1350.36612,875.9726776,3239.666667,218.6666667,813.4918033,183,19.44014246,12.21288121,0.778027656,0.91959799,0.61,-0.423923594
+3832,17913.61702,775.1276596,528.3617021,1027.978723,15951.20213,610.5531915,558.2978723,1394.43617,8947.117021,502.4148936,542.9787234,1712.787234,11243.73404,1160.106383,3430.457447,2661.234043,4191.840426,1599.531915,287.0425532,2359.808511,8902.234043,357.5957447,1461.87234,532.3510638,10921.56383,412.287234,116.893617,2320.042553,8309.914894,1679.329787,649.0531915,2811.968085,7458.446809,827.2553191,255.1808511,1422.542553,5177.851064,914.9787234,406.893617,1329.095745,3903.531915,966.2659574,163.7340426,4810.574468,3633.255319,1277.06383,352.0319149,3197.468085,445.5957447,809.9148936,94,11.76397051,10.26384117,0.488647974,0.94,0.712121212,0.269157199
+3833,29726.65625,837.3229167,477.9895833,1052.697917,26016.02083,685.6770833,391.2395833,1431.46875,15418.9375,548.4375,576.5,1726.520833,19063.59375,1329.364583,2595.208333,1679.854167,6780.833333,1392.229167,323.9479167,2408.541667,15138.48958,1044.864583,254.9479167,521.0520833,18344.26042,768.6666667,127.9895833,1538.375,14393.85417,1500.5,568.7916667,2848.677083,12569.52083,708.0833333,294.3020833,1968.947917,9065.520833,942.9895833,436.9895833,1348.697917,6835.145833,686.9895833,174.5416667,2528.416667,6243.083333,1426.416667,898.2395833,3193.489583,540.4479167,808.8958333,96,13.89205474,9.458354397,0.732426299,0.888888889,0.533333333,1.198492273
+3834,25701.58763,918.2680412,751.8350515,1133.793814,22367.76289,715.8865979,683.3092784,1684.154639,12251.51546,551.628866,466.1030928,1765.082474,16330.19588,1315.340206,1616.835052,2041.43299,5827.474227,1342.85567,311.6701031,2335.608247,12005.48454,456.6082474,128.9381443,481.0927835,14706.60825,565.4639175,125.8659794,1512.010309,11121.46392,1410.402062,507.5257732,2816.134021,9655.340206,767.0515464,287.9690722,1873.56701,7124.14433,904.1340206,427.5773196,1332.680412,5117.360825,609.4639175,160.7731959,1439.42268,4773.402062,1405.536082,149.8350515,3342.484536,788.0103093,809.5876289,97,13.8108929,9.298078469,0.739421863,0.91509434,0.621794872,0.444411524
+3835,40626.50467,952.3738318,575.0373832,1130.429907,10592.42991,429.1962617,237.8971963,1170.149533,5344.841121,374.1775701,530.1588785,1704.719626,6842.934579,880.8317757,4197.850467,1769.401869,2594.71028,1027.327103,210.7196262,2264.495327,5289.598131,235.2523364,310.1588785,479.9813084,6457.224299,291.317757,103.6261682,2419.794393,4976.616822,1238.588785,308.1028037,2790.308411,4331.560748,464.3271028,195.8317757,914.635514,2547.88785,684.3457944,324.9065421,1273.934579,1860.878505,542.4672897,131.5514019,2154.551402,1810.17757,921.9252336,128.0280374,3061.943925,266.364486,810.8504673,107,12.73662636,10.75494396,0.535696294,0.938596491,0.685897436,-1.002868439
+3836,30477.845,911.62,607.65,1113.495,26565.815,669.965,798.565,1566.765,14218.215,531.055,1858.595,1829.105,17371.89,1217.445,6078.585,3624.625,6432.825,1354.305,321.295,2546.3,13765.07,371.02,540.935,1347.575,16555.04,490.31,250.72,2686.865,12861.49,1985.175,413.575,2807.185,11213.135,592.805,279.015,1358.69,6839.65,1300.015,414.255,1301.705,5294.685,684.35,161.11,3444.54,4732.025,1281.585,452.57,3301.49,299.445,814.57,200,21.05550307,12.87085819,0.791412562,0.921658986,0.555555556,-0.938513754
+3837,35908.4,921.9846154,520.8307692,1086.815385,32158.33846,738.9692308,703.0769231,1643.615385,18882.70769,587.6461538,1063.615385,1821.261538,22056.15385,1320.615385,4914.384615,3585.307692,7962.707692,1430.061538,336.5538462,2357.107692,17411.03077,428,216.4,938.7846154,20863.44615,1016.323077,136.8769231,2665.323077,16396.27692,1655.092308,428.1076923,2822.830769,14669.89231,609.6307692,308.2307692,1503.015385,9333.753846,1198.707692,451.9538462,1308.892308,6977.215385,665.7538462,177.9538462,3605.046154,6443.938462,1385.307692,297.3076923,3279.323077,349.5692308,808.5076923,65,10.66049893,8.038320152,0.656841688,0.970149254,0.722222222,-1.071001934
+3838,19427.87805,862.9658537,798.6292683,1105.570732,17948.40976,676.7902439,859.5170732,1589.02439,9941.834146,545.5560976,710.2292683,1772.390244,12347.9561,1240.629268,1562.712195,1873.721951,4606.2,1358.121951,301.4390244,2638.014634,10199.29756,441.8195122,1000.717073,729.3219512,11971.58049,761.8097561,122.2097561,925.8878049,9166.57561,1483.707317,547.6439024,2814.078049,8149.678049,653.8097561,281.2926829,1631.312195,5629.087805,945.3317073,431.1512195,1372.731707,4449.785366,797.8780488,163.6390244,2511.204878,3965.395122,1330.121951,232.604878,3269.380488,484.9658537,811.1902439,205,22.09781079,12.11917426,0.836194336,0.907079646,0.665584416,-1.350039938
+3839,27598.95455,781.4166667,572.3181818,1060.621212,24797.0303,638.7878788,812.7121212,1511.090909,14428.55303,560.7121212,1676.984848,1772.674242,17445.09091,1188.30303,2842.05303,2481.19697,6350.75,1293.712121,273.4924242,3784.636364,13392.78788,667.4621212,323.8030303,667.6287879,16367.12879,1023.621212,129.8106061,1023.886364,12618.93182,1696.606061,534.6590909,2797.765152,11198.40152,664.030303,269.2651515,1238.734848,7841.977273,1294.113636,402.5454545,1466.795455,5841.969697,640.9393939,151.3409091,2087.44697,5399.05303,1262.916667,203.7424242,3290.159091,582.8333333,812.1893939,132,14.37265486,11.91062435,0.559692507,0.970588235,0.628571429,0.927868516
+3840,27403.06757,878.8783784,783.8108108,1112.608108,23511.12162,688.3918919,782.1216216,1634.216216,13739.56757,589.2027027,699.5405405,1702.094595,17468.37838,1317.486486,1160.283784,1285.364865,6325.432432,1336.918919,311.472973,2369.175676,13156.75676,439.4324324,212.4054054,543.7432432,16522.56757,675.1486486,120.1756757,1003.472973,12623.7027,1519.351351,473.8243243,2807.513514,10962.05405,633.4054054,277.4459459,1329.175676,8022.027027,900.7432432,417.3918919,1319.918919,5643.418919,632.2567568,163.7297297,1420,5364.22973,1359.702703,180.4459459,3220.567568,806.6621622,809.8378378,74,12.45493803,8.096081891,0.759908648,0.880952381,0.616666667,-0.058190415
+3841,16914.49412,800.1058824,791.1058824,1097.223529,15456.52941,635.5647059,742.9058824,1559.976471,8212.564706,498.8941176,749.4941176,1727.082353,10919.22353,1160.352941,4171.329412,3659,4114.176471,1251.376471,273.3764706,2378.976471,8161.047059,3940.847059,196.9764706,653.8941176,9949.682353,797.0705882,137.4705882,3443.270588,7676.458824,1500.552941,500.0235294,2812.141176,6717.623529,2673.717647,250.6352941,1735.105882,4886.647059,931.0235294,385.2941176,1309.329412,3511.152941,618.2235294,159.9058824,4701.411765,3304.376471,1202.8,240.3647059,3258.541176,837.2470588,811.4,85,11.74400414,10.05868043,0.516155376,0.904255319,0.590277778,0.989284336
+3842,27218.06383,855.2765957,616.4840426,1053.117021,24696.65426,665.787234,1357.207447,1568.340426,12588.85106,709.8351064,1903.590426,1756.87766,16739.46277,1134,5063.718085,3939.728723,6266.31383,1201.696809,292.287234,2607.888298,12593.57447,401.5638298,2342.585106,1625.111702,15909.74468,2023.723404,576.4840426,1583.271277,12060.63298,1949.68617,429.9734043,2790.739362,10154.54787,647.5053191,254.8457447,1067.287234,6676.867021,1317.968085,385.8031915,1398.111702,4117.893617,1102.319149,151.712766,5672.973404,4101.297872,1167.12234,544.6010638,3228.026596,957.7712766,814.962766,188,22.52419742,11.24832087,0.866378276,0.899521531,0.657342657,0.210029842
+3843,24859.50588,884.2235294,538.8235294,1088.070588,22831.92941,697,608.9882353,1634.317647,12012.70588,548.4941176,997.6235294,1798.917647,15013.91765,1294.494118,5616.4,4373.2,5631.929412,1338.2,320.8941176,2598.858824,11931.54118,392.6705882,1333.223529,996.8117647,14630.27059,462.5176471,136.5529412,3626.717647,11119.42353,1889.2,434,2837.8,9817.352941,842.8,287.6470588,1463.552941,5783.882353,998.3058824,435.3764706,1374.035294,4439.752941,858.2941176,177.2117647,6138.247059,4071.270588,1341.905882,2909.152941,3296.282353,286.0823529,811.7176471,85,12.42780834,9.153634593,0.676389026,0.858585859,0.50295858,0.741654327
+3844,28587.83704,888.6814815,631.0518519,1078.985185,25800.34074,692.0296296,833.8148148,1561.281481,14190.43704,552.8296296,874.6518519,1761.881481,17889.34815,1266.644444,3856.496296,3066.125926,6461.111111,1533.792593,315.0814815,2572.266667,14087.96296,445.6444444,1511.392593,610.2592593,16896.39259,458.0444444,128.2074074,2411.2,13323.13333,1813.925926,758.037037,2816.518519,11655.97037,729.2,283.3333333,1404.2,7964.6,955.4222222,432.837037,1361.133333,6076.659259,1000.451852,175.4,6455.666667,5459.696296,1341.266667,256.5777778,3324.451852,433.9407407,813.2444444,135,17.21499553,11.78551482,0.728911922,0.870967742,0.567226891,-1.261648988
+3845,29168.75714,797.5857143,470.9857143,1071.571429,25466.34286,676.4571429,749.8285714,1606.314286,14221.11429,503.9714286,1544.671429,1783.042857,18001.37143,1172.214286,4810.428571,2746.785714,7007.514286,1233.371429,294.4714286,2466.114286,13908.5,470.7428571,144.4428571,1899.242857,17499.05714,880.7428571,1359.028571,2134.514286,13452.82857,1892.742857,443.1571429,2819.471429,11469.18571,628.8714286,268.8142857,1242.442857,7673.557143,1011.585714,398.7285714,1280.371429,4905.328571,610.9,153.0142857,2627.814286,4798.828571,1216.2,420.6,3171.257143,929.7142857,810.2285714,70,11.28687858,8.187536844,0.688324288,0.886075949,0.636363636,0.743584942
+3846,30311.56436,800.7425743,510.5643564,1077.485149,31135.15842,717.7326733,874.039604,1788.80198,15104.64356,524.5247525,2418.425743,1838.930693,21164.07921,1212.831683,5778.247525,3652.227723,7526.257426,1240.732673,292.7425743,2481.049505,15722.63366,1230.910891,699.5841584,2132.554455,19326.16832,459.1287129,178.1485149,1386.60396,15223.43564,2303.940594,399.3762376,2797.257426,12223.68317,756.7326733,268.8316832,1015.544554,7753.49505,1919.722772,413.2475248,1310.831683,4439.49505,709.6138614,156.1386139,4971.386139,4513.722772,1205.29703,923.6534653,3316.584158,1010.712871,812.6435644,101,13.98384086,9.761074957,0.71607308,0.918181818,0.554945055,-1.030060293
+3847,27072.47581,891.733871,491.6693548,1053.233871,24466.32258,733.3951613,693.4919355,1497.596774,13641.40323,562.7096774,1177.612903,1731.048387,16562.54839,1261.201613,2488.564516,2527.16129,6055.403226,1635.806452,315.4919355,2311.475806,13024.45968,400.5,448.4919355,763.6048387,15796.91935,437.9435484,241.733871,1622.66129,12284.95968,1877.75,490.8548387,2807.717742,10796.33065,662.2096774,289.2096774,1372.532258,7416.741935,1028.685484,435.75,1367.709677,5597.516129,740.8870968,166.1854839,2666.806452,5047.387097,1357.580645,976.7258065,3261.016129,409.7903226,813.75,124,14.43791816,11.33811107,0.6191142,0.939393939,0.688888889,0.396295214
+3848,23630.39744,885.7179487,616.1025641,1111.012821,20848.52564,703.474359,572.4487179,1649.807692,11398.55128,552.3333333,479.0769231,1728.858974,14848.32051,1301.974359,1481.602564,1860.282051,5416.717949,1326.679487,309.7564103,2329.974359,11222.30769,435.1666667,158.8076923,473.1153846,13653.97436,585,120.9230769,1457.74359,10478.02564,1378.666667,497.7307692,2787.115385,9126.551282,719.1025641,277.2179487,1659.987179,6662.871795,841.7820513,418.4871795,1313.948718,4852.730769,626.3846154,157.974359,1159.807692,4511.641026,1378.205128,354.5,3296.897436,780.8846154,813.0769231,78,14.87393072,7.117838223,0.878063284,0.876404494,0.5,0.525116575
+3849,24891.86742,947.7613636,937.1401515,1170.390152,22771.56439,725.5833333,822.9431818,1707.30303,12971.25,614.4886364,497.125,1782.734848,15987.25,1294.284091,2022.973485,2047.825758,5769.556818,1445.958333,319.2083333,2410.034091,12593.06439,1419.090909,860.8560606,1169.69697,15034.37879,472.9659091,126.9734848,1238.170455,11711.85985,1494.738636,504.0151515,2828.534091,10258.27273,732.7992424,290.4772727,1478.818182,7026.965909,1149.996212,435.6856061,1356.560606,5369.424242,802.5757576,166.6780303,1892.045455,4843.07197,1356.795455,175.9772727,3437.227273,468.5681818,819.2386364,264,19.51315531,18.53112915,0.313241098,0.91349481,0.571428571,1.000244391
+3850,15673.68045,845.6804511,435.1390977,1016.537594,14565.42481,646.0526316,440.2406015,1414.154135,8302.007519,566.1052632,375.0977444,1691.721805,10510.31579,1194.691729,1610.661654,1260.383459,3856.729323,1434.364662,385.2631579,2335.992481,8147.616541,386.9548872,199.4699248,483.481203,9937.808271,535.4661654,110.575188,1197.462406,7750.729323,1495.845865,548.8609023,2825.917293,6763.37594,595.8345865,250.9210526,2068.612782,5038.195489,742.3984962,379.2030075,1329.684211,3743.466165,666.7255639,151.924812,1984.725564,3505.402256,1426.421053,12959.52256,3246.586466,709.4360902,817.9962406,266,19.2882156,18.04809541,0.352781287,0.936619718,0.7,1.360089413
+3851,20036.65909,765.8939394,509.9469697,1026.045455,18008.63636,609.2575758,470.6742424,1399.037879,9952.818182,688.3030303,395.2878788,1675.969697,13330.02273,1180.219697,1805.75,1809.166667,4731.045455,1496.083333,371.1742424,2351.704545,9951.537879,410.5606061,245.2954545,491.530303,12427.93939,388.5757576,115.6666667,1347.939394,9628.272727,1336.689394,533.0227273,2772.992424,8289.840909,687.5833333,257.1136364,1515.469697,6276.863636,785.6287879,378.2575758,1307.386364,4608.007576,609.7575758,150.7954545,2372.666667,4334.522727,1280.772727,1531.931818,3096.409091,746.1893939,813.3333333,132,15.50911642,10.98320357,0.70603468,0.904109589,0.6875,1.42765629
+3852,31509.09653,889.8687259,551.8339768,1096.11583,27703.94981,670.5598456,718.4362934,1634.216216,15401.27413,512.8571429,1206.289575,1743.482625,19950.95753,1317.127413,3188.355212,3291.200772,7352.185328,1245.3861,302.5945946,2461.432432,15092.41699,6052.119691,435.1042471,1300.772201,18630.49807,1220.471042,122.6756757,2764.289575,14233.0695,1641.911197,517.3938224,2801.332046,12180.7027,882.6332046,271.0965251,1128.725869,8243.092664,1475.899614,406.8764479,1313.559846,5239.783784,707.8455598,158.1621622,3342.293436,5121.250965,1241.073359,331.0849421,3285.718147,909.6563707,817.5212355,259,19.74932041,17.08908839,0.501254211,0.921708185,0.649122807,0.187412598
+3853,23279.6,821.8285714,664.5571429,1092.085714,20486.51429,623.3285714,796.4285714,1607.328571,11456.32857,485.2714286,1025.628571,1784.242857,15425.8,1198.128571,3654.628571,2571.9,5697.014286,1199.557143,274.4285714,2364.214286,11403.9,517.7142857,166.8714286,1175.371429,14384.72857,459.1285714,128.5,2007.842857,10884.58571,1757.871429,469.0142857,2852.271429,9262.785714,1017.442857,255.5285714,1177.742857,6402.128571,792.0571429,394.9857143,1293.228571,4152.471429,600.3714286,154.3714286,1873.142857,4159.314286,1211.071429,708.7,3217.528571,920.6428571,811.7571429,70,10.66653036,8.804905138,0.564445401,0.945945946,0.636363636,0.833394988
+3854,27062.19383,929.0264317,570.4008811,1061.321586,24846.05286,663.0969163,943.3436123,1575.299559,12615.40088,601.0792952,1446.933921,1736.048458,17032.11894,1135.911894,4299.960352,3873.60793,6309.590308,1198.894273,283.7004405,2812.502203,12711.37885,441.1718062,1785.757709,1651.321586,15819.77974,837.154185,124.0132159,2568,12174.49339,2049.299559,495.5947137,2784.330396,10063.22026,603.1321586,249.9295154,1109.744493,6701.797357,1123.044053,381.4713656,1351.273128,4036.612335,938.9515419,152.7092511,5052.273128,4029.867841,1140.762115,292.1982379,3256.493392,972.7180617,816.30837,227,18.75954303,15.61090456,0.554538544,0.934156379,0.630555556,-1.127121915
+3855,18419.80986,835.9859155,469.6690141,1066.387324,14347.16197,645.4295775,481.943662,1509.570423,7460.366197,496.0070423,679.915493,1733.549296,9327.978873,1230.704225,1806.070423,1608.929577,3615.091549,1255.992958,302.3028169,2345.577465,7714.725352,355.9859155,222.1549296,987.5,9512.211268,394.5774648,187.6408451,1316.908451,7236.091549,1775.732394,322.2957746,2836.605634,6465.183099,735.7464789,272.7183099,1069.06338,3903.809859,781.7957746,431.6760563,1371.950704,2951.288732,618.6549296,171.5633803,4448.676056,2775.65493,1273.922535,1581.035211,3134.78169,275.3380282,817.471831,142,19.01504344,9.799175388,0.856986987,0.916129032,0.606837607,-0.455221865
+3856,31760.85128,872.7589744,517.8205128,1069.974359,27889.24103,691.1384615,767.9846154,1551.015385,15456.82051,549.2051282,1643.476923,1775.897436,18693.37949,1248.461538,5825.794872,3864.302564,6823.784615,1377.523077,315.6717949,2590.558974,14845.20513,394.8205128,990.174359,1038.697436,17637.09744,457.1333333,125.9846154,2370.179487,13694.00513,2009.661538,452.5641026,2834.030769,12099.07692,610.4512821,292.1282051,1174.297436,7565.333333,1353.507692,427.3846154,1342.041026,5887.210256,821.8102564,168.5538462,2662.287179,5378.241026,1322.030769,391.6923077,3301.164103,334.6358974,817.0307692,195,22.73068666,12.68757176,0.829727074,0.77689243,0.570175439,0.50568911
+3857,29561.6722,848.7302905,545.7178423,1065.846473,27148.82988,694.1078838,943.0414938,1585.809129,15350.51867,547.7676349,1796.078838,1816.630705,18432.47718,1248.871369,3622.095436,4006.983402,6753.157676,1392.360996,332.966805,2366.228216,14681.86722,397.4522822,502.4190871,1302.099585,17627.61411,1257.846473,124.9709544,1985.058091,13576.42739,1922.410788,427.8298755,2821.116183,12120.29046,599.746888,288.9045643,1370.589212,7888.215768,1823.896266,435.593361,1319.767635,6096.473029,714.0414938,170.7427386,4001.780083,5437.481328,1351.460581,336.4481328,3260.946058,354.2738589,820.5767635,241,21.46489795,15.6281078,0.685494895,0.895910781,0.576555024,-0.545916629
+3858,15581.69118,844.7573529,589.6838235,1056.080882,13917.44118,668.8970588,430.6397059,1395.573529,8220.588235,527.0441176,453.6102941,1729.463235,10030.94853,1275.095588,1568.301471,914.7205882,3742.080882,1286.823529,292.5,2352.838235,8516.698529,445.2647059,311.8602941,495.2279412,10052.97794,621.3014706,123.0147059,873.3382353,8003.727941,1401.852941,696.5,2837.411765,7132.404412,650.8970588,271.4117647,2204.507353,5195.522059,801.8529412,423.4264706,1354.919118,4006.301471,712.9338235,164.6029412,2362.5,3655.323529,1317.397059,639.9411765,3175.654412,532.8235294,816.7867647,136,17.43055251,10.35871622,0.80425451,0.912751678,0.62962963,0.13817334
+3859,26549.45528,747.699187,482.8373984,1034.707317,23590.0813,747.9837398,839.2113821,1540.333333,13614.17886,481.8130081,1575.861789,1848.02439,16635.10569,1150.186992,2670.113821,2339.682927,6286.723577,1284.02439,263.5284553,2423.113821,13296.06504,907.3170732,99.17886179,1542.390244,15633.74797,391.5934959,412.0569106,838.2357724,12327.66667,2009.154472,531.0894309,2780.260163,10875.36585,602.5365854,255.1219512,1207,7795.487805,1164.162602,383.6829268,1296.373984,5988.780488,577.2520325,149.2276423,3384.626016,5384.788618,1241.382114,347.8536585,3152.788618,610.0731707,815.7235772,123,14.95153232,10.62848078,0.703331201,0.946153846,0.630769231,-0.611175258
+3860,20182.625,819.71875,562.40625,1060.984375,17679.6875,674.828125,500.40625,1512.140625,10306.57813,825.90625,648.375,1710.421875,12701.35938,1262.75,1974.203125,1393.9375,4840.484375,1325.625,311.390625,2305.578125,10116.84375,406.59375,461.546875,504.03125,12837.9375,453.78125,119.9375,957.140625,9712.484375,1506.421875,475.609375,2789.28125,8587.671875,675.421875,275.625,1542.96875,6292.484375,810.25,397.21875,1322.1875,4558.4375,728.5,162.1875,1936.328125,4449.640625,1373.828125,305.421875,3264.75,772.984375,814,64,9.518361203,8.726218754,0.39939847,0.927536232,0.711111111,0.522489364
+3861,29130.98684,839.0921053,573.9868421,1067.631579,26293.89474,687.0657895,743.7894737,1638.605263,14343.06579,534.7236842,972.1315789,1785.552632,19648.39474,1196.921053,5868.565789,4452.578947,7297.671053,1275.131579,302.7236842,2299.236842,15079.63158,389.1052632,2145.407895,921.1052632,18801.14474,791.2105263,125.6184211,3562.171053,14368.23684,2048.039474,572.5394737,2788.671053,12204.10526,805.1315789,277.8684211,1865.552632,8712.868421,1224.828947,404.1578947,1341.947368,5745.539474,1232.078947,161.3552632,4684.513158,5643.947368,1285.657895,262.5131579,3274.407895,887.6842105,813.5657895,76,10.85234983,9.39952961,0.499821369,0.926829268,0.633333333,-0.140818107
+3862,31731.10417,877.0833333,574.234375,1090.203125,23010.06771,582.1875,632.6927083,1476.286458,12133.08333,479.515625,923.7552083,1729.8125,14758.79167,1094.765625,5574.276042,2856.84375,5700.291667,1293.026042,279.2916667,2432.927083,11950.72917,891.578125,225.0208333,662.5364583,14305.03125,845.0833333,117.2291667,3288.510417,11007.83854,1375.276042,393.3645833,2793.536458,9762.130208,556.6354167,260.5989583,1187.489583,6048.083333,989.0677083,396.7604167,1303.067708,4690.625,608.6302083,156.6875,2215.994792,4197.239583,1197.619792,277.4270833,3238.036458,318.7447917,817.7604167,192,17.01304134,14.79344182,0.493870607,0.905660377,0.666666667,-0.67200496
+3863,22535.50633,827.5949367,482.4810127,1039.734177,20895.17722,650.1265823,492.1772152,1479.987342,11295.92405,502.556962,623.1139241,1722.139241,14167.70886,1183.367089,5360.962025,2964.303797,5125.164557,1348.139241,313.4556962,2333.21519,10943.50633,418.4177215,1138.506329,542.8734177,13120.4557,437.9746835,122.0759494,3556.898734,10077.68354,1491.379747,446.278481,2810.278481,8864.78481,602.1898734,267.6582278,1257.987342,5622.974684,892.0253165,395.7974684,1331.025316,4414.582278,852.2025316,164.6582278,3844.696203,4019.379747,1256.911392,317.5822785,3190.670886,343.4303797,816.1518987,79,12.98514101,8.310593963,0.768368255,0.918604651,0.564285714,0.283107834
+3864,25443.55102,798.7857143,548.4795918,1072.765306,22683.97959,648.6734694,580.1836735,1538.540816,13523.96939,523.4285714,484.0714286,1717.561224,15968.07143,1204.806122,4983.836735,3304.765306,6084.571429,1344.153061,300.0204082,2413.5,13436.56122,394.0816327,698.0102041,444.5102041,15889.36735,405.3061224,119.1938776,3146.357143,12262.39796,1571.183673,760.2244898,2811.142857,11127.42857,600.1326531,283.0306122,1545.357143,7678.336735,889.8877551,417.9183673,1314.94898,5856.459184,754.6326531,168.9081633,2722.826531,5381.663265,1319.357143,189.6530612,3236.530612,503.9489796,815.255102,98,12.21363637,10.50312492,0.510377139,0.907407407,0.685314685,-0.984122823
+3865,14125.26115,697.2484076,409.8343949,1022.165605,12823.21656,588.1401274,512.5159236,1386.11465,7577.10828,472.3566879,578.8343949,1721.687898,9065.974522,1113.66879,1151.101911,964.6942675,3582.770701,1223.936306,273,2288.675159,7568.197452,375.5095541,98.68152866,653.2929936,9066.789809,485.8343949,106.8980892,837.0382166,7219.229299,1352.420382,535.0700637,2796.515924,6413.458599,598.6305732,238.9426752,1753.624204,4654.031847,797.7324841,364.4649682,1308.324841,3509.605096,626.2611465,144.910828,1704.152866,3275.292994,1239.764331,1231.815287,3102.898089,646.910828,817.7197452,157,15.7947244,12.9298487,0.574338105,0.928994083,0.615686275,-0.053257194
+3866,20324.9292,750.1769912,411.1504425,1030.026549,18393.24779,624.7787611,454.9911504,1422.274336,10831.82301,490.2831858,406.2035398,1707.80531,13504.68142,1204.902655,1259.150442,1164.106195,4902.80531,1464.19469,371.1769912,2332.212389,10385.32743,382.0707965,89.67256637,489.9557522,12602.45133,505.1946903,112.7964602,1176.20354,9926.876106,1289.238938,526.2035398,2788.707965,8713.061947,581.3274336,250.3185841,1779.787611,6437.39823,755.079646,389.6283186,1295.017699,4831.539823,625.0442478,154.079646,2028.389381,4571.504425,1345.80531,3352.495575,3162.584071,681.9734513,815.6814159,113,14.14818505,10.38544012,0.679098109,0.933884298,0.627777778,1.250090944
+3867,28082.79464,924.1517857,761.0625,1095.303571,24455.00893,689.7857143,419.9910714,1545.455357,13824.76786,532.0625,743.7946429,1753.946429,18011.94643,1213,3921.330357,2808.892857,6560.910714,1234.580357,299.2767857,2279.348214,13641.83036,398.1160714,934.5089286,828.9285714,16773.02679,969.2946429,121.1071429,3706.973214,13150.67857,1482.357143,499.7589286,2783.151786,11027.83036,599.7321429,263.4821429,1394.946429,7685.071429,1011.607143,396.8571429,1314.375,4996.616071,878.5267857,157.3035714,3356.526786,4887.535714,1219.178571,265.1785714,3342.875,895.9732143,817.3928571,112,14.66763748,10.0970774,0.725339302,0.910569106,0.622222222,-0.267269284
+3868,38394.61039,884.3181818,497.2467532,1118.714286,35076.88961,700.4155844,702.8571429,1608.967532,19800.5974,555.7402597,973.8701299,1760.584416,23612.97403,1296.019481,4035.155844,3196.24026,8881.779221,1467.616883,335.2597403,2386.058442,19071.53896,422.5194805,201.2922078,833.3961039,22929.12338,837.4220779,132.0454545,2128.493506,17914.25325,1550.168831,470.8831169,2820.311688,15649.86364,625.1558442,309.2272727,1269.538961,10615.14286,1268.272727,453.4350649,1316.798701,8069.818182,651.7012987,174.0714286,2540.383117,7235.045455,1406.909091,233.1818182,3313.844156,374.1818182,816.7207792,154,20.52813417,10.24320506,0.86661135,0.865168539,0.611111111,-1.370057462
+3869,16238.68208,883.5028902,532.3526012,1042.867052,15216.44509,612.3815029,477.4797688,1317.872832,8537.99422,493.1560694,750.7976879,1758.034682,10775.59538,1211.294798,4277.589595,1944.416185,3944.895954,1274.947977,286.3352601,2733.693642,8723.872832,425.3641618,599.9479769,840.9306358,10310.85549,1070.83815,119.0809249,1006.364162,8222.098266,1571.595376,829.1849711,2800.716763,7215.774566,614.0404624,243.4855491,1543.942197,5325.17341,896.8843931,401.734104,1360.595376,4099.248555,755.734104,163.4450867,3212.907514,3774.156069,1292.231214,425.0809249,3157.040462,545.283237,819.1560694,173,20.30114127,11.00576148,0.840297687,0.935135135,0.600694444,-0.907426797
+3870,17233.25424,696.1440678,405.0338983,1026.338983,15807.60169,574.2457627,475.8305085,1445.313559,9072.542373,452.9491525,424.8559322,1695.330508,11452.75424,1092.169492,999.4067797,815.1101695,4325.949153,1290.449153,301.3983051,2327.076271,9045.79661,359.0932203,105.8728814,504.220339,11032.80508,431.8559322,110.2966102,794.1610169,8637.686441,1250.940678,499.9237288,2828.533898,7646.288136,599.9576271,239.1694915,1511.838983,5715.940678,786.1440678,363.7118644,1298.449153,4273.737288,762.9576271,140.5,1367.872881,3988.042373,1228.779661,863.5423729,3115.720339,660.6186441,818.1779661,118,18.46519987,8.481246301,0.888276171,0.929133858,0.526785714,-0.791087551
+3871,19691.57143,907.7744361,575.2330827,1044.473684,17726.90977,649.9849624,455.0150376,1461.992481,9985.165414,929.6541353,466.6842105,1712.699248,12702.44361,1206.180451,2187.894737,1935.37594,4543.368421,1616.496241,414.8796992,2349.556391,9489.458647,404.1879699,514.7669173,506.8195489,11669.36842,401.3909774,112.924812,1653.06015,9006.030075,1532.496241,521.9548872,2792.330827,7758.496241,718.6240602,249.0526316,1347.954887,5780.93985,780.0902256,383.5338346,1353.669173,4220.067669,718.7518797,153.4962406,2395.300752,3900.037594,1267.503759,1012.330827,3193.969925,725.0526316,817.3759398,133,14.00950312,12.17601233,0.494592125,0.956834532,0.730769231,-0.489594154
+3872,26971.80263,867.1973684,845.7105263,1139.421053,23772.59211,686.1052632,771.6447368,1680.092105,13462.21053,537.9078947,492.0394737,1716.513158,17419.28947,1261.526316,1851.855263,2368.157895,6375.381579,1332.026316,309.6973684,2392.368421,13431.22368,450.9868421,126.8947368,486.2894737,16782.61842,469.4605263,121.5789474,1754.960526,12584.77632,1450.671053,588.8552632,2799.644737,10908.38158,767.8421053,276.3552632,1841.552632,8160.473684,984.7236842,421.3684211,1336.302632,5754.065789,603.9473684,163.7105263,1836.368421,5344.026316,1371.289474,175.0921053,3313.710526,799.8552632,817.0789474,76,12.51133153,8.327512823,0.746310775,0.863636364,0.531468531,-1.337544523
+3873,26010.55263,1093.763158,791.3947368,1078.644737,23941.31579,697.0131579,1176.5,1578.355263,11823.5,522.2894737,892.0526316,1697.381579,16648.71053,1202.921053,3268.815789,1581.960526,6175.855263,1212.407895,295.6052632,2409.447368,12376.67105,1365.25,384.1578947,786.1447368,15728.43421,450.9342105,236.8157895,1112.921053,11708.03947,1882.802632,404.4868421,2798.118421,9803.5,913.7368421,257.1315789,1034.039474,6613.697368,935.9868421,393.9210526,1319.276316,4163.197368,625.6842105,157.3684211,3229.065789,4176.092105,1207.802632,544.7763158,3246.828947,949.7631579,818.0789474,76,13.29489054,7.995803034,0.798933596,0.915662651,0.493506494,0.614335429
+3874,30790.32515,1007.018405,600.2883436,1096.06135,30375.79755,692.4110429,651.2944785,1635.834356,13255.47853,521.9509202,1190.834356,1751.570552,19390.31288,1230.226994,4104.920245,4982.030675,7181.441718,1260.159509,301.8527607,2288.435583,15163.44172,372.993865,341.2760736,789.9570552,18496.53988,448.4969325,428.0858896,5611.220859,13621.11043,2078.030675,411.2147239,2809.95092,11825.38037,607.0490798,283.1165644,1470.773006,5679.631902,970.3312883,412.392638,1297.417178,3977.380368,645.993865,165.6871166,3361.006135,3961.533742,1260.736196,512.6380368,3191.797546,205.8527607,820.0429448,163,15.33653499,14.14029909,0.387187728,0.900552486,0.63671875,0.433913676
+3875,22847.23846,879.6923077,518.8846154,1035.661538,21769.54615,656.7538462,675.7538462,1425.992308,11307.79231,541.9153846,1139.492308,1830.838462,14158.89231,1191.538462,4350.084615,3515.938462,5263.938462,1346.330769,297.8846154,2643.761538,11016.97692,363.3230769,144.2538462,1158.461538,12794.99231,493.7538462,122.8,2651.276923,9986.884615,1744.315385,481.2538462,2794.276923,8696.9,642.5076923,260.7923077,1476.615385,5933.623077,1149.230769,401.6230769,1311.892308,4608.730769,592.7846154,153.3230769,2961.7,4044.9,1244.907692,653.0153846,3261.976923,390.1,819.3307692,130,16.95793137,10.98227384,0.761964561,0.833333333,0.526315789,-1.546239051
+3876,34439.76923,891.2923077,607.5692308,1102.092308,31194.53846,710.8769231,746.6615385,1613.476923,17905.96923,571.9230769,713.8307692,1774.076923,21448.58462,1315.984615,3367.430769,3464.338462,7808.692308,1412.323077,323.8461538,2343.353846,17586.86154,452,520.5846154,665.0923077,21436.64615,454.5076923,130.4461538,2094.6,16390.18462,1606.369231,671,2807.169231,14521.15385,618.1846154,304.1538462,1550.784615,9934.676923,1203.4,452.6923077,1334.584615,7710.261538,885.7230769,174.6769231,1663.784615,6989.8,1402.046154,157.9076923,3315.615385,512.5384615,818,65,12.10244015,6.965820721,0.817751396,0.928571429,0.590909091,-0.611194342
+3877,22882.77011,889.6781609,675.8965517,1116.957854,20907.4751,709.9578544,632.0114943,1562.340996,12030.18391,555.4137931,465.2375479,1754.463602,14680.00766,1342.363985,1383.402299,1303.701149,5263.551724,1387.421456,326.137931,2331.268199,11654.37548,455.4252874,246.6475096,509.6590038,13965.81992,508.1417625,130.1494253,1078.042146,10876.00383,1469.482759,566.2681992,2820.149425,9488.068966,653.2145594,294,1805.478927,6621.091954,901.4252874,440.8888889,1328.720307,5163.065134,726.0957854,170.0957854,1567.931034,4593.375479,1425.398467,817.3793103,3212.214559,522.6091954,824.5402299,261,23.19572551,14.93415553,0.765166693,0.9,0.572368421,0.120274256
+3878,20470.47458,828.9915254,481.6440678,1029.923729,18232.59322,633.6101695,659.3898305,1458.525424,10118.67797,498.7542373,1313.516949,1801.805085,13310.78814,1167.466102,3844.20339,2572.440678,5049.516949,1199.220339,285.5508475,2382.423729,10349.90678,678.6186441,201.2033898,1112.830508,13074.99153,533.0423729,116.7881356,1245.101695,9944.211864,1962.991525,494.0338983,2808.644068,8475.932203,583.7881356,258.7711864,1307.932203,6178.474576,1002.262712,385.4152542,1289.59322,4229.70339,609.2118644,151.6271186,2615.779661,4116.847458,1216.542373,1161.754237,3266.70339,860.4491525,818.2288136,118,14.53076662,10.76614913,0.671592268,0.900763359,0.648351648,-1.129756258
+3879,28044.84483,872.8362069,587.3793103,1090.043103,24101.49138,689.9655172,781.1206897,1691.637931,11732.08621,519.9655172,995.5689655,1802.439655,16055.12069,1243.137931,4405.922414,3413.905172,5937.284483,1231.086207,292.2413793,2352.336207,11894.63793,1117.758621,487.7327586,1066.853448,14903.05172,446.6810345,136.3362069,2498,11500.84483,2065.534483,522.75,2789.534483,9333.284483,667.5344828,260.2844828,1366.172414,6023.974138,1019.525862,389.8017241,1303.405172,3490.801724,676.887931,160.8448276,6562.301724,3547.948276,1175.663793,326.0431034,3200.939655,991.7068966,819.0775862,116,15.0341147,10.51539313,0.714695753,0.878787879,0.591836735,0.538810087
+3880,26705.29694,815.8034934,561.7991266,1067.820961,14513.67249,505.8733624,342.6724891,1321.825328,7219.938865,414.2751092,578.5720524,1720.366812,9410.838428,987.580786,4088.759825,1872.80786,3525.135371,1113.641921,238.6026201,2405.344978,7209.144105,281.6419214,439.7772926,733.209607,8844.139738,327.5240175,106.628821,2363.244541,6788.358079,1456.576419,317.5938865,2807.371179,5923.71179,582.0567686,226.3056769,1002.864629,3364.550218,736.7947598,361.2663755,1317.462882,2465.973799,629.6244541,144.8340611,3316.947598,2322.969432,1053.10917,145.7860262,3132.768559,260.0349345,823.069869,229,22.64879758,13.13882254,0.814537245,0.934693878,0.605820106,0.790206018
+3881,27597.54701,910.7735043,591.6923077,1090.089744,24568.2265,683.9230769,992.2393162,1556.846154,14160.24786,551.1282051,1591.354701,1817.649573,17278.25214,1284.41453,4855.764957,2650.692308,6222.376068,1394.58547,302.2820513,3086.042735,13595.88034,1112.448718,293.8376068,1512.081197,16292.17521,434.4102564,157.7179487,1297.512821,12602.26496,2153.290598,642.5128205,2803.884615,10970.92308,778.1196581,278.1581197,1235.820513,7837.717949,1296.931624,420.6282051,1333.811966,5872.534188,641.6111111,167.2435897,3620.042735,5355.91453,1316.713675,432.025641,3302.888889,558.3504274,823.6068376,234,23.00999947,13.3070007,0.815814394,0.906976744,0.585,-0.846227466
+3882,30824.07692,889.9095023,522.1221719,1072.846154,26546.65158,684.678733,718.841629,1530.438914,14878.61538,529.6063348,994.7692308,1731.651584,19405.84615,1245.221719,1928.873303,3336.828054,7052.728507,1269.253394,302.2036199,2324.574661,14615.00452,499.8687783,145.5746606,1385.266968,17839.64253,1054.542986,124.520362,1899.090498,13762.85973,1601.493213,516.9683258,2796.063348,11925.90498,799.520362,271.7420814,1602.80543,8561.977376,1090.022624,406.158371,1301.027149,5784.660633,619.1131222,159.1900452,3268.678733,5549.538462,1295.552036,596.2352941,3271.529412,842.6515837,823.5927602,221,18.99795297,15.78654502,0.556331692,0.880478088,0.584656085,0.466314537
+3883,28133.53261,861.1467391,496.1195652,1082.445652,26734.19022,708.701087,561.9673913,1640.326087,12782.26087,548.7228261,617.2663043,1760.701087,17609.80978,1299.625,4894.222826,2638.119565,6588.288043,1724.804348,323.9456522,2326.320652,14229.41848,397.4782609,1225.826087,569.4130435,17305.56522,627.701087,130.5434783,3038.271739,13062.875,1577.331522,369.1521739,2848.228261,11501.13043,759.2173913,299.4945652,1320.190217,6011.728261,856.9782609,437.423913,1357.728261,4263.559783,872.3206522,170.9836957,4548.918478,4149.690217,1340.423913,301.4728261,3228.380435,224.5108696,825.25,184,22.51193192,10.90044616,0.8749532,0.880382775,0.597402597,-0.430651663
+3884,26439.3625,913.625,599.73125,1099.5625,23589.5,644.025,641.66875,1578.7375,12970.7,486.0375,655.39375,1726.3875,16348.05625,1145.25625,4558.025,3271.15625,6391.2625,1232.725,301.39375,2335.8,12868.33125,402.6,585.2375,845.91875,16389.11875,446.8625,132.6625,3104.88125,12504.4875,1668.64375,552.6375,2800.9125,10677.85,837.6375,267.2375,1345.28125,7123.875,893.30625,400.225,1314.24375,4514.73125,746.475,157.3,2577.29375,4488.0125,1215.0375,518.025,3227.5875,924.61875,823.5625,160,18.55235111,11.2125886,0.796699515,0.930232558,0.647773279,-0.355401363
+3885,21343.75556,804.3777778,569,1081.2,20146.59259,653.162963,730.9111111,1762.8,9725.074074,484.2888889,914.8814815,1785.985185,13094.87407,1311.22963,4470.251852,2270.585185,5401.6,1259.674074,292.2444444,2449.162963,10018.07407,9128.340741,259.9333333,870.962963,13073.32593,535.6814815,151.4,2432.333333,9632.696296,1931.733333,459.2888889,2803.481481,7934.044444,770.562963,264.9259259,1109.711111,5190.6,1168.02963,388.5407407,1295.874074,2922.222222,635.8814815,154.1925926,4583.185185,2977.622222,1191.414815,565.9851852,3246.748148,1003.096296,822.237037,135,15.53539263,11.40648618,0.678905343,0.918367347,0.703125,0.425558499
+3886,32554.55769,818.9567308,527.2211538,1097.129808,27399.97115,656.8846154,984.5528846,1658.466346,12694.17788,639.6057692,1849.581731,1770.288462,18261.47115,1128.836538,5614.961538,2738.206731,6588.283654,1230.5,275.7788462,2834.197115,14066.63462,4091.855769,1133.014423,1748.822115,17172.54808,467.2884615,1452.961538,1916.081731,13379.74038,2518.336538,386.6153846,2819.298077,10853.11538,634.9855769,258.4855769,968.5096154,6664.331731,1182.197115,388.3461538,1353.475962,3722.014423,822.3653846,150.9471154,5054.995192,3862.461538,1119.009615,442.4903846,3215.927885,1018.600962,823.4951923,208,18.48958713,15.31623619,0.560179997,0.881355932,0.577777778,0.687939636
+3887,28617.25581,1055.488372,651.3372093,1088.802326,17814.24419,615.2790698,564.0232558,1347.523256,8003.453488,528.2906977,1068.534884,1724.697674,10388.5,1118.383721,4933.604651,2901.55814,4088.825581,1172.627907,259.4534884,2460.930233,8553.627907,375.5465116,257.744186,970.6046512,10362.18605,676.2674419,206.5697674,4285.465116,7915.965116,1659.313953,342.127907,2801.383721,6931.825581,522.755814,229.5116279,1029.372093,3821.244186,1053.988372,357.2209302,1286.151163,2863.406977,582.9883721,144.9302326,2134.627907,2599.790698,1052.360465,206.4534884,3304.674419,243.372093,819.4302326,86,13.24746863,8.775086386,0.749152804,0.977272727,0.614285714,1.206526659
+3888,19675.76289,802.1958763,524.3814433,1062.597938,18188.40206,630.9072165,516.3608247,1542.618557,9348.536082,509.7319588,783.0309278,1786.381443,11475.34021,1176.350515,3478.216495,2724.072165,4453.206186,1319.56701,399.0309278,2426.185567,9414.845361,356.8659794,363.6804124,723.185567,11215.46392,583.0103093,121.1546392,2220.185567,8659.041237,1693.391753,394.5876289,2829.876289,7813.773196,634.3402062,266.9278351,1096.268041,4912.597938,1196.649485,408.8969072,1327.814433,3790.43299,649.6701031,154.9278351,2327.917526,3402.938144,1240.896907,247.8453608,3263.505155,307.9175258,824,97,14.55660842,8.679661594,0.802784333,0.96039604,0.673611111,-0.102172982
+3889,35199.36054,941.0204082,501.0612245,1071.054422,30464.13605,707.4081633,847.7414966,1573.544218,17318.42857,562.3061224,996.4965986,1719.863946,21995.56463,1251.639456,3302.163265,3677.197279,8281.040816,1279.442177,300.3265306,2393.081633,16980.68027,391.9387755,493.4353741,997.0884354,21495.5102,1142.496599,124.122449,2600.442177,16438.44218,1578.863946,535.4217687,2804.659864,13948.77551,616.6190476,280.2517007,1425.421769,9809.666667,1280.047619,409.9591837,1322.653061,6383.07483,724.2993197,160.8843537,3417.503401,6262.598639,1258.55102,190.4285714,3368.408163,879.6802721,822.0136054,147,17.21409972,11.15607293,0.761574282,0.936305732,0.680555556,-1.402093967
+3890,41734.04688,960.09375,552.328125,1109.125,33597.8125,687.359375,713.09375,1582.953125,16875.01563,558.171875,1314.828125,1744.671875,22656.46875,1267,4897.0625,2817.0625,8606.03125,1344.8125,314.484375,2439.46875,17618.28125,391.640625,384.6875,987.359375,21806.48438,774.90625,139.921875,3019.140625,17146.95313,1832.6875,352.625,2817.25,14898.01563,600.9375,296.953125,1053.1875,7732.875,1180.140625,429.390625,1303.375,5475.546875,679,158.1875,2235.40625,5363.921875,1288.453125,195.1875,3277.8125,235.953125,822.78125,64,11.41722678,8.282279367,0.688306977,0.888888889,0.52892562,0.854275874
+3891,25980.77301,845.993865,531.8895706,1096.202454,23577.15951,750.3865031,830.006135,1644.944785,12015.08589,547.9693252,1886.067485,1908.478528,15813.30061,1271.680982,4411.300613,5806.582822,5630.453988,1314.441718,310.4478528,2545.613497,12305.11656,395.5030675,487.1411043,2622.276074,14949.5092,464.4417178,721.4355828,2992.503067,11483.25153,2336.539877,434.7852761,2816.981595,10016.46626,609.2453988,292.4110429,1505.392638,5916.638037,1259.331288,426.196319,1315.687117,4531.503067,683.3128834,170.006135,4618.245399,4094.06135,1320.521472,1355.539877,3274.116564,280.398773,825.7546012,163,21.85838567,10.2665727,0.882833664,0.867021277,0.479411765,-0.847887367
+3892,35262.86486,863.1891892,432.5,1048.675676,29997.36486,687.5540541,749.7837838,1486.554054,17492.97297,543.3378378,1192.878378,1726.567568,20892.87838,1263.837838,2182.243243,1905.202703,7697.081081,1485.148649,310.8513514,2370.675676,16574.21622,394.0540541,143.4864865,775.1891892,20550,520.5135135,135.2837838,1177.72973,15862.90541,1543.486486,464.0810811,2827.297297,13873.5,770.5675676,300.7027027,1221.121622,9539.418919,1244.918919,437.7567568,1304.878378,7042.635135,613.8513514,169.6351351,1689.135135,6662.337838,1346.324324,847.3648649,3285.581081,404.1756757,821.9054054,74,11.35568908,8.732078906,0.639296022,0.891566265,0.616666667,1.298066964
+3893,28556.29508,868.3442623,497.4262295,1102.131148,24057.21311,678.5737705,629.5409836,1580.016393,14222.42623,544.3934426,495.557377,1733.213115,16846.22951,1191.163934,2363.491803,2501.262295,6321.262295,1391.196721,293.9672131,2346.836066,13493.70492,2262.098361,236.2786885,462.7868852,16233.5082,422.6721311,123.5245902,3146.377049,12878.01639,1486.04918,566.0491803,2808,11311.47541,586.1967213,281.5901639,1341.836066,7764.180328,810.295082,418.6229508,1300.704918,5772.885246,636.4590164,164.852459,2504.409836,5283.983607,1310.672131,169.6065574,3373.213115,422.2786885,821.5901639,61,10.65649504,7.49321903,0.711031843,0.910447761,0.61,-0.927819484
+3894,36450.98795,870.4096386,580.626506,1076.481928,32087.79518,704.313253,729.5903614,1608.084337,17986.04819,537.373494,625.2168675,1745.108434,22555.22892,1258.192771,2858.39759,2412.963855,8038.638554,1518.216867,322.2409639,2384.662651,17529.75904,465.746988,1237.349398,551.7951807,21086.07229,500.7831325,128.8795181,1603.807229,16795.56627,1718.024096,688.1084337,2800.795181,14543.75904,692.7108434,302.686747,1277.759036,9902.156627,885.5180723,437.7590361,1368.86747,7478.819277,912.3855422,175.9879518,4866.987952,6691.662651,1362.927711,186.0120482,3315.108434,432,823.5662651,83,13.55824572,8.701619042,0.766875955,0.882978723,0.538961039,0.434112003
+3895,19391.63014,824.8150685,547.9931507,1058.767123,17578.44521,668.9726027,580.9863014,1464.59589,9687.821918,510.7328767,573.3356164,1745.958904,11974.39726,1188.09589,2014.294521,1939.109589,4358.972603,2316.356164,293.1849315,2347.39726,9342.479452,377.5273973,1882.349315,525.8835616,11228.4726,429.2123288,130.4863014,1428.123288,8691.136986,1613.554795,522.4794521,2868.30137,7703.890411,724.3972603,265.4383562,1342.541096,5324.321918,803.0205479,410.869863,1350.136986,3993.410959,1101.19863,173.8356164,5219.40411,3670.178082,1284.993151,381.5958904,3238.136986,443.260274,823.369863,146,14.80851922,12.71433355,0.512675639,0.948051948,0.695238095,-0.743598272
+3896,17274.52174,799.6770186,498.6521739,1068.149068,15610.82609,637.9254658,649.0621118,1463.273292,8869.465839,649.7142857,641.5962733,1772.906832,10769.26708,1150.677019,3448.031056,2039.391304,4018.571429,1344.223602,306.9254658,2381.552795,8706.428571,363.0310559,2406.298137,706.6521739,10292.98137,484.5714286,132.2360248,923.1304348,7977.695652,1703.267081,549.0745342,2785.931677,6984.006211,683.1863354,261.0496894,1372.354037,4807.546584,884.5217391,401.068323,1416.751553,3724.248447,1207.993789,157.1242236,3610.689441,3448.565217,1253.217391,198.757764,3261.832298,488.0621118,822.9378882,161,16.43507941,12.73039078,0.632467976,0.958333333,0.71875,-1.268086501
+3897,24922.76744,874.0775194,948.2248062,1127.922481,22008.46512,727.620155,737.4263566,1682,12220.87597,800.1550388,684.6899225,1774.744186,15801.65116,1278.03876,2718.736434,1988.147287,5619.751938,1435.410853,348.9767442,2438.984496,11678.25581,462.5968992,565.1550388,590.0852713,14707.07752,597.9069767,120.2403101,1267.007752,11242.77519,1665.178295,522.751938,2794.503876,9768.705426,670.8139535,285.4031008,1389.806202,7208.100775,909.0542636,408.627907,1380.953488,5215.984496,731.3410853,158.8372093,3005.379845,4863.015504,1347.813953,240.2325581,3188.550388,753.9147287,823.5891473,129,13.9371813,11.86584612,0.524548408,0.948529412,0.767857143,-0.221919569
+3898,23110.97744,988.8195489,811.0902256,1095.691729,20026.54135,744.556391,862.6466165,1641.330827,11580.50376,806.7518797,4797.729323,1789.150376,14354.75188,1295.24812,2320.842105,1891.774436,5277.541353,1325.225564,316.2631579,2356.661654,10953.55639,446.4135338,508.2105263,912.1879699,13555.09023,482.2857143,120.2857143,852.2406015,10693.06015,1988.631579,480.2781955,2817.969925,9260,785.6616541,276.8496241,1475.353383,6748.834586,1018.428571,412.1203008,1392.894737,4817.781955,721.481203,159.1654135,2391.022556,4554.699248,1343.368421,233.2932331,3329.067669,766.6390977,824.7744361,133,15.81287236,10.93188562,0.722540815,0.943262411,0.639423077,0.497661957
+3899,27360.88889,874.6904762,777.5952381,1111.02381,25043.38889,704.5079365,860.4365079,1658.095238,13746.63492,534.4285714,1173.349206,1782.365079,17689,1263.539683,3174.031746,4646.97619,6642.261905,1293.246032,301.2460317,2569.968254,13425.22222,422.8571429,111.452381,736.8412698,16814.40476,1457.436508,123.7142857,2541.515873,12589.80159,1584.198413,580.8650794,2784.365079,10805.45238,646.3571429,279.9365079,1876.992063,7999.714286,1341.960317,421.0793651,1311.539683,5655.769841,595.3492063,166.0793651,4196.031746,5165.666667,1350.420635,586.5793651,3236.896825,812.7857143,825.1507937,126,16.58505663,10.03624791,0.796120599,0.875,0.636363636,0.327418163
+3900,26667.70909,917.6272727,713.2090909,1128.445455,23460.48182,697.1545455,822.6363636,1632.963636,13068.89091,536.7272727,620.9181818,1733.381818,17302.5,1270.218182,1733.1,1818.963636,6219.227273,1281.027273,302.4636364,2326.718182,12524.22727,418.3454545,118.5454545,582.2545455,15137.24545,752.6818182,124.6181818,1168.181818,11761,1392.745455,466.6818182,2820.409091,10069.38182,1009.363636,270.2727273,1431.281818,7304.354545,1063.209091,410.8,1296.5,5126.727273,593.6,159.6909091,2036.372727,4868.727273,1287.163636,895.5,3211.472727,825.2818182,822.5454545,110,13.77088908,10.27462424,0.665820569,0.916666667,0.654761905,-1.138400214
+3901,29639.68182,902.4545455,559.3333333,1089.424242,27345.5303,706.9848485,703.2272727,1717.424242,13732.16667,519.6666667,1025,1793.060606,17655.06061,1235.287879,4795.439394,3612.439394,6718.257576,1232.484848,289.7272727,2511.318182,13474.37879,1337.545455,579.7575758,1199.30303,16874.0303,773.7575758,150.9848485,2156.030303,12934.12121,1833.015152,486.3939394,2803.136364,10730.54545,785.8181818,256.0454545,1165.636364,6779.651515,1038,384.1666667,1297.363636,3963.878788,692.6969697,155.2121212,5237.227273,4002.833333,1166.818182,332.9848485,3157.69697,982.6515152,822.6515152,66,11.18964922,8.319173435,0.668768797,0.891891892,0.545454545,-1.038495088
+3902,21423.70667,833.8666667,575.1866667,1027.24,13295.76,591.56,699.72,1471.053333,6189.533333,450.1466667,1390.586667,1716.973333,8891.866667,1049.733333,5031.013333,2076.173333,3504.36,1247.626667,260.6933333,2412.72,6938.626667,356.28,508.8666667,1056.813333,8674.693333,436.5866667,261.8933333,1175.106667,6536.573333,2305.213333,408.6,2774.866667,5418.88,1015.586667,231.6533333,826.88,3299.813333,1315.626667,359,1307.226667,1769.186667,630.7466667,141.48,2139.746667,2000.013333,1056.24,1261.693333,3277.186667,1044.706667,820.6133333,75,11.1817518,8.606947064,0.638367725,0.949367089,0.757575758,1.467511118
+3903,17195.72917,752.5763889,436.6527778,1044.993056,15764.04167,614.3680556,543.2638889,1452.944444,9006.215278,479.5208333,531.375,1733.909722,11239.38194,1157.423611,1956.548611,1432.583333,4234.041667,1329.25,329.2777778,2342.625,8752.048611,376.0277778,99.38194444,540.5277778,10594.95139,536.2847222,128.4652778,1407.048611,8260.736111,1303.25,534.9583333,2793.736111,7303.944444,615.6944444,244.9930556,2101.131944,5381.027778,831.1666667,382.5208333,1329.166667,4007.75,701.1111111,148.9583333,2635.5,3697.861111,1281.763889,2936.423611,3130,675.4097222,824.75,144,15.0195967,12.95947455,0.50548103,0.9,0.6,0.750504572
+3904,25712.6,942.6888889,644.5777778,1146.3,22437.86667,757.1,719.1666667,1685.1,12416.88889,619.5777778,1247.5,1752.955556,16514.1,1360.944444,781.6111111,1064.955556,5751.544444,1418.522222,318.6,2350.533333,11974.86667,453.1333333,203.1111111,499.4111111,14708.02222,474.8555556,127.2333333,834.5444444,11442.06667,1476.244444,488.2555556,2784.022222,9921.033333,825.3777778,283.9666667,1722.355556,7192.755556,821.4333333,434.1,1352.244444,5140.155556,649.8444444,169.9,1239.955556,4759.644444,1431.855556,171.9888889,3306.677778,776.6666667,823.2666667,90,12.22124624,10.27148298,0.541871767,0.873786408,0.625,0.479703088
+3905,36107.46512,818.0697674,469.744186,1061.116279,32676.69767,1014.372093,1178.139535,1697,18923.93023,540.3023256,2101.72093,2024.651163,22933.16279,1268.395349,3068.209302,3339.395349,8227.325581,1310.44186,285.5581395,2375.302326,18156.18605,480.5813953,109.3488372,2721.953488,22571.27907,440.9302326,1511.697674,992.3023256,17291.2093,2146.325581,532.5581395,2796.395349,14959.04651,612.7674419,276.6511628,1206.069767,10698.5814,1384.813953,405.8604651,1295.046512,8011.534884,595.2790698,155.2093023,3346.255814,7351.837209,1321.55814,720.3953488,3173.604651,613.4186047,823.5116279,43,9.912005819,6.012952849,0.794981782,0.934782609,0.5375,-0.548027341
+3906,26076.31544,924.2281879,497.9328859,1051.637584,22554.79195,736.4362416,618.557047,1518.389262,12518.00671,661.0536913,917.1275168,1779.013423,16162.14765,1321.926174,3196.100671,2552.52349,5673.926174,1332.134228,298.2147651,2352.926174,11912.10067,413.5436242,296.852349,1120.711409,14572.65772,444.738255,371.6241611,1550.026846,11003.01342,1718.241611,561.9127517,2790.778523,9606.986577,628.8120805,250.5234899,1298.422819,6924.47651,1012.610738,382.4228188,1297.671141,5290.651007,643.0268456,158.1677852,2685.66443,4644.375839,1342.234899,2887.530201,3137.583893,623.6442953,826.3422819,149,17.73523896,12.07826657,0.732253586,0.792553191,0.551851852,1.238646687
+3907,32302.06494,864.7142857,465.3246753,1073.87013,28590.81818,696,833.8441558,1563.948052,17008.96104,573.2987013,1695.194805,1783.987013,20123.24675,1267.792208,2649.298701,3080.87013,7017.766234,1494.181818,396.4805195,2470.792208,15644.16883,499.5714286,167.6103896,1240.38961,19263.01299,453.5454545,120.4545455,1363.116883,15005.23377,1840.935065,568.2337662,2789.532468,13030.4026,701.7922078,289.9480519,1401.298701,9352.818182,1470.675325,411.7792208,1291.207792,6673.727273,642.6103896,163.9480519,1833.909091,5956.987013,1361.038961,900.961039,3207.038961,732.4545455,824.7792208,77,11.78573102,8.40364524,0.701127877,0.974683544,0.712962963,-0.397421986
+3908,23344.58,757.56,462.52,1043.04,21512.2,612.99,539.67,1503.6,11845.15,495.94,471.17,1755.88,15312.65,1157.52,1756.67,1604.07,5514.31,1417.18,345.91,2337.3,11380.24,2948.15,333.53,534.37,14324.39,506.14,116.44,927.89,10898.76,1461.42,773.86,2770.39,9328.13,698.35,251.89,1226.77,7022.92,879.79,383.03,1301.63,5127.68,680.02,148.9,2047.73,4700.92,1247.76,365.91,3140.04,742.26,824.42,100,12.90652812,9.93164296,0.638640317,0.970873786,0.833333333,0.314986826
+3909,31157.73043,899.573913,593.3043478,1080.634783,27761.18261,711.0695652,623.0956522,1599.973913,16224.38261,556.9826087,680.8695652,1780.817391,19608.03478,1257.6,2906.93913,3023.869565,6978.721739,1287.695652,288.0608696,2325.13913,15027.26957,433.3478261,287.173913,600.1652174,18452.92174,463.2086957,123.2521739,2938.052174,14190.75652,1539.991304,791.4,2800.13913,12367.33913,827.6434783,273.3217391,1591.46087,8760.443478,978.3913043,407.8086957,1308.678261,6425.678261,650.2347826,154.6521739,2371.4,6060.504348,1313.582609,593.1478261,3328.617391,596.0695652,824.9652174,115,13.56040791,10.93623152,0.591257977,0.942622951,0.638888889,1.454437372
+3910,19261,805.8762887,478.6804124,1055.103093,17559.07216,652.8556701,578.4123711,1553.958763,10168.70103,493.9690722,404.9896907,1776.979381,13040.54639,1218.680412,1513.979381,1225.43299,4699.072165,1290.154639,310,2298.628866,10065,433.9278351,138.4845361,479.8969072,12278.15464,538.4123711,116.8969072,934.4020619,9486.402062,1310.989691,520.3917526,2802.783505,8377.412371,711.2886598,260.6804124,2037.020619,6159.597938,999.443299,388.2268041,1300.340206,4687,1846.278351,157.3195876,1803.907216,4335.134021,1338.71134,390.9484536,3163.752577,664.2371134,826.5154639,97,12.84622247,11.07281628,0.506991331,0.91509434,0.621794872,-1.363239063
+3911,30606.45263,1049.357895,526.3368421,1057,27338.64211,732.4842105,657.9263158,1532.831579,14950.35789,608.3894737,1041.326316,1737.494737,18324.22105,1288.926316,3289.515789,2309.663158,6321.694737,1337.821053,310.5263158,2345.442105,13954.26316,710.8631579,436.6526316,694.3789474,16428.53684,897.7368421,127.6421053,1540.789474,12946.42105,1518.684211,376.3263158,2819.021053,11258.45263,635.5052632,283.4631579,1114.536842,6979.221053,932.9894737,412.4210526,1331.294737,5254.821053,671.4842105,159.1473684,2145.463158,4700.410526,1261.305263,1157.357895,3380.557895,327.3473684,825.8,95,13.59404157,9.190374074,0.736847499,0.922330097,0.678571429,-1.323482184
+3912,24810.00694,825.0347222,751.0138889,1123.152778,22494.28472,677.5902778,848.4305556,1646.8125,13332.23611,563.4305556,625.4583333,1789.305556,16176.22917,1247.576389,2658.597222,1470.548611,5727.770833,1348.125,293.3611111,2434.055556,12478.95833,1092.104167,663.0902778,577.3055556,15026.41667,443.4027778,124.25,892.7430556,11847.41667,1687.118056,606.8125,2823.993056,10263.4375,678.2222222,286.8680556,1294.368056,7372.4375,895.4236111,417.1597222,1352.625,5498.513889,725.1875,160.3055556,2004.493056,5027.576389,1318.861111,177.6388889,3314.326389,573.5138889,826.8611111,144,14.38888121,12.77947713,0.459554709,0.96,0.738461538,-1.240525474
+3913,22132.90678,876.8559322,623.1016949,1088.29661,18908.38136,702.3813559,679.9915254,1622.584746,10982.47458,627.7711864,471.4661017,1715.127119,14003.41525,1267.932203,1076.466102,1677.127119,5091.686441,1373.220339,307.9067797,2335.533898,10625.29661,446.5423729,186.9661017,506,13167.90678,530.4576271,123.8050847,1210.194915,10147.90678,1409.90678,493.8813559,2798.483051,8850.262712,1291.262712,279.6101695,1695.084746,6455.661017,826.6694915,412.7711864,1320.813559,4598.813559,632.7966102,162.1779661,1554.279661,4356.305085,1366.491525,343.0084746,3254.050847,787.4745763,826.9237288,118,12.5739294,11.99843208,0.299070847,0.967213115,0.756410256,1.063767582
+3914,21968.35088,849.7280702,742.4649123,1141.482456,18901.26316,685.1140351,796.7280702,1670.192982,10939.25439,522.6140351,749.8421053,1768.631579,13968.90351,1237.105263,1317.72807,2334.815789,5133.22807,1295.017544,297.1315789,2454.508772,10552.16667,412.2807018,133.5877193,761.7982456,13020.53509,653.7192982,122.9385965,1266.570175,10033.54386,1505.403509,516.2807018,2823.77193,8728.017544,1168.22807,275.245614,1564.289474,6339.236842,1103.815789,410.4298246,1312.192982,4565.587719,606.6403509,156.7982456,2126.72807,4320.403509,1324.122807,437.0701754,3217.342105,802.0789474,826.8947368,114,13.22627555,11.16774155,0.535775829,0.94214876,0.730769231,-0.101460103
+3915,35837.4697,903.6060606,789.4090909,1127.333333,32230.5,730.5454545,789.2727273,1779.772727,16585.60606,543.1969697,501.2424242,1765.757576,23026.75758,1283.045455,2877.545455,1909.348485,8341.590909,1293.848485,323.6060606,2435.727273,16989.10606,493.9545455,530.4242424,565.1818182,21198.18182,471.6363636,132.7727273,1679.409091,16239.93939,1536.590909,451.5,2819.227273,13794.75758,1071.469697,280.9848485,1167.424242,9012.030303,931.5909091,416.8484848,1323.621212,5570.045455,702.1818182,159.3484848,4516.060606,5569.545455,1287.272727,264.6666667,3286.651515,947.1515152,825.6212121,66,12.34305343,7.1616387,0.814462548,0.916666667,0.545454545,0.824964631
+3916,25390.05556,828.0444444,582.1944444,1086.605556,19408.9,626.9833333,700.0944444,1601.566667,7681.855556,566.7333333,1152.894444,1769.25,12381.42778,1095.677778,7106.061111,3257.872222,4612.85,1181.638889,281.3611111,2464.594444,9111.088889,503.9944444,1809.361111,1064.011111,11024.83333,1026.016667,123.9333333,3110.077778,8300.705556,2227.333333,379.9,2818.872222,6555.272222,636.9833333,240.2944444,891.55,3498.861111,985.6222222,361.5666667,1304.488889,1865.133333,964.8166667,138.6111111,3347.194444,2112.572222,1053.494444,887.6555556,3228.338889,1069.066667,828.2944444,180,15.7410207,14.74244802,0.350500903,0.957446809,0.75,-1.312627797
+3917,27090.68027,832.5034014,536.1836735,1069.816327,24880.55782,671.7142857,794.3605442,1624.911565,12826.35374,539.0204082,1310.503401,1778.789116,16248.16327,1226.292517,4561.244898,3600.646259,6281.442177,1331.163265,314.0068027,2676.605442,13329.71429,404.0680272,1077.102041,1294.102041,16017.09524,553.6054422,127.5510204,2164.380952,12226.34694,1831.904762,467.462585,2811.653061,11023.78231,599.0340136,293.2653061,1374.986395,6558.829932,1202.92517,429.2993197,1326.265306,5124.659864,811.9319728,166.3809524,3611.802721,4542.102041,1304.870748,316.9251701,3273.115646,294.8707483,827.3333333,147,16.90295582,11.44879657,0.73568382,0.960784314,0.765625,-1.280480325
+3918,37491.82353,933.3921569,512.4901961,1089.176471,33552.09804,752,865.9215686,1658.843137,19422.58824,585.745098,1971.666667,1757.078431,23652.62745,1332.333333,3617.54902,3499.352941,8558.078431,1490.921569,332.5490196,2677.294118,18710.03922,493.627451,284.8627451,1000.647059,22063.03922,1209.529412,144.5882353,1781.137255,17638.76471,1710.137255,475.3137255,2841.607843,15321.17647,830.8431373,311.4117647,1253,10271.52941,1362.54902,451.7058824,1324.45098,7605.803922,687.3137255,178.4509804,4000.980392,7009.392157,1399.568627,389.2941176,3363.45098,377.9019608,825.6078431,51,10.655652,6.597649271,0.785257769,0.944444444,0.6375,0.447355336
+3919,24555.76471,925.0420168,750.2268908,1116.697479,22526.40336,723.907563,822.3193277,1646.941176,12543.68067,561.4033613,590.1596639,1785.613445,15124.96639,1291.210084,1636.033613,2012.294118,5553.554622,1481.941176,328.1512605,2418.453782,12215.47899,488.0336134,459.4201681,1021.042017,14639.0084,528.8571429,127.8403361,1360.411765,11207.39496,1542.705882,489.5294118,2822.596639,10006.52941,849.092437,296.1932773,1368.537815,6842.033613,1245.705882,442.789916,1325.243697,5177.840336,709.7310924,168.4621849,1531.689076,4721.134454,1373.663866,389.4537815,3364.243697,455.6470588,828.0840336,119,13.42313557,11.79228152,0.477734549,0.92248062,0.61025641,-1.419843968
+3920,20690.7767,882.5048544,635.9902913,1055.097087,18461,681.2621359,855.2815534,1490.76699,10535.32039,548.7669903,1268.087379,1743.184466,12694.2233,1217.019417,6444.058252,3861.145631,4737.941748,1285.446602,295.0582524,2886.660194,10467.58252,424.961165,549.9223301,480.6019417,12303.91262,747.2718447,119,2042.349515,9793.631068,1624.281553,581.5436893,2803.349515,8792.223301,602.3203883,267.3592233,1428.699029,6074.106796,1118.524272,411.6893204,1316.271845,4624.242718,699.3106796,155.6699029,2203.834951,4289.92233,1268.223301,275.5145631,3317.07767,503.5728155,827.3883495,103,14.57871241,9.63368701,0.75055757,0.927927928,0.668831169,-0.100461589
+3921,14354.93827,775.4012346,483.3765432,1052.555556,13501.20988,628.7407407,597.8271605,1481.203704,7607.728395,489.8580247,455.5802469,1715.833333,9394.197531,1177.604938,1037.771605,820.8271605,3605.765432,1194.524691,270.0432099,2286.216049,7745.08642,401.3148148,101.7222222,500.1975309,9502.290123,527.6728395,113.1790123,881.1790123,7310.703704,1277.271605,554.6728395,2822.950617,6553.160494,617.1975309,246.2530864,1940.802469,4840.253086,829.3271605,379.5,1319.876543,3708.222222,642.7839506,154.0061728,2036.574074,3409.45679,1300.246914,676.617284,3185.314815,641.0123457,831.9753086,162,18.43946798,12.36176903,0.742002357,0.861702128,0.50625,-0.509400841
+3922,24138.2906,842.8504274,534.1410256,1058.982906,21522.08547,647.2735043,603.2094017,1547.508547,11797.7094,509.0897436,582.3205128,1743.897436,15615.97436,1171.517094,4620.196581,2835.726496,5766.641026,1222.106838,285.6623932,2348.059829,11839.76068,2156.038462,509.7179487,601.0128205,14801.26496,624.0299145,119.6153846,4003.470085,11262.79487,1737.589744,653.8333333,2792.230769,9553.897436,609.8504274,263.8247863,1509.606838,6798.316239,889.8632479,394.0769231,1301.534188,4577.478632,723.0641026,159.3504274,5313.632479,4435.363248,1206.162393,166.2948718,3281.991453,865.3760684,831.2649573,234,20.71614367,15.03053072,0.68817288,0.936,0.655462185,0.418485995
+3923,21170.23944,1139.014085,552.6760563,1026.15493,18404.21127,715.6478873,651.5633803,1433.760563,8375.873239,577.4366197,946.6478873,1725.267606,11667.09859,1170.816901,4159.943662,2459.267606,4033.43662,1129.225352,257.7042254,2378.112676,7634.619718,365.915493,133.7887324,1222.126761,9741.408451,636.1126761,165.7746479,3116.084507,6929.253521,1735.014085,411,2794.521127,5732.619718,541.3239437,219.1971831,1025.450704,3799.605634,901,354.4225352,1279.760563,2567.394366,542.3521127,146.2676056,1795.71831,2165.591549,1011.802817,197.2394366,3512.197183,934.8873239,825.9859155,71,10.92010672,8.635573523,0.612080181,0.946666667,0.645454545,-1.185030081
+3924,30861.34409,902.7634409,561.9677419,1105.526882,28069.62366,721.1397849,695.5483871,1664.548387,15824,575.6236559,791.3010753,1740.634409,19059.24731,1340.956989,3781.494624,2589.182796,7055.451613,1582.763441,349.3870968,2473.096774,15372.05376,665.2795699,985.9139785,577.0967742,18183.32258,979.0967742,130.4408602,1580.397849,14081.96774,1852.677419,594.827957,2915.311828,12515.32258,726.9569892,301.0215054,1261.752688,8258.903226,1287.494624,444.9569892,1320.806452,6381.365591,855.8924731,181.5913978,2410.268817,5662.849462,1405.354839,512.1827957,3272.086022,370.2150538,828.2258065,93,13.1115657,9.680591604,0.67444553,0.920792079,0.664285714,1.248705118
+3925,38623.00794,891.9047619,518.4444444,1109.396825,34592.42063,734.3730159,850.2857143,1660.18254,19391.96032,570.1904762,1023.238095,1780.761905,23483.7619,1302.992063,3397.039683,3245.960317,8654,1439.087302,332.4761905,2527.634921,18485.33333,444.6984127,191.1984127,612.3333333,22246.14286,446.6269841,135.2619048,2071.992063,17611.30159,1819.134921,520.7063492,2853.611111,15414.24603,1046.412698,318.3571429,1639.103175,10274.4127,1089.968254,452.547619,1312.087302,7660.007937,651.9603175,178.4603175,2186.071429,7078.190476,1430.873016,1042.492063,3270.492063,395.3888889,831.1031746,126,15.30696437,11.4501864,0.663656237,0.913043478,0.617647059,-0.065472303
+3926,28234.18947,867.6210526,521.9473684,1072.2,26128.42105,687.4210526,540.5157895,1520.705263,13755.36842,541.7052632,579.3157895,1731.473684,17431.73684,1256.189474,1679.610526,2315.821053,6309.136842,1671.284211,308.6526316,2344.568421,13658.15789,410.1578947,374.5368421,455.4315789,16543.11579,452.6631579,124.5368421,2154.873684,12859.34737,1482.473684,546.9789474,2864.831579,11270.73684,706.1368421,289.9157895,1492.768421,7644.715789,854.0631579,432.3684211,1320.2,5894.557895,696.3052632,167.6210526,3944.2,5353.726316,1333.568421,897.4210526,3266.494737,411.7894737,828.5789474,95,13.51929434,9.229177164,0.73072954,0.95959596,0.664335664,-0.489381556
+3927,18288.99543,800.1872146,512.1004566,1065.995434,17127.18721,654.739726,628.3972603,1516.488584,9785.744292,501.8401826,680.0228311,1745.584475,12472.74886,1204.333333,1128.063927,1265.90411,4603.223744,1303.196347,324.652968,2509.004566,9882.894977,431.283105,127.2054795,698.4109589,11956.54795,896.5388128,111.2694064,831.5707763,9335.39726,1293.086758,532.6438356,2802.60274,8277.223744,694.4703196,252.4292237,2351.018265,6090.141553,1064.96347,381.8173516,1333.369863,4628.6621,1203.16895,149.8219178,2172.730594,4325.908676,1400.310502,1364.86758,3219.388128,683.6712329,833.3744292,219,24.04535054,12.04497543,0.865489294,0.916317992,0.523923445,-0.727325246
+3928,27669.53448,889.3448276,562.8793103,1091.689655,25548.39655,767.1551724,1275.637931,1632.189655,14142.51724,557.7241379,2381.775862,1904.586207,17809.65517,1278.413793,3613.362069,4592.413793,6446.431034,1385.689655,305.9137931,2955.862069,13772.56897,431.2758621,191.9310345,1272.655172,16123.5,477.7586207,178.5344828,2890.224138,12978.41379,2125.103448,570.5,2814.551724,11223.93103,926.0344828,288.9137931,1730.086207,7473.862069,1315.534483,440.4137931,1311.224138,5689.982759,630.6551724,171.7931034,4639.068966,5157.982759,1345.051724,1445.775862,3249.672414,385.5517241,827.4310345,58,9.800037429,7.690949562,0.619764592,0.966666667,0.805555556,-0.80829129
+3929,7796.084337,1151.73494,754.686747,1123.795181,8114.325301,672.1566265,677.5903614,1491.746988,3810.518072,524.8915663,524.3493976,1818.313253,4859.192771,1172.578313,1011.783133,1128.590361,2008.795181,1327.518072,267.626506,2357.783133,4489.493976,378.2650602,132.626506,491.6144578,4725.096386,396.4457831,114.4216867,1004.277108,3705.686747,1392.903614,469.4698795,2792.771084,3559.337349,534.4939759,244.7228916,1445.036145,2550.180723,804.0843373,394.1204819,1330.722892,2183.180723,569.2289157,151.253012,860.5903614,1791.204819,1184.301205,135.1325301,3310.060241,512.3373494,830.6144578,83,12.58840992,10.42854086,0.560101492,0.783018868,0.532051282,0.876820864
+3930,36696.02326,818.503876,510.3488372,1071.48062,32538.99225,756.2635659,1087.054264,1576.139535,19066.49612,538.744186,1576.44186,1832.271318,23026.51163,1264.875969,2915.457364,3766.581395,8428.364341,1300.829457,298.0930233,2419.542636,18155.21705,425.9224806,112.1472868,1632.379845,22008.96124,431.248062,377.0077519,1484.162791,16967.4031,2081.666667,595.8062016,2798.844961,14694.94574,741.5426357,276.6744186,1479.131783,10549.45736,1227.224806,402.2403101,1301.488372,7907.860465,607.1627907,161.124031,2682.465116,7084.945736,1341.031008,489.4883721,3249.387597,606.751938,831.1937984,129,13.26535027,12.87970733,0.239369478,0.955555556,0.5375,0.288923186
+3931,17567.92917,822.5583333,430.9833333,1037.920833,16301.12083,638.1416667,570.2583333,1417.075,9196.333333,500.5291667,546.8333333,1720.95,11890.79583,1187.8125,1183.029167,898.9583333,4408.825,1321.770833,340.0958333,2307.454167,8922.679167,387.1125,103.9291667,591.6208333,11027.325,545.6666667,109.5916667,778.1541667,8598.583333,1344.991667,501.1708333,2824.854167,7524.116667,609.2208333,245.45,2005.241667,5648.820833,866.5708333,381.5291667,1308.108333,4191.629167,644.525,149.4125,1999.4125,3842.016667,1346.7625,6300.458333,3216.854167,702.6958333,834.3416667,240,20.33984669,16.01486542,0.616488238,0.875912409,0.601503759,-0.410531049
+3932,17337.25806,772.5,483.6290323,1058.927419,15636.67742,737.1370968,914.8629032,1533.903226,8012.733871,1007.862903,1079.120968,1784.983871,10764.54032,1101.483871,2664.169355,2063.459677,4140.419355,1150.798387,302.9112903,2678.524194,8158.685484,362.8145161,4081.604839,1498.91129,10081.32258,459.4919355,545.9274194,1482.822581,7876.33871,2045.725806,439.5967742,2793.209677,6639.532258,587.7096774,257.1209677,1018.717742,4425.08871,806.3306452,381.8387097,1496.983871,2661.798387,1474.201613,155.1290323,6557.983871,2727.064516,1121.153226,300.6532258,3123.798387,964.1290323,830.0887097,124,14.54161435,10.97302223,0.656191389,0.96875,0.681318681,-0.559487916
+3933,29541.44118,941.0294118,690.5588235,1114.757353,24086.18382,707.7720588,884.4191176,1771.117647,10896.39706,515.4632353,1678.110294,1802.279412,15297.40441,1193.647059,6408.022059,2688.007353,5961.838235,1497.845588,300.9926471,2717.75,11985.83824,411.7279412,2496.669118,1534.786765,14762.54412,477.7279412,155.0147059,1453.676471,11211.95588,2214.544118,682.0661765,2820.602941,9113.882353,583.4191176,258.9852941,928.375,5278.573529,1279.919118,388.4705882,1319.669118,2765.911765,1056.397059,155.2867647,5319.161765,2995.073529,1136.227941,466.7647059,3247.904412,1037.058824,831.0735294,136,15.45905227,11.4862813,0.669276662,0.877419355,0.604444444,0.700512212
+3934,39356.84932,901.3835616,538.3835616,1110.061644,26817.75342,601.3972603,737.5136986,1524.150685,11593.74658,458.2123288,1489.068493,1716.068493,17452.4589,1087.363014,3928.10274,2466.863014,6635.869863,1155.719178,269.0479452,2400.308219,13451.20548,364.260274,165.0479452,1530.513699,16628.00685,547.2739726,114.5410959,1255.363014,12567.22603,2281.006849,359.2191781,2794.143836,10170.63699,562.9109589,250.739726,799.1986301,5760.321918,1313.883562,372.6712329,1275.273973,3060.013699,574.4931507,144.0136986,1224.952055,3359.013699,1071.356164,323.0890411,3108.883562,1049.582192,831.4178082,146,16.81935001,11.523181,0.728435369,0.895705521,0.608333333,0.743735773
+3935,24535.86598,815.7835052,576.7835052,1095.494845,22652.34021,666.5670103,656.9587629,1577.742268,12752.51546,513.4123711,670.6804124,1787.876289,16473.63918,1198.886598,2183.845361,2431.051546,6307.453608,1257.206186,291.3917526,2318.57732,12793.73196,410.2886598,371.2783505,755.6494845,15885.42268,517.4639175,119.1443299,1950.56701,12182.17526,1635.443299,524.0103093,2941.618557,10564.25773,1132.649485,272.8556701,2048.329897,7610.247423,1164.257732,408.2268041,1314.948454,5244.804124,718.0618557,159.2268041,2699.257732,5073.835052,1300.57732,890.5257732,3296.556701,831.8762887,830.7835052,97,12.97120648,9.839454553,0.651601746,0.97,0.621794872,-0.718307574
+3936,34672.35474,910.9082569,602.3547401,1101.541284,30652.72477,707.5657492,865.0856269,1618.908257,17038.6208,544.204893,1367.088685,1750.422018,22055.3578,1262.562691,3534.437309,3377.611621,8171.015291,1317.370031,315.82263,2560.889908,16725.97859,404.5657492,696.4311927,1212.186544,21274.69113,1122.027523,203.470948,2889.2263,15884.59939,1987.782875,553.0275229,2795.782875,13604.81957,777.2110092,281.6207951,1264.547401,9416.559633,1123.776758,415.0183486,1330.186544,6074.764526,808.2599388,162.9663609,4698.892966,5865.366972,1284.798165,376.9296636,3307.495413,885.4311927,833.764526,327,25.71979186,18.01868802,0.713577064,0.823677582,0.654,-1.375454072
+3937,27004.84314,927.9803922,647.3137255,1084.676471,24218.16667,629.1666667,569.0980392,1524.235294,13306.43137,488.9313725,555.3823529,1689.617647,17330.21569,1137.803922,3450.235294,2739.588235,6431.637255,1199.107843,279.6372549,2255.45098,13267.41176,372.5882353,202.372549,2233.166667,16544.29412,594.9117647,122.9803922,3905.029412,12484.30392,1451.313725,458.5882353,2782.862745,10747.08824,611.9313725,257.1176471,1292.078431,7329.676471,951.0294118,394.627451,1280.294118,4717.823529,648.1764706,149.7058824,2629.754902,4639.647059,1191.911765,385.2647059,3399.392157,903.2843137,830.3431373,102,11.82848363,11.47751127,0.2417916,0.910714286,0.56043956,0.763958547
+3938,38636.34862,870.6146789,572.3944954,1118.678899,34777.59633,817.8807339,914.1559633,1800.715596,17550.9633,537.3577982,1635.137615,1925.275229,23585.77982,1253.394495,5342.761468,4536.59633,8785.954128,1290.394495,314.3669725,2439.366972,17704.48624,446.5779817,198.8807339,2102.853211,22366.31193,573.3944954,1342.53211,2632.33945,17293.98165,2194.66055,475.1192661,2855.357798,14140.83486,668.9082569,285.587156,1141.853211,9037.990826,1088.853211,419.4587156,1305.66055,5170.027523,620.9266055,167.2018349,3222.990826,5323.477064,1268.917431,542.7247706,3221.825688,988.4587156,830.0550459,109,15.77476891,9.175065788,0.813454059,0.893442623,0.582887701,1.558093713
+3939,35823.42188,880.9375,555.546875,1083.421875,31210.4375,709.4375,732.28125,1554.59375,17797.70313,542.078125,952.265625,1763.640625,21961.71875,1250.75,3073.46875,3516.734375,7862.15625,1708.046875,315.484375,2415.921875,17073.3125,440.78125,791.765625,645.921875,20699.28125,453.21875,149.796875,2520.125,16711.875,1758.875,641.328125,2821.34375,14481.78125,663.796875,297.9375,1435.828125,9872.15625,1064.109375,432.984375,1317.390625,7415.109375,770.453125,172.671875,4213.109375,6860.4375,1379.171875,192.09375,3310.359375,426.375,829.234375,64,14.48117832,6.238314531,0.902453265,0.842105263,0.533333333,1.314746746
+3940,15440.03419,966.1794872,800.0940171,1110.059829,14618.13675,756.3675214,1137.504274,1590.282051,7738.982906,611.6752137,1113.205128,1811.324786,9595.82906,1263.452991,2517.282051,2316.649573,3619.179487,1361.965812,297.8461538,2449.991453,7932.213675,415.6068376,826.5384615,1178.880342,9355.264957,657.0683761,277.4273504,1270.880342,7039.923077,1890.25641,477.2222222,2817.316239,6234.521368,907.8205128,275.3247863,1471.957265,4385.521368,952.4017094,422.5641026,1330.811966,3428.564103,814.2222222,162.2820513,2280.145299,3020.213675,1285.418803,237.4615385,3346.692308,495.974359,833.8547009,117,16.58314464,9.460745522,0.821295025,0.860294118,0.5625,0.242811821
+3941,28413.912,872.552,592.928,1082.096,25883.952,696.36,627.848,1649.08,13131.792,520.992,447.848,1759.4,18130.648,1220.208,5034.776,3912.16,6822.328,1236.376,323.152,2334.464,13617.64,412.408,545.816,573.704,17380.528,555.968,125.776,4256.944,13070.424,1638.456,475.568,2780.656,11142.272,622,263.8,1569.048,7284.008,1052,405.456,1310.224,4582.976,720.392,161,6124.4,4537.384,1227.688,345.064,3258.592,942.744,833.496,125,13.90934932,11.99237964,0.506599999,0.925925926,0.595238095,0.77065044
+3942,16266.16514,861.7477064,471.1238532,1062.119266,15218.92661,682.4495413,399.5825688,1515.908257,6659.422018,525.3119266,358.0183486,1713.013761,9753.201835,1302.880734,2260.509174,1230.43578,3700.412844,1351.16055,313.9174312,2264.027523,7911.142202,369.587156,902.6238532,430.4541284,9659.275229,394.4633028,124.2752294,1417.857798,7165.229358,1434.651376,303.4633028,2830.958716,6322.013761,668.6559633,280.0733945,1062.486239,3073.908257,728.9266055,404.9082569,1307.509174,2186.651376,735.7247706,162.2568807,3360.307339,2320.761468,1257.201835,1400.288991,3121.321101,208.2201835,834.6422018,218,21.0713652,13.29410384,0.775857228,0.951965066,0.641176471,-1.036570874
+3943,30605.38119,877.7326733,558.5,1094.40099,25090.39604,662.8910891,605.2425743,1631.143564,12122.71782,533.1980198,1223.485149,1761.712871,16401.77228,1199.232673,5802.480198,2929.391089,6297.861386,1273.351485,300.3663366,2450.519802,12898.15842,362.8712871,920.6237624,795.0049505,16018.21782,436.0643564,230.7524752,4216.009901,11962.9604,1692.792079,347.2970297,2833.722772,10544.67327,586.2673267,268.7029703,1167.376238,5455.940594,911.0544554,404.7722772,1311.509901,3889.183168,826.2425743,154.0148515,3259.757426,3708.292079,1222.49505,219.5594059,3262.658416,235.6485149,833.3069307,202,19.59801512,13.43256607,0.728162612,0.939534884,0.721428571,-1.396871436
+3944,31899.46753,1021.987013,512.0909091,1051.467532,28042.37662,730.987013,702.5974026,1529.662338,15361.74026,590.7142857,1009.337662,1733.623377,19095.31169,1294.571429,3284.571429,2348.701299,6579.545455,1350.844156,313.6363636,2346.116883,14402.75325,392.6493506,310.6493506,770.2727273,17660.87013,665.5324675,125.5974026,1617.428571,13721.88312,1509.519481,355.6493506,2814.181818,12008.54545,657.8051948,293.9220779,1039.363636,7375.727273,1177.987013,421.8181818,1297.87013,5587.246753,715.7272727,167.8051948,1533.285714,5096.922078,1344.064935,3668.558442,3289.376623,315.8701299,831.5974026,77,10.51472927,9.76772351,0.370189517,0.9625,0.583333333,1.24733589
+3945,27255.11732,853.6480447,612.8100559,1089.27933,24591.53073,745.5251397,979.4022346,1607.106145,13867.97765,554.4301676,1916.832402,1929.01676,16786.87709,1331.240223,2941.430168,3969.268156,6126.005587,1358.787709,321.6089385,3144.553073,13211.19553,469.3519553,781.6312849,971.726257,16267.10615,1596.324022,282.3631285,1109.134078,12300.31285,2051.022346,1654.994413,2821.106145,10684.17318,897.2849162,293.4748603,1413.290503,7598.972067,1580.162011,440.2122905,1387.631285,5787.893855,766.972067,171.4301676,5390.715084,5103.324022,1361.949721,357.3351955,3378.268156,541.2290503,833.4581006,179,16.96695325,13.53469411,0.60304236,0.92746114,0.71031746,-1.281963829
+3946,27784.0614,851.4824561,562.5,1085.614035,26270.01754,678.9035088,645.8333333,1691.657895,12673.2193,538.4649123,1216.552632,1736.859649,17001.24561,1190.508772,5584.973684,4849.184211,6485.903509,1280.692982,347.5526316,2442.368421,13035.19298,403.7807018,635.2192982,2191.04386,16471.53509,944.0614035,134.9649123,2688.078947,12336.92982,2237.464912,488.5526316,2821,10338.50877,599.3333333,268.5526316,1118.824561,6605.701754,1504.464912,407.4912281,1311.631579,3911.535088,723.6754386,158.7368421,2715.087719,3857.964912,1236.77193,190.5789474,3200.72807,977.8508772,833.3859649,114,17.03631919,8.782356586,0.856884845,0.919354839,0.542857143,0.81816941
+3947,27754.5,864.0416667,482.25,1079.895833,26369.08333,681.2083333,506.7291667,1499.333333,13524.375,530.1458333,651.4791667,1686.020833,16415.85417,1248.875,1616.520833,2527.833333,6366.166667,1561.729167,307.9166667,2329.5625,13607.41667,393,314.5416667,475.1875,16237.5625,443.7083333,123.875,1578.333333,12010.625,1475.166667,478.1041667,2837.0625,10730.875,1058.458333,277.375,1457.854167,7362.375,1012.979167,438.3125,1316.0625,5746.5,656.4583333,169.4166667,1903.104167,4903.041667,1377.666667,2697.541667,3182.75,403.6041667,831.5625,48,9.579007036,6.481243174,0.736342412,1,0.888888889,0.099053652
+3948,44127.52632,867.1754386,491.8070175,1119.263158,38573.24561,709.122807,624.5614035,1604.122807,23216.57895,563.6491228,1335.684211,1769.789474,29275.03509,1302.824561,2195.140351,3464.333333,10233.57895,1442.719298,369.1052632,2558.526316,21592.61404,613.3859649,122.8245614,848.1929825,26474.19298,578.9824561,121.9473684,1225.105263,21379.80702,1965.157895,559.6491228,2861.175439,18629.57895,717.1754386,304.1578947,1242.807018,13486.4386,1408.824561,404.4035088,1327.719298,9340.298246,634.754386,160.9473684,2741.614035,8924.526316,1421.77193,407.3859649,3188.491228,737.7192982,833.5614035,57,12.04711352,6.280188757,0.853372044,0.93442623,0.59375,0.392171934
+3949,32920.91954,910.8045977,1218.114943,1153.333333,28495.45977,847.2068966,1161.195402,1778.471264,16454.70115,549.9770115,951.1034483,1834.390805,21329.41379,1290.827586,1345.011494,1939.482759,7618.229885,1339.425287,310.9655172,2504.011494,15784.02299,456.8045977,120.6896552,659.1034483,18998.70115,507.3678161,299.0114943,1451.643678,15063.5977,1629.321839,487.5747126,2814.218391,12786.37931,940.9655172,282.5977011,1648.264368,9246.206897,1112.45977,426.7701149,1336.287356,6341.494253,604.6896552,165.6091954,2972.586207,6057.62069,1341.218391,484.2988506,3328.436782,821.2988506,833.7126437,87,11.66391843,9.819431378,0.539689951,0.896907216,0.725,-0.381985358
+3950,30539.07143,994.797619,1053.964286,1193.166667,27047.92857,787.5238095,1342.547619,1996.488095,12854.94048,544.7261905,888.0952381,1796.166667,17530.66667,1333.547619,2361,1987.642857,6480.845238,1401.857143,330.4880952,2371.107143,13040.85714,707.047619,211.5952381,919.8928571,16387.55952,748.9285714,140.3571429,1512.714286,12614.92857,1750.47619,421.9047619,2828.178571,10377.89286,1186.392857,290.9761905,1179.583333,6425.559524,990.8690476,422.6904762,1324.964286,3625.178571,627.8095238,163.9404762,1667.738095,3707.559524,1273.511905,598.0714286,3340.702381,1000.107143,834.0833333,84,13.15614843,8.460103719,0.765821484,0.923076923,0.6,-0.065391551
+3951,40425.63636,887.1688312,574.1168831,1133.337662,34156.01299,783.2727273,1150.298701,1822.909091,17232.98701,551.9350649,2496.675325,1882.519481,23043.42857,1272.285714,6518.285714,4046.649351,9003.415584,1341.142857,323.3116883,2742.597403,18159.84416,1026.87013,328.7012987,2432.727273,22629.14286,561.7922078,366.987013,1644.038961,17547.19481,2727.116883,387.8831169,2841.636364,14333.16883,658,285.9480519,978.3636364,8786.168831,2012.194805,416.8961039,1317.38961,4908.662338,657.7532468,158.6623377,3175.974026,5154.25974,1244.532468,274.5974026,3263.311688,1011.935065,831.9480519,77,11.21886781,8.94138918,0.603985004,0.927710843,0.658119658,1.45322501
+3952,26419.84483,853.2844828,609.9655172,1096.275862,19965.81034,562.5431034,367.8965517,1558.137931,9557.543103,463.6034483,545.2586207,1769.681034,12699.47414,1083.974138,6139.008621,2951.681034,4930.456897,1181.482759,278.1982759,2301.517241,10151.92241,323.5431034,568.5172414,508.9310345,12454.10345,364.3706897,115.8189655,5813.853448,9466.913793,1480.232759,384.1465517,2825,8372.094828,578.7844828,249.2586207,1249.163793,4580.163793,747.9137931,381.5086207,1328.956897,3394.387931,691.4482759,151.6896552,5153.913793,3133.922414,1160.465517,169.8103448,3264.017241,256.887931,834.6810345,116,14.3013459,11.3618223,0.607318764,0.899224806,0.594871795,1.354073925
+3953,29000.425,917.275,547.3583333,1080.341667,26787,713.1083333,538.1,1541.783333,14627.64167,558.125,519.9583333,1759.975,18045.23333,1267.833333,3387.491667,3166.033333,6480.933333,1861.875,303.7666667,2321.641667,14090.63333,411.3666667,357.475,475.8,16743.3,425.4166667,123.4166667,3064.75,13421.24167,1524.058333,591.2583333,2814.241667,11616.35,626.675,287.575,1619.6,7919.458333,861.3583333,437.5583333,1307.383333,6064.833333,687.2333333,175.925,3763.416667,5381.566667,1350.191667,187.1166667,3395.2,415.4416667,836.625,120,17.94075462,10.06437012,0.827830654,0.754716981,0.441176471,-0.867204836
+3954,22742.79191,952.8959538,751.6069364,1083.16185,21291,681.1791908,950.300578,1507.959538,11478.38728,578.8901734,1262.687861,1788.791908,14007.02312,1245.757225,2582.930636,2534.369942,5152.705202,1349.976879,301.0289017,2580.184971,11088.2948,386.9306358,1377.184971,1358.433526,13252.81503,1012.184971,162.699422,1101.208092,10085.51445,1855.450867,478.2196532,2801.768786,8849.710983,595.132948,278.0115607,1412.549133,6043.606936,1184.768786,422.4913295,1363.121387,4684.358382,917.5491329,163.2312139,3282.930636,4104.693642,1285.404624,256.3410405,3271.421965,464.6300578,835.9132948,173,19.20392001,11.85061299,0.786889885,0.901041667,0.686507937,-1.021401529
+3955,26616.25882,909.5529412,808.5764706,1134.223529,24121.76471,725.6470588,719,1670.270588,13869.68235,559.6823529,702.8588235,1789.117647,17273.03529,1330.105882,3422.094118,2582.282353,6028.741176,1359.952941,312.6823529,2543.623529,13115.65882,468.5176471,175.0823529,776.7411765,15880.61176,484.1176471,128.1411765,2279.882353,12338.16471,1572.694118,604.3764706,2817.976471,10592.30588,1137.752941,296.4470588,1573.447059,7674.694118,950.2941176,440.0470588,1339.035294,5730.294118,612.7176471,168.5529412,2310.070588,5203.941176,1363.988235,536.6470588,3382.847059,562.9647059,833.6823529,85,12.30542759,9.089153687,0.674111444,0.904255319,0.607142857,1.377106787
+3956,27173.86316,813.5263158,523.8105263,1063.631579,25804.51579,683.6631579,937.8421053,1563.736842,14451.98947,628.7789474,789.8631579,1779.568421,17819.38947,1235.284211,4050.568421,2763.315789,6400.957895,1290.473684,301.5684211,2353.084211,13736.53684,446.0421053,1150.547368,676.8315789,17047.93684,713.5473684,120.0421053,1687.915789,13164.35789,1599.294737,622.6315789,2804.357895,11459.66316,632.0210526,278.1684211,1483.294737,8309.463158,1165.926316,408.4105263,1326.063158,6068.915789,1020.905263,153.2947368,2551.326316,5739.884211,1332.663158,243.3684211,3247.368421,592.1368421,834.9157895,95,11.41599612,11.03291057,0.256880816,0.904761905,0.608974359,1.148342699
+3957,35076.72059,981.7745098,538.7696078,1101.583333,31162.39706,743.3529412,909.6666667,1627.843137,18338.0098,585.245098,1361.387255,1774.627451,22419.4902,1346.303922,3012.254902,3611.70098,7949.995098,1413.75,356.5490196,2557.877451,16685.55392,609.4803922,110.6176471,1319.397059,20663.56373,493.9754902,217.3872549,2282.759804,15929.55392,1909.323529,536.5882353,2789.279412,13962.53922,1025.607843,287.5343137,1503.602941,10046.79412,1405.882353,414.7058824,1300.5,7125.328431,618.5784314,162.2990196,2689.705882,6323.607843,1377.818627,776.8137255,3237.191176,725.2205882,837.7745098,204,19.68558155,13.79910181,0.713185781,0.923076923,0.68,-0.312325899
+3958,31767.69565,993.7391304,470.7173913,1058.847826,27545.95652,728.6304348,645.4782609,1522.065217,16326.17391,550.3478261,470.2826087,1718.456522,19437.91304,1329.130435,2495.26087,2133.391304,7129.195652,1295.586957,297.1521739,2331.847826,15279.21739,418.2608696,124.673913,519.7391304,18900.97826,414.2826087,130.173913,1832.652174,14514.54348,1465.065217,548.9347826,2799.413043,12712.34783,604.4347826,269.326087,1386.847826,9020.717391,832.2173913,392.9565217,1277.586957,6840.130435,619.1956522,154.1956522,1946.195652,6108.978261,1360.23913,1343.413043,3247.26087,618.1956522,833.2608696,46,9.103168285,6.772428407,0.668219832,0.92,0.575,-1.110336642
+3959,27965.91489,1116.117021,479.4148936,1028,24717.75532,771.4680851,523.7340426,1422.925532,14798.89362,658.4361702,923.287234,1671.893617,18462.1383,1403.670213,1940.202128,1682.712766,6331.5,1377.170213,353.9255319,2314.319149,13520.1383,412.0744681,142.9893617,793.1489362,16734.96809,438.9574468,118,860.3085106,13517.7234,1633.042553,463.3085106,2787.946809,11620.28723,585.4787234,269.2446809,1084.840426,8573.446809,1235.968085,391.3191489,1312.56383,6198.978723,606.4787234,157.4361702,1125.670213,5778.861702,1350.882979,1520.031915,3117.138298,713.9893617,836.5531915,94,14.46289549,8.508501351,0.808643767,0.949494949,0.723076923,-0.449422229
+3960,40526.47368,911.9868421,557,1131.289474,34208.76316,745.8947368,618.5263158,1785.671053,19814.40789,552.7105263,519.1578947,1718.973684,24369.76316,1282.526316,4398.697368,4229.815789,9479.078947,1351.342105,321.2105263,2306.355263,19295.77632,434.0526316,372.9210526,687.8552632,24549.27632,455.1710526,142.9473684,3188.407895,19028.73684,1711.828947,537.0131579,2798.921053,16367.82895,626.9342105,297.8289474,1560.223684,10670.52632,935.9210526,436.2763158,1308.263158,6315.723684,686.7236842,172.2894737,2831.644737,6406.276316,1351.026316,283.6052632,3293,930.0526316,834.5263158,76,11.22399726,8.877420178,0.611903873,0.926829268,0.628099174,-0.899853998
+3961,28986.40455,781.8181818,537.5772727,1076.181818,22130.42727,596.7136364,691.8772727,1560.804545,10121.45,468.1818182,1316.009091,1741.813636,14505.98636,1066.522727,5373.090909,2343.636364,5654.090909,1349.963636,260.3363636,2581.195455,11351.57273,607.1590909,1212.304545,1545.495455,14098.76818,448.3818182,329.7181818,1328.259091,10763.31818,2157.259091,430.05,2812.581818,8836.154545,668.1409091,240.5090909,861.6,5258.013636,1005.25,364.6772727,1275.568182,2834.868182,871.05,145.15,2270.3,3027.809091,1076.640909,940.1818182,3122.090909,1027.95,840.3181818,220,20.39756938,15.11011887,0.671747313,0.88,0.625,0.020730358
+3962,18041.3432,1423.526627,633.6745562,1170.579882,16230.88166,1054.023669,616.0946746,1994.704142,8547.201183,770.0650888,489.1360947,1727.52071,10422.16568,1650.337278,3358.43787,1416.473373,3664.473373,1616.976331,409.035503,2317.076923,7867.964497,519.7869822,506.5266272,448.9526627,9368.076923,515.1656805,163.3254438,1072.053254,7225.307692,2096.005917,410.6923077,2839.147929,6581.526627,717.3609467,402.8816568,1219.242604,4149.970414,1162.260355,546.0295858,1340.591716,3176.100592,1413.443787,208.2248521,1471.881657,2970.201183,1755.52071,4611.159763,3292.810651,325.5384615,838.4911243,169,15.10371784,14.32239103,0.317467241,0.949438202,0.66015625,-0.285823924
+3963,26795.4661,884.5169492,590.6779661,1110.313559,24247.30508,701.6864407,604.7118644,1618.152542,13824.29661,540.0508475,1151.644068,1785.855932,16352.66102,1270.330508,3456.152542,3960.211864,6168.152542,1410.974576,341.8559322,2430.084746,13308.76271,428.2711864,675.0762712,713.3728814,15890.59322,559.4830508,149.5508475,3443.440678,12056.5339,1709.084746,475.1949153,2824.525424,10812.78814,629.6525424,289.9745763,1395.974576,7055.262712,1487.457627,437.2288136,1308.161017,5478.457627,765.2966102,171.7711864,5450.076271,4834.508475,1379.29661,1308.20339,3285.898305,359.1186441,837.7033898,118,13.74840345,11.21104462,0.578836842,0.914728682,0.605128205,-0.534963842
+3964,24471.85227,1001.153409,680.0397727,1129.880682,21247.27273,748.6988636,739.6420455,1610.022727,12278.03977,655.6988636,771.7670455,1753.590909,14995.54545,1338.806818,2446.147727,1810.159091,5525.806818,1402.693182,332.7102273,2528.403409,11831.00568,430.2386364,2272.505682,627.3181818,14268.02273,518.3011364,132.6477273,919.7443182,10897.80682,1634.8125,497.7159091,2822.028409,9571.375,773.6931818,306.8409091,1349.136364,6561.903409,1096.551136,442.6193182,1361.596591,4944.761364,1192.931818,175.6079545,2996.301136,4546.414773,1370.982955,261.8636364,3262.715909,484.5397727,838.8806818,176,17.31026092,13.35569149,0.636171512,0.921465969,0.611111111,-0.664748669
+3965,26903.325,798.33125,469.48125,1061.10625,24129.13125,669.375,642.29375,1545.5625,13460.68125,799.01875,555.55,1740.3375,17389.28125,1189.825,2502.2125,1629.03125,6244.90625,1296.33125,311.3,2343.475,12564.18125,7323.4875,526.73125,525.58125,15367.1,874.4125,114.85,1389.1125,12031.93125,1550.3375,561.63125,2803.60625,10404.25,644.04375,259.69375,1269.24375,7497.5875,974.6125,386.55625,1341.3375,5388.39375,728.95625,152.41875,4482.91875,5025.86875,1251.7,273.325,3257.15,749.48125,836.48125,160,16.17892309,12.76836707,0.614139372,0.963855422,0.769230769,1.310016388
+3966,27534.66667,852.2307692,815.6153846,1109.397436,24366.16667,702.9871795,1011.679487,1633.833333,14152.16667,614.1666667,1615.769231,1826.602564,17739.16667,1247,2775.179487,4937.769231,6541.5,1301.192308,308.6025641,2486.987179,13602.80769,445.474359,229.3205128,1617.846154,16735.97436,2002.525641,119.8333333,1642.115385,12953.29487,1618.628205,521.0128205,2803.564103,11142.38462,692.1153846,278.5384615,1656.384615,8152.410256,1740.923077,421.4487179,1337.294872,5608.230769,637.3205128,157.9487179,3067.179487,5349.064103,1362.294872,445.7692308,3232.75641,809.974359,835.9358974,78,11.64930119,8.653564753,0.669469198,1,0.644628099,0.821295264
+3967,36956.96429,886.2428571,620.15,1129.971429,32414.77857,697.4071429,549.4785714,1689.628571,16296.95,541.8214286,638.4071429,1784.714286,21034.07143,1246.321429,5636.635714,2995.157143,7888.771429,1338.528571,319.1642857,2299.714286,16361.31429,393.9785714,610.3857143,522.85,20071.38571,404.6357143,128.0857143,3952.742857,15473.59286,1506.614286,355.2285714,2807.157143,13473.27857,597.8714286,289.0857143,1258.464286,6988.178571,862.0285714,420.3142857,1318.8,4948.621429,707.4214286,161.3642857,2925.492857,4621.971429,1252.814286,152.1214286,3280.685714,247.8428571,841.6928571,140,17.92531931,10.42420991,0.813521012,0.880503145,0.614035088,0.044796981
+3968,22180.45113,1064.691729,599.4586466,1062.451128,18691.71429,701.7293233,682.8496241,1485.270677,10137.01504,586.4887218,1153.819549,1723.390977,12580.65414,1276.135338,3432.18797,2459.857143,4628.120301,1274.368421,302.2406015,2794.075188,9961.37594,375.9924812,241.4210526,691.6992481,12084.94737,512.8571429,119.8120301,1716.383459,9405.195489,1761.661654,350.1804511,2817.518797,8489.368421,563.4360902,276.556391,1091.413534,5186.06015,1038.345865,410.6842105,1295.398496,3930.43609,606.7744361,160.2481203,1989.75188,3584.969925,1263.075188,3419.458647,3250.037594,309.5488722,839.7293233,133,14.05652585,12.2566785,0.48958343,0.977941176,0.682051282,0.333463042
+3969,30421.56667,890.1833333,563.9833333,1105.8125,26676.50417,713.6125,825.9375,1621.270833,15615.84167,565.3666667,794.4375,1758.4125,18704.1875,1288.241667,2898.216667,3692.3,6797.475,1516.158333,331.2333333,2350.608333,14620.20833,462.7416667,1074.833333,585.7375,17718.06667,656.5041667,131.3166667,2052.958333,13825.63333,1682.195833,601.0375,2820.2375,12105.55,682.725,296.825,1596.908333,8211.020833,1077.3125,448.3291667,1327.804167,6075.8125,873.0541667,175.1333333,2514.791667,5605.958333,1385.220833,1430.091667,3252.616667,448.6458333,844.0333333,240,25.57278409,12.66785926,0.868685001,0.848056537,0.615384615,-0.129673128
+3970,13311.20408,782.7918367,498.8979592,1068.497959,12447.2898,648.2122449,607.2693878,1476.355102,7123.404082,504.3020408,522.3714286,1730.036735,9066.073469,1197.526531,860.6040816,973.9183673,3382.220408,1288.106122,286.4081633,2300.967347,7292.477551,425.7387755,168.1877551,553.5591837,8841,669.6367347,111.7102041,881.8244898,7004.138776,1304.244898,662.2326531,2810.922449,6283.126531,671.1673469,255.7836735,2690.816327,4636.008163,859.6,387.8816327,1353.342857,3573.693878,765.5714286,154.4408163,2113.391837,3323.187755,1351.502041,1831.820408,3247.297959,662.877551,839.7265306,245,19.8289994,15.8364997,0.601791154,0.968379447,0.716374269,-0.849702732
+3971,30056.07767,1016.15534,571.6893204,1071.368932,25882.7767,716.0873786,649.7864078,1503.669903,14587.13592,572.9805825,777.5436893,1706.116505,19209.28155,1259.883495,2946.31068,3006.106796,6854.398058,1233.757282,292.3398058,2310.873786,14230.34951,581.776699,156.0776699,701.2718447,17157.42718,572.3398058,115.7864078,2856.834951,13482.21359,1668.980583,547.2330097,2804.135922,11611.2233,723.6407767,259.815534,1431.048544,8260.621359,910.6116505,394.0970874,1301.61165,5660.300971,606.4466019,153.6990291,2559.533981,5411.145631,1230.504854,235.6116505,3488.543689,838.6213592,837.6601942,103,12.8206181,10.45169531,0.579143608,0.971698113,0.613095238,-1.1946585
+3972,30551.275,892.0214286,669.9785714,1102.417857,26575.23571,707.3071429,782.3178571,1637.996429,14457.62857,530.3392857,1202.614286,1766.925,19127.71786,1217.717857,4464.432143,3235.857143,6999.260714,1258.417857,306.3,2350.853571,14342.14643,400.475,550.3464286,1524.703571,17984.53929,450.8607143,586.2071429,3507.660714,13651.18571,2108.464286,523.2678571,2809.5,11669.52143,636.5214286,268.9571429,1152.217857,7804.346429,989.3714286,406.7821429,1318.532143,4839.728571,837.7785714,157.575,2208.582143,4742.042857,1224.471429,339.7285714,3281.096429,915.4535714,840.3428571,280,20.00487984,18.24447601,0.410187355,0.933333333,0.701754386,1.376292118
+3973,38684.82192,890.9589041,515.0136986,1095.671233,35228.91781,738.1232877,945.3835616,1618.438356,19830.60274,582.8630137,1701.876712,1785.438356,23756.39726,1356.945205,2932.178082,3977.369863,8794.780822,1466.630137,340.8767123,2599.260274,19142.17808,1133.506849,284.2328767,932.8356164,23271.0274,1521.068493,135.2054795,1506.205479,17889.64384,1780.931507,453.1232877,2844.136986,15991.56164,950.7123288,318.6849315,1259.589041,10533.57534,1685.424658,465,1317.260274,7951.232877,672.9315068,181.7260274,3100.808219,7244.726027,1434.794521,415.6712329,3296.671233,370.2739726,836.8082192,73,11.24497192,9.490127627,0.53643114,0.848837209,0.608333333,1.450148165
+3974,31433.824,872.672,579.496,1088.56,29219.92,735.448,666.216,1620.664,16075.096,556.624,899.6,1793.672,19617.912,1311.104,3106.208,4118.656,7206.344,1428.232,316.512,2414.648,15541.52,494.68,207.552,728.2,18674.232,440.656,196.864,2885.104,14560.144,1664.368,656.856,2825.608,12870.864,841.984,300.088,1750.576,8546.584,1104.232,443.936,1307.256,6481.424,649.608,175.752,3767.688,5843.76,1401.2,1338.112,3257.408,387.288,839.384,125,13.42101729,12.20614169,0.41574851,0.939849624,0.595238095,0.635278166
+3975,24788.93467,921.7386935,611.2763819,1078.38191,22228.41709,702.7537688,631.3417085,1537.170854,12238.50251,555.0050251,828.281407,1784.507538,15417.07538,1280.824121,3038.20603,2712.467337,5468.321608,1962.005025,305.919598,2339.924623,11796.22111,404.0351759,1021.070352,609.5427136,14410.76382,432.718593,128.2361809,2352.994975,11420.65829,1750.492462,528.5276382,2822.19598,9942.552764,730.4924623,286.9095477,1467.211055,6780.713568,1162.211055,432.6331658,1317.396985,5134.020101,915.5075377,169.7085427,3649.939698,4672.738693,1355.150754,210.9648241,3279.170854,427.2713568,840.9346734,199,16.6076109,15.62648579,0.338620142,0.947619048,0.690972222,1.518513663
+3976,17545.2987,858.7662338,486.7402597,1037.571429,15920.97403,678.3506494,552.9350649,1486.506494,8504.12987,948.9480519,388.1168831,1764.831169,11400.7013,1286.142857,2728.441558,1797.025974,4022.285714,1542.246753,332.9090909,2277.792208,8359.649351,390.8181818,856.3766234,457.4155844,10173.7013,415.1818182,113.3766234,1105.701299,7631.779221,1525.649351,583.2337662,2783.272727,6715.337662,803.3896104,253.3896104,1324.987013,4936.961039,765.5974026,370.7662338,1359.220779,3723.896104,805.4025974,161,2494.987013,3362.584416,1434.753247,9895.142857,3157.363636,623.7142857,839.2207792,77,12.56371657,8.043033302,0.768225395,0.927710843,0.611111111,-0.192399537
+3977,28198.8216,845.2910798,535.4929577,1096.126761,25089.83099,677.6713615,644.8356808,1597.525822,13925.53991,583.8638498,1060.624413,1739.478873,17730.30516,1247.394366,2417.140845,3424.159624,6492.530516,1284.901408,305.8732394,2413.643192,13377.13146,408.7230047,228.7699531,920.0892019,16704.21596,1161.751174,131.2910798,2516.164319,12586.22535,1470.286385,564.0751174,2809.929577,10920.68075,1053.234742,274.7840376,1769.201878,7913.328638,1273.859155,411.4507042,1317.816901,5517.159624,656.1173709,162.7793427,3552.502347,5123.469484,1332.732394,424.4882629,3216.746479,791.4835681,838.7981221,213,22.96251645,11.95338213,0.853824705,0.938325991,0.806818182,1.536024316
+3978,32944.99065,997.3084112,537.7196262,1082.261682,27283.74766,720.9953271,622,1565.635514,15839.34112,572.7336449,843.3271028,1722.64486,20053,1270.247664,2596.742991,3233.378505,7411.345794,1258.957944,301.9859813,2375.046729,15405.72897,561.3504673,128.5841121,672.682243,19052.25234,634.4158879,126.0093458,3149.962617,14478.98131,1635.023364,521.0373832,2797.831776,12586.23832,634.182243,279.4672897,1487.116822,8785.200935,1004.443925,402.2897196,1288.172897,5791.971963,597.4859813,162.9205607,3141.443925,5582.285047,1238.845794,169.3037383,3338.163551,856.3457944,841.7897196,214,20.52244529,13.68480889,0.745217427,0.938596491,0.594444444,0.57022225
+3979,31501.47475,835.6464646,576.0808081,1072.030303,28657.89899,695.4848485,925.6262626,1678.222222,15067.19192,633.3131313,1310.464646,1807.373737,19107.25253,1179.858586,5350.737374,4166.040404,7325.69697,1241.444444,327.6060606,2595.393939,15085.47475,468.0606061,1891.121212,1768.222222,18949.58586,465.1515152,160.7474747,3789.181818,14474.34343,2563.434343,602.6666667,2815.777778,12136.68687,612.6969697,275.4444444,1152.59596,7733.858586,1157.69697,413.989899,1372.252525,4519.616162,1068.828283,153.9191919,3757.444444,4572.525253,1236.474747,251.4646465,3198.656566,971.0505051,840.0909091,99,12.93650659,10.08594463,0.626215783,0.942857143,0.642857143,0.090491877
+3980,30921.45783,1000.939759,553.9879518,1079.337349,27512.96386,737.5060241,642.1445783,1575.084337,14368.18072,606.8433735,1343.301205,1809.698795,18310.98795,1292.493976,4926.349398,3436.060241,6401.722892,1341.578313,314.746988,2479.168675,14153.92771,472.8433735,440.253012,871.2650602,16855.92771,945.5783133,125.686747,1873.759036,13203.75904,1716.843373,374.5542169,2797.73494,11700.21687,593.1686747,272.5180723,1134.060241,6920.433735,1371.963855,420.3373494,1298.542169,5321.253012,662.8313253,160.4819277,2526.578313,4700.409639,1274.180723,305.4939759,3541.048193,297.626506,838.5542169,83,11.20154759,9.629551594,0.510862215,0.954022989,0.754545455,1.000725259
+3981,28893.77381,826.0833333,543.1547619,1083.47619,26156.41667,691.297619,795.1904762,1555.440476,14752.66667,547.0119048,1454,1812.488095,18297.25,1468.833333,5170.22619,3461.404762,6595.619048,1403.75,317.5714286,2886.380952,14301.88095,428.047619,561.0595238,1021.154762,17692.15476,447.4761905,170.6904762,2047.119048,13457.75,2272.845238,624.9880952,2806.559524,11647.58333,757.3690476,284.9285714,1979.214286,8452.107143,1391.821429,427.2261905,1347.416667,6309.083333,743.3333333,171.4166667,5709.452381,5613.119048,1336.642857,296.0119048,3276.071429,553.8928571,838.7142857,84,13.32389709,8.339987942,0.779869543,0.865979381,0.646153846,1.372598662
+3982,35172.35526,898.5789474,581.3026316,1096.592105,30504.44737,739.6842105,712.2763158,1634.539474,17862.48684,548.7894737,743.2894737,1725.802632,20980.75,1335.078947,3445.763158,3137.868421,7696.828947,1315.736842,293.4736842,2379.631579,16451.46053,453.7105263,350.6052632,641.8947368,20030.60526,459.8289474,121.5,2059.421053,15233.15789,1644.289474,581.8684211,2805.697368,12990.85526,672.2236842,287.9342105,1698.868421,9272.263158,1055.368421,418.1184211,1308.157895,7113.407895,702.5263158,155.6315789,2902.276316,6005.697368,1391.407895,522.3421053,3337.026316,600.6184211,840.1052632,76,10.96389201,9.291866252,0.530800086,0.894117647,0.575757576,0.191453047
+3983,21689.9604,891.3168317,535.7821782,1062.366337,18824,645.2673267,404.9405941,1498.148515,10282.0099,547,421.7227723,1715.425743,13615.80198,1163.158416,3201.663366,2245.158416,5123.950495,1335.415842,291.009901,2265.188119,10082.09901,360.990099,761.1089109,507.2079208,12387.24752,407.5049505,122.0792079,2889.960396,9611.267327,1408.712871,474.8514851,2796.435644,8230.425743,740.7128713,249.039604,1209.049505,5592.792079,771.2772277,378.5643564,1301.732673,3604.60396,809.2772277,152.5445545,2485.60396,3548.376238,1174.39604,394.6633663,3272.910891,899.6534653,840.8217822,101,13.74226437,9.565191143,0.718001212,0.943925234,0.706293706,0.519230633
+3984,37110.79775,947.3820225,754.2359551,1147.735955,26140.38764,728.5,851.0449438,1701.331461,12375.16854,493.3595506,1945.02809,1770.932584,16890.22472,1145.606742,3795.308989,2345.882022,6604.157303,1253.831461,288.1235955,2705.247191,13156.12921,448.5505618,233.3595506,1357.308989,16383.20225,461.9325843,793.3876404,1594.550562,12635.25843,2096.865169,379.011236,2811.078652,10420.97191,636.7022472,259.6404494,914.511236,6190.747191,1006.157303,384.488764,1298.202247,3436.91573,600.0168539,151.0898876,1687.516854,3575.061798,1135.533708,382.9269663,3154.764045,1013.247191,841.1910112,178,22.12887811,12.45886209,0.826447546,0.763948498,0.551083591,1.240824027
+3985,24576.55556,928.5277778,988.75,1175.055556,23213.52778,735.7777778,921.0277778,1744.75,13248.5,574.9722222,568.4444444,1851.166667,16206.38889,1355.166667,777.3333333,1071.083333,5913.972222,1429.194444,319.6666667,2410.583333,13056.44444,511.5277778,153.3611111,532.8055556,16357.5,472.1944444,127.5833333,942.8611111,12344.77778,1624.888889,476.6666667,2819.111111,10563.55556,643.7777778,309.9444444,1672.583333,7403.861111,911.5,463.1388889,1335.416667,5779.333333,627.2222222,171.4722222,1047.611111,5327.472222,1418.638889,147.4444444,3407.777778,511.7222222,837.4444444,36,7.758807268,6.061285457,0.624263864,0.923076923,0.666666667,1.505355168
+3986,32254.57554,844.7841727,482.8561151,1068.223022,28496.6259,699.3884892,837.676259,1602.956835,17368.09353,558.1798561,1078.122302,1735.985612,20280.48921,1291.079137,3924.136691,3455.05036,7525.266187,1322.877698,302.2230216,2752.640288,16448.91367,418.1582734,308.3381295,1255.165468,20051.2518,430.2805755,119.6402878,1621,15663.82014,1743,655.352518,2785.863309,13852.82734,666.7482014,283.9496403,1323.079137,9900.251799,948.7913669,402.1654676,1312.755396,7307.201439,652.9856115,160.352518,2021.294964,6701.453237,1399.244604,589.6258993,3193.482014,610.971223,843.1079137,139,18.10521698,10.09601901,0.830089369,0.939189189,0.545098039,-0.690680971
+3987,18680.91608,883.4125874,560.3846154,1078.636364,16618.44056,704.8811189,831.7902098,1550.937063,9606.881119,531.5104895,1224.608392,1747.811189,12178.81119,1291.167832,2561.748252,1756.958042,4444.804196,1247.517483,288.4755245,2296.34965,9517.503497,439.1468531,107.2517483,931.5944056,11616.85315,705.4825175,119.958042,875.6223776,9058.048951,1327.72028,560.041958,2797.804196,8068.160839,617.4685315,265.3006993,1914.041958,5809.321678,1217.06993,391.6783217,1320.216783,4432.405594,644.8811189,158.8531469,2366.202797,4001.06993,1384.27972,2195.804196,3234.734266,647.3076923,842.8531469,143,14.72158324,12.53090308,0.524853423,0.966216216,0.6875,0.157116261
+3988,41362.78652,913.8426966,623.8426966,1148.280899,38232.57303,751.2696629,829.247191,1841.033708,18881.94382,541.1235955,1080.022472,1808.033708,26270.7191,1273.752809,3344.011236,4121.842697,9791.842697,1330.561798,326.4719101,2360.101124,19511.21348,458.7078652,168.6629213,1391.101124,24449.49438,884.7865169,142.3595506,3045.325843,19106.25843,1757.460674,481.6966292,2812.662921,15720.95506,1124.516854,286.5617978,1315.011236,9922.617978,1229.191011,434.5730337,1300.786517,5630.213483,623.1348315,165.6741573,2472.719101,5771.325843,1284.606742,542.2921348,3275.337079,992.1123596,839.494382,89,13.04097888,9.144288418,0.712968094,0.908163265,0.635714286,1.104690633
+3989,40244.34025,929.8506224,552.2572614,1122.3361,35519.09544,742.4522822,852.7842324,1760.950207,18648.77178,590.9626556,1418.80083,1814.688797,23791.0083,1335.742739,5521.522822,4850.452282,8730.526971,1394.103734,339.1161826,2471.182573,18869.02905,1924.879668,243.3070539,615.4564315,22860.94191,1873.041494,136.4315353,3366.087137,17974.76349,1604.282158,380.560166,2834.3361,15990.12448,654.5892116,323.4273859,1392.290456,9127.950207,1460.838174,458.7925311,1317.016598,6813.518672,675.7634855,179.4605809,5215.742739,6123.576763,1389.763485,415.3941909,3325.854772,283.2904564,842.7842324,241,24.69369813,13.1878381,0.845448582,0.892592593,0.662087912,-1.557711134
+3990,37314,960.3018868,860.5471698,1178.339623,31682.13208,766.2075472,836.1320755,1789.264151,19739.50943,592.4528302,461.3396226,1787.679245,23847.54717,1402.169811,1209.45283,1090.358491,8607.45283,1511.339623,363.9433962,2373.566038,18517.96226,480.2264151,178.2075472,462.1886792,23141.32075,478.9245283,135,1023.377358,18207.69811,1557.622642,462.3962264,2830.075472,15743.22642,969.3962264,329.6226415,1578.54717,10980.88679,883.8867925,476.4339623,1341.018868,8063.716981,661.8490566,178.3773585,1041.471698,7724,1488.301887,166.6603774,3299.660377,504.5660377,840.3207547,53,8.5290855,8.067586827,0.324483987,0.929824561,0.654320988,-0.73548984
+3991,19884.11047,904.5465116,809.3023256,1145.866279,18922.01163,723.5174419,762.3372093,1623.360465,10231.9593,558.5988372,556.5523256,1780.267442,12701.25581,1370.238372,705.7325581,884.6046512,4605.476744,1374.872093,329.2034884,2375.668605,10057.80814,480.9651163,202.2267442,510.3604651,12108.79651,523.3662791,129.6104651,829.8953488,9257.686047,1512.825581,530.2383721,2815.697674,8181.994186,662.7383721,288.8023256,1738.215116,5736.889535,888.9534884,451.3139535,1352.912791,4526.156977,643.3488372,169.244186,1351.215116,3864.505814,1425.744186,324.372093,3232.209302,519.0232558,844.1162791,172,16.74700099,14.46282947,0.504165374,0.873096447,0.530864198,1.047993708
+3992,29058.56701,896.0309278,645.8556701,1116.783505,26625.91753,748.1185567,905.6391753,1634.252577,15537.28866,602.0876289,1327.030928,1797.979381,19011.56701,1341.345361,2573.195876,2450.164948,6684.237113,1376.958763,322.4020619,2380.623711,14524.0567,462.2938144,417.1134021,1318.659794,17768.25773,654.0309278,217.7731959,1047.113402,13911.07732,1713.752577,593.0721649,2818.706186,12034.8299,1052.371134,302.7061856,1305.902062,8619.93299,1294.824742,447.3298969,1351.798969,6427.546392,696.0051546,171.1391753,2957.773196,5743.747423,1408.649485,458.9278351,3279.185567,567.371134,843.6958763,194,21.78793942,11.75847705,0.841871359,0.898148148,0.60625,-1.04981666
+3993,20161.00709,771.7234043,428.4539007,1054.808511,18378.55319,635.6666667,584.6028369,1500.48227,10545.88652,501.2269504,412.1489362,1724.801418,13018.26241,1185.397163,888.9503546,871.106383,4956.723404,1214.22695,281.3829787,2291.007092,10426.36879,395.9574468,104.5177305,463.3049645,12858.56028,513.8510638,110.1702128,1111.843972,9779.546099,1290.241135,542.2765957,2815.893617,8722.255319,634.070922,251.3971631,1740.234043,6414.113475,804.4042553,374.1631206,1315.368794,4777.716312,635.8297872,151.7943262,1997.035461,4341.092199,1308.156028,1380.141844,3161.971631,632.2765957,844.4326241,141,15.31925468,12.20491257,0.604369608,0.959183673,0.55952381,-0.218529111
+3994,20399.19598,857.7638191,848.3065327,1130.060302,18379.71357,686.3517588,781.7688442,1656.050251,10150.69347,659.7889447,807.9447236,1803.562814,13271.94975,1220.58794,1800.668342,2854.552764,4819.623116,1307.572864,296.0050251,2371.613065,9932.110553,429.0904523,446.3668342,1029.366834,12275.29146,707.3969849,119.1306533,1454.015075,9534.005025,1742.582915,704.8291457,2795.281407,8238.763819,658.8090452,268.9296482,1609.768844,5971.703518,1128.321608,409.4723618,1341.959799,4295.170854,739.8140704,158.6432161,2439.271357,4010.98995,1307.386935,218.0552764,3277.592965,767.798995,843.1407035,199,18.3527101,14.02022049,0.645296885,0.956730769,0.654605263,1.370191008
+3995,23652.75,836.8684211,484.9342105,1065.822368,21818.82895,677.7039474,580.9144737,1562.572368,12313.25658,520.5460526,953.2434211,1784.453947,15936.34211,1268.559211,1521.421053,1527.927632,5691.546053,1278.493421,312.5065789,2344.651316,12189.86184,473.0328947,139.75,849.125,14923.52632,685.4013158,117.5328947,775.1644737,11591.61842,1325.052632,542.4078947,2806.506579,10214.375,658.4013158,268.75,2070.690789,7471.611842,1137.506579,401.7828947,1328.5,5624.605263,1649.815789,153.8157895,1723.019737,5126.585526,1466.993421,2121.368421,3214.539474,686.1710526,844.7697368,152,20.00042848,10.34321846,0.855894876,0.888888889,0.527777778,-0.885682191
+3996,30072.3125,942.6125,842.35,1116.1875,27683.05,693.1625,802.95,1731.025,15695.5875,541.3875,700.6,1757.7125,20795.4125,1273.725,1443.725,1609.3125,7637.65,1339.175,321,2429.3625,15217.3,6458.55,121.825,642.2125,19233.9125,526.9,120.7,1094.5375,14765.525,1565.05,500.475,2826.1125,13071.4,2971.4875,278.6,1466.575,9373.525,1016.0625,406.3875,1325.0125,6919.9375,621.0375,157.6375,2137.1625,6442.2875,1373.6375,285.65,3301.1625,734.4375,842.55,80,12.62609916,8.653272209,0.728215679,0.879120879,0.512820513,-0.924257557
+3997,32886.86667,985.88,489.0266667,1066.44,28934.42667,719.6266667,826.4,1506.426667,16508.96,735.4933333,1840.08,1766.533333,20851.84,1254.653333,1619.693333,3121.773333,7424.24,1305.426667,334.4933333,2360.04,15851.98667,406.0666667,326.1466667,1732.466667,19737.8,1290.026667,122.6266667,997.1333333,14970.69333,1584.56,465.32,2802.52,13042.38667,804.56,278,1260.093333,9382.973333,1785.44,411.4933333,1335.213333,6397.693333,681.4533333,155.6666667,2432.013333,6123.653333,1304.266667,270.1066667,3379.76,806.3733333,843.76,75,11.52802403,9.217719397,0.600543198,0.882352941,0.568181818,0.626662352
+3998,28513.46429,879.1173469,679.0255102,1103.505102,26044.43878,698.627551,740.1734694,1676.47449,13632.90816,518.2653061,704.122449,1739.673469,18177.31122,1225.77551,4877.433673,3712.561224,6927.341837,1287.591837,305.0255102,2319.188776,14161.57143,424.6173469,493.0918367,708.1836735,17863.16837,487.5918367,136.4693878,4019.632653,13443.39286,1703.454082,472.9336735,2798.806122,11552.2449,661.0204082,288.2857143,1674.352041,7522.923469,923.5663265,415.9285714,1316.02551,4700.765306,721.744898,163.2142857,4630.326531,4657.94898,1318.061224,296.7602041,3255.545918,934.7959184,845.1479592,196,16.87995379,15.11349885,0.44535936,0.942307692,0.720588235,-1.147930144
+3999,28429.85714,829.6285714,565.8571429,1076.542857,17600.00952,543.7142857,692.4095238,1409.704762,7183.87619,434.0857143,1861.27619,1746.409524,11348.74286,1008.580952,5455.219048,3241.714286,4389.666667,1164.533333,243.9142857,2601.885714,8734.4,346.1714286,919.3142857,1591.933333,10889.41905,584.5238095,123.2952381,1390,8131.933333,2148.266667,401.3142857,2789.942857,6710.961905,541.1809524,225.4666667,821.7809524,3878.695238,1424.085714,350.1714286,1282.447619,2089.828571,773.7904762,142.5238095,2602.152381,2301.2,1005.695238,464.1428571,3035.619048,1043.971429,842.1142857,105,13.96003552,9.693401574,0.71962012,0.921052632,0.681818182,1.568768728
+4000,14118.34586,822.112782,457.7669173,1064.135338,13086.8797,680.481203,532.9398496,1577.616541,5896.609023,523.1729323,559.3157895,1787.706767,8302,1200.887218,4848.789474,1880.902256,3148.992481,1257.759398,387.2105263,2400.789474,6718.827068,404.9097744,2399.315789,592.1654135,8294.571429,439.8045113,122.0075188,2069.233083,6007.06015,1825.120301,293.6541353,2842.729323,5395.789474,915.8270677,262.037594,1124.609023,2717.12782,770.9172932,391.4661654,1361.706767,1958.473684,1355.541353,150.7744361,2486.887218,2024.992481,1237.150376,269.2255639,3195.639098,222.4511278,843.3759398,133,15.63494878,11.44128506,0.68154489,0.898648649,0.692708333,-1.382500165
+4001,39731.37624,901.0891089,567.0594059,1106.138614,35935.42574,739.6732673,633.7326733,1667.584158,20302.06931,577.2673267,737.8712871,1790.574257,24719.80198,1361.811881,2504.792079,3438.148515,9034.792079,1504.29703,335.3663366,2354.336634,19664.28713,2553.574257,305.4257426,655.009901,23517.56436,606.1980198,139.3762376,2252.168317,18537.38614,1694.623762,557.3564356,2833.118812,16361.13861,1077.772277,316.8811881,1594.425743,10720.9604,1219.316832,452.4158416,1315.217822,8011.019802,678.6336634,177.9306931,3109.168317,7342.277228,1452.435644,506.6633663,3303.683168,378.6633663,844.2079208,101,15.29645989,9.216246796,0.798112481,0.870689655,0.554945055,0.766219336
+4002,33128.76871,859.8061224,552.9251701,1090.908163,30036.94218,763.2823129,873.7176871,1643.646259,17337.92177,613.744898,1439.605442,1828.044218,21070.15986,1293.020408,3638.326531,3807.442177,7544.445578,1325.401361,306.5340136,2396.738095,16012.40816,427.7108844,490.0272109,1438.918367,20061.64966,892.5748299,248.7959184,2269.581633,15422.90476,1807.003401,700.6360544,2813.435374,13281.4966,847.4591837,286.9319728,1706.204082,9387.57483,1352.061224,425.1870748,1339.622449,7018.714286,735.1360544,161.6632653,4030.462585,6376.197279,1376.013605,402.3979592,3273.503401,589.9285714,847.9285714,294,25.56613122,14.9276763,0.811836498,0.939297125,0.636363636,0.941938924
+4003,35258.56757,904.8333333,568.0900901,1083.657658,31744.38739,715.8828829,671.8558559,1684.342342,16388.5045,614.8243243,1133.801802,1743.274775,22045,1328.162162,3886.247748,3654.945946,8106.337838,1277.184685,319.8198198,2316.936937,16723.83784,421.3918919,1295.738739,876.8063063,20857.25225,471.3423423,125.8873874,2770.995495,15988.73423,2001.378378,454.8558559,2813.698198,13589.13063,998.509009,282.3018018,1174.783784,8704.671171,1187.986486,414.2027027,1353.193694,5247.662162,913.1216216,160.9954955,4318.234234,5300.094595,1258.716216,654.8063063,3281.234234,949.2432432,847.8378378,222,20.55095805,13.98849847,0.732586646,0.936708861,0.621848739,-0.498852663
+4004,25804.04839,913.1129032,643.3145161,1123.217742,16990.84677,551.4596774,411.5483871,1394.693548,7841.58871,461.7016129,537.1774194,1693.5,10757.34677,1055.677419,5086.354839,1770.935484,4182.475806,1127.177419,253.6693548,2362.08871,8482.927419,1736.846774,705.516129,449.6129032,10295.73387,384.1532258,111.75,3077.104839,7626.806452,1350.266129,346.1693548,2788.145161,6825.580645,528.7822581,232.7096774,1003.16129,3507.370968,715.3306452,367.5645161,1285.629032,2558.959677,732.6774194,140.6370968,1781.443548,2395.677419,1070.620968,175.0887097,3210.233871,236.2903226,845.8306452,124,14.01238783,12.58418151,0.439841432,0.832214765,0.635897436,-0.67948223
+4005,19161.41667,901.7708333,620.1979167,1071.520833,18343.64583,642.03125,574.8229167,1535.052083,8837.28125,502.5520833,598.1979167,1773.395833,12097.1875,1205.822917,9587.083333,3526.177083,4437.364583,1251.40625,306.4895833,2307.354167,9318.010417,361.6770833,798.3541667,510.2916667,11575.44792,423.8645833,125.6875,8966.9375,8541.208333,1682.364583,466.84375,2804.479167,7463.916667,679.1458333,264.7708333,1409.791667,4224.53125,833.4791667,417.6875,1378.947917,3167.75,759.09375,160.5833333,6628.15625,2939.395833,1230.791667,370.0833333,3218.104167,260.5208333,844.0520833,96,12.64060324,10.13236411,0.597897147,0.923076923,0.615384615,-0.875193065
+4006,42367.52,851.96,531.9,1128.42,37906.5,715.18,925.7,1820.52,19462.74,532.78,1514.7,1802.44,26473.96,1236.8,3567.12,2754.48,9857.52,1308.68,328.76,2423.54,20197.9,436.08,161.28,2115.88,25548.64,517.22,195.34,1549.1,19649.72,2215.46,409.06,2800.44,16342.98,645.24,292.28,969.38,10367.12,1161.94,432.28,1297.64,5897.48,618.02,158.92,1370.64,6106,1280.64,223.86,3238.38,985.52,845.18,50,10.18467056,7.237933798,0.703526113,0.909090909,0.505050505,-0.468933272
+4007,26368.28931,884.1698113,494.1320755,1069.125786,23966.0566,748.245283,840.2704403,1583.188679,13151.14465,576.7861635,1225.163522,1779.333333,15573.77987,1293.358491,2766.91195,2572.943396,5787.72956,1347.062893,337.1194969,2435.113208,12701.00629,388.3207547,1491.515723,1504.515723,15368.30189,556.3459119,260.2830189,1661.025157,11401.69811,1747.100629,440.3647799,2828.849057,10314.15723,666.2767296,299.1320755,1632.949686,6602.377358,1130.207547,431.7044025,1372.496855,4974.031447,941.9622642,176.4465409,3748.503145,4498.63522,1438.924528,3441.18239,3260.666667,346.6477987,848.0943396,159,17.51636579,12.01595322,0.727616272,0.908571429,0.6625,-0.898070732
+4008,29622.78226,888.4919355,626.8709677,1101.112903,27183.78226,711.6370968,941.0887097,1627.919355,15008.22581,562.5887097,2433.830645,1842.766129,18489.04839,1279.403226,3381.959677,5532.201613,6783.870968,1383.080645,325.9032258,2455.572581,15078.07258,410.9193548,375.7419355,2070.193548,17635.04032,952.3951613,254.3145161,2900.927419,13906.65323,2064.774194,471.9274194,2822.66129,12470.21774,674.8870968,304.6532258,1958.927419,8283.629032,2073.330645,452.016129,1322.669355,6284.266129,696.9919355,175.0322581,5657.903226,5514.822581,1387.322581,978.0403226,3254.274194,365.9677419,846.7096774,124,18.18949783,9.53953513,0.851439453,0.843537415,0.593301435,1.512652545
+4009,19248.25926,846.25,602.3240741,1095.157407,17787.07407,688.5462963,678.7962963,1576.092593,10221.42593,551.2592593,459.9444444,1742.62037,12628.90741,1258.675926,925.25,891.7962963,4734.953704,1372.833333,311.1944444,2323.759259,10241.63889,409.9537037,274.5277778,459.6574074,12338.71296,443.0277778,124.1481481,857.6666667,9429.796296,1417.009259,458.8611111,2867.675926,8440.87963,1352.018519,280.6111111,1633.768519,5985.027778,830.5092593,432.0555556,1329.87037,4544.564815,652.7592593,164.9351852,1275.240741,4168.583333,1376.518519,467.2314815,3328.37037,494.2962963,846.2962963,108,17.30110284,8.98205587,0.854676532,0.812030075,0.5,-1.361110867
+4010,28259.57778,995.3444444,580.2888889,1074.933333,24836.58889,722.5222222,519.8555556,1510.311111,14152.88889,590.2888889,435.4,1694.966667,18097.62222,1291.1,2238.866667,2430.688889,6464.944444,1250.922222,292.4777778,2297.4,13125.48889,609.4777778,154.6111111,494.8444444,16123.37778,409.7888889,114.9111111,1648.633333,12627.43333,1379.855556,561.5,2770.611111,11072.85556,900.9,269.6333333,1337.755556,7856.333333,843.2888889,392.8111111,1286.933333,5569.411111,589.2555556,154.5555556,2068.955556,5209.222222,1294.233333,1259.122222,3360.644444,743.9666667,846.9666667,90,11.39733361,10.21647405,0.443263025,0.947368421,0.629370629,0.111676553
+4011,28089.6092,952.8103448,503.9252874,1061.954023,25063.87931,721.4885057,908.0344828,1539.344828,14106.83333,550.4827586,2006.752874,1777.522989,17775.24713,1254.844828,3149.017241,4362.333333,6545.022989,1255.270115,301.7528736,2631.522989,13301.16667,388.2701149,108.7471264,1748.344828,16458.05747,902.5172414,200.9885057,1287.965517,12418.82759,1958.965517,469.7298851,2792.896552,10682.52874,642.5747126,267.3793103,1268.988506,7511.097701,1858.735632,401.2701149,1299.33908,5179.097701,589.8218391,156.1724138,2677.982759,4767.057471,1262.488506,437.4252874,3374.074713,824.8275862,848.8045977,174,23.20587138,10.21092872,0.897990482,0.87,0.50877193,-0.952323302
+4012,30065.71287,871.3069307,658.3465347,1096.772277,26182.32673,697.6534653,870.2376238,1674.019802,14628.73267,526.4059406,862.029703,1761.673267,19593.9802,1249.376238,3510.118812,3060.069307,7155.188119,1300.940594,312.5841584,2354.881188,14640.27723,422.6732673,829.2970297,818.9009901,18454.26733,574.8514851,174.3465347,2796.792079,14005.51485,1846.534653,500.4257426,2807.584158,12041.82178,1362.445545,283.8415842,1391.188119,8353.881188,932.1386139,429.8019802,1327.871287,5407.613861,879.7326733,161.2574257,3885.178218,5301.851485,1335.029703,335.5841584,3267,884.1089109,846.1485149,101,12.76019328,10.23104978,0.597600165,0.952830189,0.706293706,1.564349422
+4013,40062.98413,851.7777778,505.5873016,1082.079365,36266.36508,711.4603175,1072.746032,1689.650794,18422.06349,530.6349206,2081.984127,1764.571429,24861.25397,1220.888889,3478.984127,3976.793651,9412.063492,1325.095238,329.3492063,2722.253968,19093.46032,449.5873016,159.6190476,2736.84127,23985.26984,464.6190476,539.1746032,2572.428571,18401.88889,2633.285714,462.5238095,2803.095238,15433.38095,614.6031746,292.7777778,1065.079365,9654.968254,1421.873016,419,1292.904762,5626,607.1904762,160.4126984,3085,5659.825397,1249.809524,301.6031746,3175.587302,978.3333333,845.4285714,63,11.30524754,7.545537906,0.744666474,0.926470588,0.63,-0.532047797
+4014,17151.85915,889.7887324,633.0985915,1080.295775,16984.74648,710.5070423,1188.126761,1553.422535,9232.169014,592.3802817,2002.704225,1854.352113,11452.67606,1249.774648,5326.647887,4190.859155,4301.070423,1270.746479,282.1690141,2430.450704,9114.521127,393.1408451,2645.211268,1696.591549,10652.46479,1172.028169,279.5492958,1300.802817,8185.929577,2363.464789,766.5492958,2804.070423,7368.633803,819.3098592,267.7464789,1487.859155,5317.943662,1438.690141,421.6197183,1392.873239,4107.43662,1256.492958,170.4507042,8547.380282,3365.084507,1269.478873,488.8591549,3233.71831,545.4225352,847.9014085,71,13.45356137,7.361166263,0.837032137,0.835294118,0.606837607,-0.27287108
+4015,13523.352,729.184,456.864,1038.672,12664.424,589.24,533.104,1423.112,7057.768,472.984,429.312,1751.256,9459.232,1138.944,1154.872,792.112,3547.064,1199.168,279.856,2285.312,7162.368,377.608,100.488,508.544,8701.984,527.352,108.928,821.912,7003.08,1249.296,526.976,2835.272,6159.088,618.16,235.12,2041.84,4550.28,765.008,373.984,1314.344,3414.288,679.504,150.832,2016.4,3229.072,1305.928,4608.52,3202.424,696.616,849.28,125,12.78041045,12.66267795,0.135421712,0.961538462,0.686813187,1.421597127
+4016,27724.07273,818.1545455,517.7272727,1053.318182,25438.64545,697.3090909,1120.890909,1588.518182,12814.39091,585.0181818,1818.036364,1806.6,17041.35455,1179.154545,5567.036364,3362.209091,6331.045455,1219.209091,291.0727273,2675.345455,13110.25455,507.2,1581.536364,1582.9,16420.69091,428.0727273,145.1727273,2461.854545,12695.40909,2300.390909,426.8272727,2817.890909,10657.11818,673.4636364,266.0181818,1053.945455,6829.354545,1340.309091,385.4454545,1337.5,4025.381818,979.9909091,157.2545455,4674.4,4174.318182,1182.436364,491.9545455,3200.554545,961.5454545,848.4909091,110,14.39904601,10.14335444,0.709757307,0.94017094,0.705128205,-0.46418441
+4017,19292.64894,1077.446809,626.7021277,1060.510638,16940.91489,727.6702128,496.3510638,1527.457447,9576.446809,595.3617021,607.9255319,1718.117021,11567.70213,1265.670213,1598.393617,1681.042553,4130.223404,1741.755319,288.0319149,2285.851064,9002.489362,364.5851064,325.2021277,565.4574468,11067.04255,422.8297872,120.0744681,2222.734043,8964.553191,1503.744681,484.5425532,2869.617021,7826.340426,634.5425532,271.6170213,1198.202128,5337.819149,830.3297872,420.0425532,1324.382979,3957.457447,673.2446809,161.9574468,3001.276596,3704.851064,1263.489362,213.6914894,3785.457447,412.1382979,847.7021277,94,12.10100896,10.55530116,0.489031357,0.903846154,0.657342657,-1.015950147
+4018,38342.56164,948.9109589,761.8219178,1139.917808,35288.19178,746.0821918,929.1643836,1705.643836,20033.74658,599.0068493,1315.69863,1783.253425,24298.23973,1342.678082,3032.90411,4938.315068,8844.849315,1443.979452,340.8767123,2489.424658,19026.9726,501.1438356,760.9109589,1169.013699,23345.68493,1221.623288,157.7534247,2264.150685,17990.47945,1717.616438,538.5342466,2828.636986,15722.97945,633.1369863,320.7328767,1560.410959,10742.08904,1341.60274,470.8561644,1359.979452,8149.30137,784.6438356,174.1780822,2830.075342,7237.267123,1447.150685,296.8424658,3295.90411,460.3424658,849.1986301,146,17.41347195,12.86878676,0.673690874,0.789189189,0.506944444,-0.945649949
+4019,32075.89286,917.8035714,591.1785714,1125.785714,28690,782.6428571,868.8392857,1644.125,16721.85714,623.4642857,1752.339286,1826.178571,20638.42857,1319.75,3732.982143,3871.982143,7160.785714,1365.553571,325.8392857,2521.5,15691.51786,442.6607143,1217.428571,1509.089286,18779.80357,463.6964286,517.0535714,1592.017857,15086.01786,2146.160714,610.0892857,2839.553571,13181.14286,746.875,306.75,1566.821429,9249.303571,1186.642857,440.0535714,1367.303571,6788.839286,890.5535714,172.9642857,5416,6091.339286,1403.446429,470.125,3295.160714,553.5178571,846.875,56,9.13002961,8.286927752,0.419714508,0.903225806,0.777777778,0.822958016
+4020,17106.07087,844.480315,445.8503937,1025.023622,15271.38583,661.2755906,621.8503937,1461.826772,8640.165354,836.2992126,456.4645669,1714.574803,11008.08661,1242.866142,2688.070866,1439.826772,4056.527559,1386.299213,308.0708661,2381.330709,8602.244094,401.2125984,529.519685,506.015748,10417.90551,424.7874016,114.8346457,968.488189,8056.007874,1631.165354,630.2755906,2784.622047,7106.76378,806.3700787,250.7637795,1381.362205,5167.598425,771.1181102,379.992126,1323.952756,3988.346457,715.2834646,151.3700787,1885.338583,3525.023622,1391.685039,6563.535433,3167.944882,616.1181102,851.4488189,127,17.88118076,9.542189485,0.845709053,0.894366197,0.533613445,-0.518941633
+4021,23995.85882,945.8941176,526.7294118,1050.917647,21277.58824,693.2,479,1511.588235,11526.14118,542.2705882,456.2823529,1696.741176,14827.25882,1221.882353,3666.694118,2632.541176,5547.258824,1203.576471,281.0117647,2316.576471,11279.95294,415.7294118,150.2235294,584.4,13899.25882,427.0470588,118,2667.423529,10387.65882,1390.858824,488.8705882,2789.058824,8962.494118,590.5294118,257.4588235,1990.847059,6298.835294,785.1058824,384.5294118,1305.894118,4315.976471,593.8705882,153.7647059,3589.447059,3983.282353,1180.576471,158.5647059,3373.952941,848.4588235,848.4588235,85,13.92077149,8.055263928,0.815575494,0.923913043,0.544871795,0.805848254
+4022,39844.73427,1003.615385,613.1678322,1139.559441,32969.16084,776.6643357,813.7272727,1700.797203,18612.8951,571.1538462,1464.062937,1799.727273,24139.18881,1314.86014,3018.062937,3497.937063,8750.846154,1369.041958,321.8321678,2346.713287,18082.71329,428.2937063,208.951049,1643.090909,23138.36364,603.7692308,445.6503497,1961.237762,17038.46154,2191.545455,472.3566434,2809.93007,14780.61538,686.5244755,292.2307692,1294.636364,10337.7972,1159.377622,433.4545455,1309.440559,6666.552448,663.4125874,169.0979021,2344.426573,6287.671329,1324.202797,357.4265734,3347.804196,868.6153846,848.9090909,143,18.95079239,10.1011241,0.846103547,0.89375,0.578947368,-1.05150816
+4023,30575.67143,914.6285714,717.1571429,1119.157143,25499.47143,689.0142857,691.3285714,1668.114286,12616.65714,542.8428571,544.1285714,1767.257143,16582.18571,1220.542857,7789.157143,5562.057143,6252.457143,1301.228571,307.2142857,2309.685714,13222.3,388.8714286,610.7428571,475.9714286,15926.85714,493.9428571,130.2571429,8470.071429,12295.47143,1499.042857,409.3714286,2801.871429,10749.07143,675.4714286,288.0857143,1910.514286,5905.885714,826.3714286,423.4571429,1295.057143,4385.471429,780.8,170.1857143,6519.071429,3997.171429,1300.242857,887.1571429,3267.771429,269.4714286,849.2571429,70,10.80191829,8.556808365,0.610318186,0.95890411,0.53030303,0.957238627
+4024,17502.11712,955.981982,1314.954955,1191.765766,15845.79279,709.7387387,1024.36036,1798.432432,8963.054054,600.990991,687.9369369,1766.54955,11165.54054,1263.387387,1814.279279,1274.783784,3991.072072,1421.162162,307.9459459,2560.873874,8729.558559,551.3513514,769.6306306,526.4954955,10623.20721,492.6936937,129.5675676,873.9009009,8103.837838,1610.63964,460.5945946,2827.558559,7200.054054,953.3063063,296.1621622,1757.027027,5045.243243,888.3693694,453.5945946,1382.288288,3768.081081,777.7567568,167.3513514,1749.315315,3472.243243,1365.747748,419.3063063,3341.162162,478.3873874,850.4054054,111,13.0135937,11.26396377,0.500816181,0.948717949,0.656804734,0.863057001
+4025,30193.63492,938.0952381,759.047619,1119.269841,26949.53968,759.6507937,792.9206349,1606.174603,16362.26984,618.7460317,496.4761905,1755.238095,20311.65079,1385.809524,1042.52381,1097.142857,7109.047619,1511,352.4126984,2354.031746,15539.33333,460.3968254,676.2539683,458.0952381,19512.73016,478.2380952,136.2857143,907.6349206,15041.07937,1567.31746,471.1111111,2825.904762,13162.49206,691,307.1904762,1526.761905,9171.539683,861.5238095,464.7460317,1379.285714,6902.206349,773.6190476,175.1111111,1784.984127,6572.238095,1510.190476,244.0634921,3316.571429,507.4444444,849.3809524,63,10.83666016,7.709313429,0.702776744,0.926470588,0.583333333,-0.082105853
+4026,32111.875,909.9545455,809.2840909,1112.318182,28342.53409,775.7159091,1164.659091,1667.318182,16800.11364,574.5568182,2167.965909,1965.147727,20443.52273,1367.840909,2879.113636,3598.954545,7217.522727,1468.897727,330.3863636,2476.511364,15619.59091,453.9545455,572.2727273,1852.806818,19142.78409,611.3977273,301.5454545,873.5454545,15289.26136,2194.329545,611.4318182,2817.772727,13154.54545,680.6477273,306.5454545,1337.431818,9375.454545,1699.875,454.5113636,1350.454545,7014.829545,720.6022727,168.0340909,4155.022727,6113.079545,1424.806818,338,3293.340909,536.8068182,848.5909091,88,11.77021095,10.3135425,0.481872958,0.956521739,0.666666667,0.695738541
+4027,27581.69919,976.7479675,610.3252033,1100.617886,24237.46341,730.3821138,836.6260163,1633.95935,13792,566.8536585,1138.910569,1755.495935,16892.13821,1305.504065,1980.154472,2627.715447,6181.495935,1359.325203,304.6910569,2283.455285,12737.43089,422.0569106,120.5284553,1042.365854,15559.07317,468.5934959,315.2520325,1661.699187,12135.0813,1653.504065,560.097561,2798.081301,10503.81301,652.0325203,283.9186992,1491.300813,7459.471545,1053.162602,416.0731707,1299.658537,5135.796748,660.0731707,158.1463415,1682.03252,4849.398374,1357.065041,273.4796748,3298.569106,781.6422764,850.4390244,123,13.7745286,11.52978329,0.547147045,0.938931298,0.788461538,0.154310266
+4028,22095.125,1037.568182,524.0227273,1061.886364,19964.30682,745.375,783.5,1530.965909,9893.431818,611.375,1465.352273,1763.420455,12796.05682,1294.522727,4567.988636,3509.715909,4441.647727,1287.340909,312.0568182,2417.727273,9802.988636,512.8977273,256.1931818,1293.988636,11574.25,672.0795455,116.3068182,1592.215909,8898.227273,2218.715909,329.9772727,2791.920455,7815.113636,583.75,276.0227273,1193.784091,4534.261364,2073.420455,412.1363636,1304.522727,3483.215909,626.1022727,167,2253.272727,3062.295455,1296.75,3808.897727,3312.511364,299.0113636,850.375,88,12.72769019,8.910117845,0.714086256,0.967032967,0.676923077,0.428225544
+4029,38521.94375,860.56875,543.1,1102.5625,33976.7625,705.9,934.95,1638.88125,19214.075,536.2625,1774.85625,1757.89375,24410.43125,1277.35625,2297.85625,3864.8375,9023.90625,1321.525,310.6,2356.95625,18676.15625,418.5,115.73125,1812.675,23140.43125,1964.575,138.375,1630.45,17782.95625,1584.83125,550.6125,2812.3125,15491.4,614.65625,286.75625,1397.225,11060.31875,2008.9625,426.83125,1316.61875,7524.7625,617.225,162.75,2853.81875,7076.83125,1365.6875,202.86875,3273.8,795.84375,850.875,160,18.46162136,12.08420092,0.756011837,0.855614973,0.672268908,1.035297493
+4030,39028.74419,941.744186,1077.930233,1205.895349,34085.38372,734.2209302,1094.895349,1997.313953,16634.13953,544.1744186,1651.5,1823.639535,22734.0814,1282.244186,2882.232558,2791.372093,8530.581395,1310,321.244186,2538.244186,17337.4186,495.4534884,175.6976744,1173.988372,21532.83721,638.244186,130.1162791,1447.872093,16617.98837,2169.395349,405.5348837,2806.267442,13704.9186,797.244186,285.3023256,1182.94186,8457.197674,1230.395349,426.0581395,1315.255814,4786.348837,598.7209302,160.4186047,1887.906977,4878.546512,1271.686047,402.9534884,3317.453488,990.4186047,850.7674419,86,13.21146722,9.312269123,0.709343863,0.843137255,0.558441558,-1.154365344
+4031,28926.86047,799.0697674,541.8139535,1081.895349,25235.83721,635.7906977,491.8023256,1736.197674,12130.13953,1004.732558,665.6860465,1739.988372,16899.80233,1152.337209,6475.418605,3243.488372,6417.697674,1249,349.5697674,2303.290698,12886.65116,395.7325581,1687.802326,715.2790698,16173.22093,890.9418605,126.6860465,2444,12549.5814,1705.104651,428.6860465,2789.151163,10226.59302,657.372093,263.9651163,1498.813953,6259.511628,942.9418605,385.3837209,1343.767442,3496.162791,1081.686047,157.6046512,4710.848837,3652.813953,1179.802326,407.1860465,3254.906977,1000.604651,850.2209302,86,12.42953784,8.891682885,0.698748782,0.955555556,0.716666667,0.349724753
+4032,19607.64286,932.702381,642.9880952,1075.535714,15032.95238,603.4404762,625.297619,1479.392857,7018.011905,788.9761905,583.4761905,1727.595238,9831.571429,1047.130952,4941.785714,1988.52381,3874.857143,1238.059524,333.6190476,2290.261905,7657.404762,367.3690476,1947.5,588.7619048,9526.785714,409.7619048,145.797619,1213.47619,7462.238095,1731.857143,462.5595238,2797.702381,6253.178571,609.3452381,233.6547619,899.297619,3783.690476,725.75,361.6190476,1311.904762,2134.488095,1203.380952,137.6785714,1912.916667,2290.892857,1074.178571,212.0119048,3109.77381,1009.928571,849.3928571,84,12.01740619,9.272718533,0.636099167,0.976744186,0.636363636,0.774861763
+4033,38775.4625,843.85,566.3,1094.95,30683.9875,767.7625,924.225,1777.2875,13795.525,501.6,2877.825,1796.525,19012.5375,1159.2625,5325.4875,2473.7625,7546.4625,1289.425,291.425,2476.2875,15354.5375,429.5875,427.4375,1381.6125,19291.525,450.125,1615.2625,2224.75,14596.8875,2206.4875,381.675,2805.8125,12043.7375,668.7875,283.475,981.4625,6646.65,1068.675,395.7125,1306.7625,3542.8125,672.1125,156.1375,2724.325,3862.5125,1143.4,922.925,3172.0125,1034.3125,850.075,80,13.81179534,7.809085063,0.824822015,0.898876404,0.571428571,-1.260128565
+4034,13806.74586,813.2209945,493.0552486,1049.370166,12613.62983,651.359116,610.2651934,1453.834254,6763.458564,508.2430939,862.8674033,1736.563536,8089.154696,1188.944751,1233.441989,1562.756906,3105.127072,1287.524862,295.4088398,2291.309392,6887.099448,364.9171271,543.7348066,598.5856354,8299.171271,474.0110497,122.8729282,958.0607735,6292.497238,1500.430939,400,2820.314917,5850.276243,589.0165746,267.4585635,1446.303867,3709.088398,1262.314917,413.5248619,1326.248619,2831.436464,680.9944751,170.5911602,2941.668508,2715.171271,1350.596685,5706.060773,3205.618785,332.2486188,853.2486188,181,15.98287083,14.63159904,0.402420353,0.937823834,0.709803922,0.978181244
+4035,24168.16514,873.0458716,544.3669725,1098.201835,21919.66055,710.3302752,695.4220183,1592.798165,12061.6055,563.1284404,1277.724771,1723.990826,14462.07339,1275.348624,2830.93578,3190.633028,5452.853211,1420.917431,313.2568807,2516.642202,11561.9633,406.3669725,580.0642202,786.4036697,13989.89908,451.2293578,130.3486239,1940.605505,10784.61468,1871.853211,573.4495413,2821.944954,9647.605505,1064.357798,294.0275229,1814.082569,6418.779817,1332.853211,435.8256881,1325.055046,4821.055046,729.5412844,171.7706422,4192.550459,4410.155963,1393.110092,3136.559633,3214.018349,390.2201835,851.7431193,109,14.28273082,10.01867953,0.71271467,0.908333333,0.598901099,-0.87074148
+4036,24461.12583,841.8543046,473.794702,1057.02649,21524.62914,673.5629139,843.3178808,1512.556291,12536.72848,568.4966887,1919.92053,1748.423841,15869.07285,1215.589404,3378.754967,3398.589404,6010.039735,1255.900662,297.0794702,3309.192053,11930.80795,588.6490066,235.1456954,1824.754967,14668.50331,884.3311258,118.0463576,1224.927152,11537.57616,1884.84106,543.4503311,2790.225166,10072.74834,630.4635762,263.794702,1426.417219,7195.860927,1438,391.8874172,1341.86755,5355.377483,639.5298013,156.1456954,3610.178808,4803.384106,1297.582781,1217.589404,3233.960265,719.9470199,855.5099338,151,16.80107867,12.01909827,0.698739109,0.909638554,0.599206349,-0.013779848
+4037,16040.28462,833.3615385,604.8846154,1069.661538,14064.59231,671.5230769,623.2076923,1492.630769,8042.976923,519.8923077,501.7153846,1743.892308,9896.992308,1194.684615,2045.046154,2008.930769,3647.830769,1698.346154,294.6153846,2307.2,7953.276923,375.8846154,2074,484.1153846,9634.807692,421.0769231,120.6769231,1499.753846,7523.284615,1578.276923,607.5153846,2862.992308,6664.815385,778.8307692,261.2461538,1621.053846,4556.930769,839.0538462,414.5538462,1339.415385,3429.446154,1142,169.1230769,5272.246154,3192.623077,1311.276923,1323.030769,3222.138462,438.3538462,854.4,130,15.36506802,10.82862242,0.709449867,0.977443609,0.738636364,-0.185929967
+4038,32644.47297,1017.527027,904.7432432,1139.418919,29174.98649,782.5405405,921.0675676,1650.013514,16426.63514,606.1351351,1441.378378,1797.540541,20194.55405,1347.459459,2105.067568,2100.77027,6851.72973,1433.716216,322.5,2415.378378,14915.95946,463.8918919,416.5135135,996.3378378,18156.60811,544.1081081,372.7432432,1036.202703,14076.37838,1929.878378,458.3918919,2825.540541,12163.75676,706.5,299.2702703,1435.432432,8276.013514,1279.797297,443.2837838,1333.648649,6147.459459,703.0675676,167.8243243,1501.22973,5285.702703,1354.189189,406.1351351,3380.445946,468.2432432,853.2297297,74,11.97974691,8.066780893,0.739307267,0.936708861,0.632478632,-0.428590199
+4039,23705.9125,823.8125,441.975,1068.4625,21082.95,651.0375,622.6625,1544.3,12423.675,508.6875,623.4375,1746.7,15864.4125,1235.5375,935.3625,1139.1375,5869.9875,1245.5875,275.925,2277.3125,12467.4,402.975,105.8375,670.65,15411.2,563.9125,115.4875,848.975,11848.0125,1360.725,506.7,2825.1125,10459.2625,619.9625,265.45,1629.7625,7622.2625,1082.8125,393.55,1310.8375,5756.6625,626.0125,151.6625,1850.2375,5291.6125,1375.4875,2282.4375,3228.1625,638.25,852.4375,80,13.46347695,7.724784045,0.819024547,0.963855422,0.555555556,-0.740361398
+4040,25448.25275,906.0879121,616.8021978,1080.32967,24038.49451,695.7802198,1084.307692,1563.076923,13096.01099,534.1758242,1190.912088,1809.791209,16792.69231,1253.472527,2154.791209,4480.417582,6431.208791,1279.120879,296.3846154,2581.285714,12674.46154,745.4835165,106.8241758,1487.087912,16048.46154,591.3406593,141.3516484,1577.593407,11973.63736,1833.417582,591.5824176,2792.758242,10670.95604,1625.868132,278.2527473,1548.153846,7714.186813,1358.494505,410.3846154,1319.659341,5596.10989,594.4615385,155.9010989,2574.164835,4977.043956,1334.296703,1775.923077,3205.241758,736.6703297,853.2307692,91,12.40072528,10.52178427,0.529225262,0.842592593,0.631944444,0.557005009
+4041,35189.84722,973.875,569.0694444,1088.25,30080.44444,717.4305556,626.8194444,1590.513889,17483.83333,554.0416667,561.2916667,1707.694444,22022.08333,1244.736111,2534.166667,3223.611111,7883.541667,1250.430556,292.7638889,2316.625,16403.69444,399.5833333,125.9027778,672.3055556,20065.06944,679.1666667,122.8194444,2342.458333,15508.30556,1564.791667,578.3888889,2793.527778,13524.77778,582.4861111,275.3472222,1445.958333,9415.569444,888.7916667,403.0833333,1303.458333,6150.833333,601.0555556,157.8888889,1937.125,5774.541667,1257.666667,146.4305556,3450.444444,842.0416667,852.4166667,72,13.26437343,7.033709133,0.847828368,0.96,0.6,0.597734886
+4042,27897.18269,994.125,895.4326923,1123.788462,24286.92308,682.3557692,690.6153846,1702.903846,13246.31731,572.5,509.2980769,1749.586538,16533.875,1237.134615,2568.759615,2883.019231,6196.019231,1433.644231,326.4615385,2325.855769,12603.51923,418.9615385,639.5769231,519.0096154,15996.625,611.0288462,127.1634615,2000.346154,11932.26923,1540.644231,499.0480769,2786.576923,10244.46154,1171.634615,271.0769231,1172.326923,6895.182692,844.4903846,408.7019231,1330.778846,4331.798077,812.0288462,153.9711538,2611.009615,4254.432692,1248.048077,422.5192308,3435.394231,904.0192308,851.9807692,104,13.26763297,10.27115098,0.633001003,0.936936937,0.619047619,-0.942851199
+4043,22092.18605,921.872093,564.1860465,1083.162791,17044.82558,580.755814,396.5232558,1519.767442,8377.244186,471.3488372,850.872093,1768.860465,11478.56977,1108.883721,3394,1516.895349,4333.360465,1204.430233,304.2093023,2316.616279,9112.802326,475.0348837,787.8255814,565.6976744,11332.56977,439.1627907,115.244186,1781.5,8554.302326,1484.069767,308.0232558,2857.034884,7629.325581,778.1860465,255.8255814,999.1395349,3943.825581,882.244186,395.5,1362.465116,2865.348837,738.627907,156.872093,3760.011628,2762.406977,1182.895349,183.5581395,3156.662791,241.7674419,854.9651163,86,14.48438834,7.983501511,0.834386533,0.924731183,0.521212121,-0.475876897
+4044,20116.2619,836.6964286,548.6547619,1087.613095,18508.88095,664.3095238,523.0595238,1667.238095,9018.47619,518.2738095,536.7142857,1795.053571,12326.20833,1218.035714,4568.702381,2299.845238,4634.446429,1290,367.702381,2286.529762,9745.970238,3740.505952,1364.809524,536.8511905,11878.8631,459.1785714,125.3630952,4581.97619,8957.964286,1643.297619,409.0238095,2839.065476,7985.089286,758.3869048,275.1428571,1268.261905,4262.422619,821.577381,403.0178571,1365.678571,3089.964286,931.827381,162.7916667,4430.785714,2882.178571,1248.678571,473.0416667,3259,251.2738095,856.7380952,168,21.62701196,10.17345127,0.882450723,0.933333333,0.552631579,-0.547011781
+4045,19705.48739,1150.848739,632.7394958,1060.10084,14450.13445,578.7226891,507.3781513,1410.798319,7240.403361,484.7983193,814.4033613,1770.058824,9813.747899,1109.932773,6497.840336,2692.310924,3845.168067,1159.411765,264.9579832,2290.12605,8110.588235,905.4789916,183.6806723,470.907563,9245.067227,1147.243697,111.2605042,4050.10084,7235.067227,1343.663866,351.3529412,2810.02521,6619.02521,590.5294118,245.8151261,1334.285714,3811.638655,1131.806723,385.2016807,1284.277311,2927.689076,601.4369748,153.8823529,5630.890756,2559.411765,1141.487395,252.8403361,3277.411765,282.5966387,852.7394958,119,20.37495293,8.520613789,0.908359302,0.804054054,0.495833333,-1.41294287
+4046,27636.58559,893.7837838,652.4234234,1079.693694,24454.79279,695.0540541,598.3873874,1561.702703,13785.54054,552.3783784,580.0540541,1756.234234,16898.3964,1253.774775,2538.918919,2586.630631,6114.342342,1766.990991,307.8738739,2335.927928,13023.9009,393.2342342,1648.612613,493.2072072,15951.37838,437.4504505,123.6036036,1679.045045,12612.04505,1650.927928,630.2432432,2818.783784,11108.41441,674.3963964,291.7297297,1496.648649,7474.945946,930.8108108,436.963964,1365.126126,5546.801802,1140.189189,167.5315315,5268.576577,5127.315315,1372.144144,279.5945946,3292.567568,425.8918919,853.4234234,111,13.35167583,11.47231857,0.511569597,0.888,0.776223776,-1.561777261
+4047,25113.80488,895.4552846,733.1788618,1118.00813,23173.20325,735.6422764,1066.414634,1795.495935,13828.60976,580.1869919,1617.910569,1942.894309,16684.9187,1297.536585,3252.682927,2823.097561,5768.04878,1371.869919,312.6666667,2407.853659,12816.4878,442.4634146,527.1788618,1148.154472,15560.61789,662.8292683,133.5203252,898.1544715,12404.73171,1604.186992,698.2764228,2826.699187,10800.37398,923.5528455,297.495935,1325.853659,7631.00813,1710.252033,443.195122,1361.682927,5663.170732,725.6178862,169.3739837,4165.308943,5195.121951,1373.764228,223.0813008,3330.130081,571.6910569,853.3902439,123,15.76391995,10.13197913,0.766090924,0.938931298,0.675824176,-0.974017987
+4048,18782.71023,784.6988636,448.6306818,1042.403409,17347.13636,632.7727273,603.5454545,1501.590909,10072.07386,494.25,522.0056818,1709.306818,12226.42614,1193.835227,1013.806818,1006.488636,4704.471591,1215.414773,268.7727273,2281.017045,10369.51136,405.7272727,134.75,520.0454545,12268.49432,588.9431818,109.2784091,920.8636364,9493.318182,1305.306818,545.3522727,2813.818182,8504.897727,624.5170455,251.2784091,1671.505682,6149.590909,861.3238636,371.8125,1303.477273,4707.375,620.75,149.5909091,2106.215909,4286.323864,1355.551136,5417.931818,3166.255682,624.6931818,857.8295455,176,19.46992694,12.02444319,0.786499773,0.916666667,0.628571429,-0.237663657
+4049,22412.26012,866.8034682,419.3641618,1057.16763,20416.07514,699.6184971,414.9132948,1441.445087,11795.89017,563.8381503,1297.936416,1724.693642,14701.21965,1318.242775,583.0462428,1614.410405,5403.450867,1428.427746,301.0462428,2300.878613,11596.28324,439.5202312,181.6763006,1077.751445,14188.95954,636.8381503,202.9710983,749.2138728,11091.48555,1434.16185,707.2023121,2785.092486,9781.16763,631.3352601,266.0462428,1825.606936,7262.757225,1300.763006,400.9190751,1331.398844,5362.300578,653.2023121,157,1950.676301,4883.231214,1583.554913,11502.38728,3219.99422,672.3179191,855.6242775,173,17.93805733,12.61584354,0.710892746,0.901041667,0.636029412,-0.806714344
+4050,36299.98113,910.7735849,458.9056604,1077.226415,30020.66038,701.8490566,670.754717,1551.773585,19275.50943,557.9433962,595.0754717,1684.471698,23485.37736,1319.396226,1422.471698,1780.735849,8709.773585,1331.584906,307.9433962,2433.849057,17735.9434,473.0188679,105.9245283,666.3773585,21911.88679,754.1320755,120.3773585,1133.867925,17712.98113,1480.037736,497.8113208,2794.132075,15498.60377,817.6792453,281.4528302,1367.339623,11132.96226,989.3207547,414.3584906,1295.943396,7648.207547,618.3584906,158.3207547,1943.981132,7351.132075,1382.981132,1114.283019,3280.245283,728.5283019,852.6226415,53,10.66492078,6.475378142,0.79457495,0.946428571,0.688311688,0.24782487
+4051,34028.31915,831.4893617,512.8404255,1091.989362,31132.24468,691.5319149,879.9255319,1679.489362,15019.76596,500.606383,1952.117021,1759.606383,20444.23404,1170.946809,4338.946809,3831.425532,7636.138298,1238.255319,298.8723404,2337.138298,15823.89362,1026.085106,216.3085106,2169.159574,20167.71277,486,337.1382979,3651.968085,15201.54255,2610.43617,482.0425532,2790.117021,12628.6383,589.2978723,272.1170213,1170.87234,8025.553191,1314.734043,401.9680851,1304.489362,4603.765957,640.6702128,159.1595745,3538.734043,4673.56383,1206.457447,473.5744681,3208.882979,970.7446809,853.2659574,94,11.89144415,10.16845808,0.518451426,0.959183673,0.712121212,-0.797762208
+4052,38062.08929,913.8571429,545.5,1113.75,33372.67857,724.9821429,1072.535714,1893.428571,13919.01786,525.4821429,2275.660714,1853.303571,20526.57143,1203.178571,6503.339286,3266.232143,8063.357143,1262.303571,314.8928571,2616.964286,16205.83929,473.3214286,205.7321429,1758.339286,20341.58929,567.2321429,135.8571429,1509.875,15254.28571,2299.357143,363.4821429,2794.767857,12403.03571,606.25,274.9642857,885.7678571,6699.964286,1115.160714,398.3214286,1303.839286,3498.732143,599.2321429,151.3928571,1772.482143,3876.982143,1137.75,312.8928571,3206.964286,1043.660714,851.9821429,56,9.682814669,7.771496723,0.596507913,0.888888889,0.691358025,-0.314409387
+4053,33950.83505,912.7628866,581.7731959,1126.979381,21522.30928,590.6907216,582.2783505,1444.979381,10464.79381,484.2371134,792.1546392,1732.484536,14686.39175,1110.268041,4619.206186,2534.525773,5434.494845,1183.319588,279.4536082,2363.391753,11203.94845,432.1752577,910.0515464,708.8350515,14078.19588,408.5670103,116.3608247,3231.701031,10717.39175,1649,310.7938144,2815.886598,9389.28866,590.2989691,251.1443299,984.6701031,4443.690722,1067.628866,386.6701031,1290.845361,3108.505155,801.742268,149.3814433,2008.206186,3168.206186,1138.752577,167.9278351,3225.412371,229.3402062,854.8659794,97,12.39841822,10.31542721,0.554782494,0.932692308,0.577380952,-1.423732203
+4054,18991.32468,854.2987013,544.1428571,1051.090909,17803.83117,701.2597403,624.8181818,1489.779221,9414.194805,547.9480519,646.2857143,1763.883117,11490.94805,1236.727273,3464.350649,3914.766234,4312.922078,1547.636364,322.9220779,2350.805195,9161.103896,398.038961,2261.896104,502.9480519,10961.74026,439.4545455,129.3116883,3118.61039,8617.844156,1674.818182,731.8051948,2817.818182,7699.987013,714.8311688,283.1948052,1757.831169,5141.428571,947.8441558,419.0649351,1364.805195,3919.545455,1104.519481,173.0779221,7293.519481,3602.272727,1371.038961,1236.454545,3233.090909,399.4675325,854.0649351,77,12.289234,8.709272959,0.705518725,0.895348837,0.641666667,-1.043386087
+4055,19627.33721,946.7906977,729.6511628,1154.27907,18171.54651,751.755814,907.8255814,1711.906977,10420.83721,592.6976744,521.0348837,1775.639535,12969.18605,1355.290698,944.7093023,970.9651163,4674.732558,1418.686047,331.9418605,2382.744186,10311.82558,481.8139535,339.627907,465.372093,12222.06977,494.5697674,132.5,848.6162791,9442.104651,1525.372093,445.4302326,2818.5,8538.616279,757.6744186,316.6162791,1708.825581,5983.569767,889.627907,448.9418605,1362.604651,4487.197674,676.5465116,168.8953488,1535.790698,3983.232558,1439.918605,195.6744186,3422.790698,499.1744186,853.5232558,86,13.13751433,8.584929351,0.756955184,0.934782609,0.682539683,1.325646521
+4056,38790.85841,911.3982301,661.8318584,1112.433628,34451.10619,802.2831858,1155.964602,1660.938053,19731.79646,600.159292,2756.256637,1870.654867,23884.10619,1355.044248,3031.159292,3411.672566,8662.946903,1432.469027,342.840708,2536.884956,18528.10619,452.2743363,519.8318584,1203.814159,23318.39823,527.300885,481.0176991,921.3893805,17672.47788,2234.469027,492.6017699,2802.123894,15327.73451,657.699115,314.4778761,1328.318584,10821.25664,1747.345133,454.8141593,1340.831858,8217.070796,712.4778761,170.7256637,3725.336283,7111.044248,1446.424779,408.840708,3535.495575,529.6725664,855.3893805,113,12.86132037,12.09706427,0.339580026,0.896825397,0.538095238,-1.335065204
+4057,39170.53398,900.7669903,513.7281553,1093.339806,35046.65049,748.2912621,926.7864078,1645.135922,19961.62136,556.0194175,2561.786408,1833.601942,25175.81553,1304.912621,2076.68932,4817,9391.883495,1316.815534,319,2571.553398,19218.61165,426.3883495,112.4563107,1697.893204,24043.03883,914.5048544,512.6699029,1524.757282,18458.8932,2153.23301,520.5825243,2804.213592,16007.21359,626.7087379,295.4563107,1378.291262,11357.92233,2363.932039,433.776699,1314.951456,7627.271845,622.1941748,162.9223301,3059.165049,7167.271845,1372,424.8834951,3260.669903,809.3009709,854.2718447,103,13.89336445,9.665923404,0.718310857,0.936363636,0.66025641,0.78483788
+4058,36110.75115,957.4423963,646.2396313,1114.211982,31876.18894,717.4562212,841.6728111,1641.391705,18330.88018,560.8479263,1153.414747,1755.626728,23600.02304,1293.778802,2124.672811,2986.050691,8548.428571,1318.940092,313.40553,2463.718894,17826.36406,450.3732719,145.7004608,1243.331797,22073.45622,510.9262673,175.9677419,2488.907834,17100.62212,1896.004608,507.1658986,2812.004608,14820.56221,640.3502304,287.3133641,1441.967742,10413.79263,1113.857143,427.0599078,1321.640553,6987.294931,628.3732719,161.6359447,2587.258065,6624.829493,1334.617512,489.5529954,3373.179724,832.9907834,858.4654378,217,18.11347619,15.97727178,0.47112686,0.911764706,0.601108033,0.755000764
+4059,31121.42857,881.8911565,586.5816327,1107.972789,28213.29932,682.462585,596.8469388,1679.319728,13982.07143,539.5102041,515.3707483,1759.017007,18486.34354,1245.670068,4678.755102,2928.829932,6907.901361,1336.227891,313.5068027,2286.408163,14873.52041,443.1938776,376.0238095,496.2414966,17833.23129,441.7993197,126.170068,4344.931973,13930.89116,1495.217687,404.5442177,2862.017007,12109.86054,691.0816327,287.7346939,1324.102041,6531.068027,1287.044218,419.3469388,1300.598639,4720.506803,670.4829932,163.9693878,3957.64966,4350.789116,1289.568027,398.6360544,3243.462585,264.7142857,861.1122449,294,21.2011463,18.66269562,0.47447638,0.867256637,0.556818182,-1.242459667
+4060,38889.8,883.9833333,510.95,1074.233333,34929.9,713.4,783.3166667,1631.833333,20015.61667,581.9,1685.266667,1804.166667,24111.73333,1302,2345.866667,3071.583333,8622.533333,1436.333333,319.4833333,2361.483333,18991.85,419.35,215.35,889.4166667,22795.68333,489.15,136.6666667,1910.983333,18147.35,1829.233333,509.75,2806.183333,15791.78333,1090.483333,310.7,1690.466667,10456.3,1194.833333,441.7166667,1298.616667,7730.4,686.3,181.9,3006.8,7072.166667,1421.583333,764.7,3308.15,379.15,853.8333333,60,10.02873271,7.673769762,0.643818297,0.952380952,0.740740741,1.074032707
+4061,24608.03509,892.8596491,691.7807018,1099.394737,21889.60526,724,591.4561404,1587.394737,13382.20175,641.8333333,587.0350877,1768.298246,16239.42982,1352.27193,1949.096491,1321.491228,5894.982456,1380.929825,321.7017544,2357.105263,12710.57018,446.6842105,846.4912281,548.9473684,15676.58772,507.3859649,136.4824561,938.8333333,12172.4386,1676.754386,497.5614035,2815.175439,10710.77193,686.5438596,301.6842105,1669.5,7608.122807,857.0438596,453.3070175,1380.114035,5728.403509,869.8421053,178.8596491,2157.973684,5214.868421,1443.894737,292.7894737,3315.938596,515.745614,855.3947368,114,12.58692578,11.69219808,0.370290249,0.974358974,0.730769231,-1.482780635
+4062,31691.34074,929.2962963,708.7851852,1107.340741,29577.21481,746.2222222,914.4407407,1749.885185,17159.94074,563.9111111,1175.525926,1870.285185,20532.62222,1308.333333,2040.311111,3250.459259,7354.344444,1357.662963,312.7925926,2486.185185,15987.44815,454.5814815,155.4444444,792.1814815,19893.66667,1195.581481,135.9,1667.477778,15512.43704,1561.085185,630.862963,2798.451852,13421.31481,680.2518519,303.4037037,1423.522222,9478.618519,1365.422222,445.462963,1321.448148,7072.881481,628.1518519,166.5555556,2808.085185,6372.566667,1355.674074,451.4296296,3356.277778,580.5740741,861.5666667,270,22.73820464,17.10188313,0.659024942,0.841121495,0.511363636,-1.337342971
+4063,19962.04545,886.4166667,565.1363636,1072.159091,18275.7197,681.0378788,704.7878788,1588.80303,9518.734848,553.7121212,584.7651515,1751.295455,13125.62121,1215.901515,3323.80303,2345.022727,4776.143939,1248.075758,340.2727273,2315.136364,9652.719697,426.2575758,861.3787879,645.7575758,12412.06818,496.969697,128.4166667,1238.265152,9046.143939,1751.295455,477.5984848,2811.689394,7933.05303,1195.659091,266.6969697,1313.613636,5638.613636,925.719697,410.5984848,1347.371212,3645.939394,1118.113636,155.5454545,1835.780303,3594.310606,1275.893939,414.0454545,3329.833333,878.780303,856.1590909,132,14.35920132,11.96584995,0.552786667,0.942857143,0.634615385,1.542667101
+4064,25518.67593,965.2222222,610.1851852,1062.712963,21798.93519,644.3425926,968.9907407,1594.62963,11599.59259,537.3055556,1347.268519,1758.75,15270.0463,1175.962963,3430.314815,3671.157407,5728.583333,1218.842593,286.9074074,2590.657407,11482.69444,443.9814815,366.1111111,788.75,14347.97222,1625.712963,115.962963,1632.055556,11071.67593,1560.046296,457.1203704,2807.37037,9415.592593,891.2962963,259.7777778,1090.666667,6201.888889,1462.009259,390.5925926,1338.018519,3924.314815,661.8055556,159.2777778,4874.027778,3895.101852,1215.425926,680.287037,3137.398148,910.5833333,858.9444444,108,15.60644743,10.05082312,0.765010873,0.864,0.613636364,-0.195673336
+4065,47423.94382,946.5280899,506.1123596,1124.516854,42329.39326,778.8314607,903.6741573,1732.662921,24132.93258,600.6966292,1784.41573,1835.359551,28889.02247,1382.561798,2653.191011,3716.876404,10656.77528,1488.359551,352.6516854,2389.573034,23089.80899,435.988764,278.5505618,1944.157303,28336.02247,786.0337079,844.4831461,1464.460674,22358.26966,1882.775281,448.9213483,2849.370787,19687.53933,714.1348315,343.3033708,1317.134831,12940.60674,1418.775281,482.2134831,1304.853933,9493.011236,702.6179775,181.5955056,2481.966292,8697.258427,1507.179775,953.0337079,3280.089888,367.4494382,854.8539326,89,14.40600448,8.141683305,0.824981992,0.87254902,0.659259259,1.444939073
+4066,24767.61798,1038.662921,734.7752809,1091.988764,15616.82022,682.2696629,812.5280899,1518.561798,8851.382022,561.5393258,1583.011236,1882.033708,10648.61798,1203.179775,3487.988764,3841.674157,4064.876404,1617.966292,302.3033708,2398.741573,8670.314607,367.6292135,699.5842697,865.8988764,10403.25843,493.505618,122.4382022,2094.58427,8353.089888,2110.067416,658.1123596,2800.977528,7414.011236,607.4494382,269.5280899,1432.314607,5123.730337,1430.651685,408.6404494,1321.651685,3821.067416,894.6292135,165.6179775,3548.775281,3557.842697,1276.067416,219.7865169,3321.404494,414.8539326,856.3932584,89,13.48613214,9.040763246,0.742022652,0.898989899,0.618055556,-0.731314744
+4067,31901.6646,910.3975155,607.515528,1111.596273,29106.09938,759.173913,890.1614907,1602.26087,16693.99379,597.4658385,1178.993789,1795.192547,20130.8882,1321.47205,4455.080745,3628.751553,7205.590062,1373.757764,322.2298137,2451.888199,15537.07453,429.9565217,1213.993789,1166.608696,19233.65217,976.2111801,160.8571429,1983.310559,15100.19255,1751.757764,657.7018634,2811.546584,13178.31677,881.0496894,301.7826087,1395.31677,9285.52795,1192.708075,445.2484472,1369,6770.204969,901.8819876,169.6335404,5094.515528,6084.931677,1378.664596,300.4596273,3281.937888,549.3850932,856.7950311,161,24.03292009,9.149952653,0.924687984,0.809045226,0.522727273,-1.249434732
+4068,31998.98718,904.4807692,475.8782051,1062.75,28431.02564,757.4551282,1188.910256,1586.967949,16167.85897,554.0192308,1249.429487,1828.371795,20136.14103,1236.314103,3893.25641,2015.974359,7521.621795,1268.403846,295.1858974,2312.660256,15214.55769,5263.955128,162.2179487,1967.121795,19171.32051,582.3076923,743.4679487,1701.775641,14827.57692,1835.083333,528.3461538,2806.455128,12950.77564,599.9935897,265.7371795,1287.288462,9306.301282,843.1602564,408.2371795,1307.897436,6491.75641,620.1538462,158.3653846,3138.141026,6008.512821,1295.698718,388.1794872,3360.365385,752.6794872,858.4230769,156,16.88432649,12.23075816,0.689395326,0.876404494,0.65,0.370800743
+4069,26199.23009,810.1415929,596.1415929,1072.088496,23460.65487,643.9911504,715.1858407,1641.911504,12600.0885,523.0088496,606.0176991,1761.938053,16502.23894,1176.292035,4961.159292,4094.761062,6164.017699,1231.300885,307.3362832,2530.176991,12772.15044,408.6902655,912.7876106,648.7522124,16109.81416,466.3097345,127.6902655,4089.19469,12095.26549,1731.646018,461.8230088,2793.955752,10272.07965,624.4070796,265.1858407,1439.212389,6838.884956,1054.221239,402.7345133,1328.973451,4211.929204,1006.884956,159.7699115,4362.20354,4196.982301,1215.300885,264.3716814,3250.893805,919.8495575,856.8141593,113,14.52279808,10.38703205,0.69889682,0.911290323,0.672619048,-0.184419119
+4070,37193.57463,840.7985075,525.1940299,1093.768657,31272.90299,674.119403,888.358209,1676.067164,14972.78358,513.4776119,1569.5,1758.828358,21020.21642,1172.91791,4989.514925,3545.074627,7887.925373,1268.029851,303.1791045,2555.783582,16201.45522,404.8059701,369.4626866,1515.902985,20649.84328,816.3134328,128.9776119,4903.955224,15415.79104,2131.88806,488.1044776,2819.022388,12686.86567,604.3955224,271.0671642,1070.91791,7914.783582,1203.044776,396.3208955,1296.067164,4534.880597,713.4402985,157.7462687,2975.791045,4640.246269,1209.910448,475.3507463,3229.873134,980.2014925,859.7014925,134,19.19865419,9.592859282,0.866219819,0.8375,0.587719298,-0.133224221
+4071,16066.42174,892.9217391,451.0304348,1058.965217,14790.7087,694.9391304,538.9565217,1476.76087,8164.569565,528.873913,635.5086957,1721.226087,10697.7,1308.391304,935.1695652,1032.9,3861.695652,1222.169565,292.373913,2261.973913,8324.813043,413.0913043,106.6695652,690.6695652,10067.56522,567.2826087,126.9391304,783.8391304,7998.186957,1380.373913,562.0130435,2815.482609,7005.973913,630.926087,269.7695652,1629.095652,5295.234783,907.9826087,396.5391304,1314.313043,3912.643478,636.9478261,161.8956522,2329.93913,3650.565217,1511.452174,7938.221739,3193.304348,684.8043478,861.5826087,230,20.11604718,14.65476417,0.68503397,0.962343096,0.71875,-0.380760123
+4072,27186.27174,872.6086957,487.8478261,1088.467391,25275.45652,701.25,651.0869565,1597.086957,12999.52174,558.7934783,477.7065217,1747.815217,17028.58696,1318.858696,4164.923913,2025.423913,6150.195652,1346.445652,330.2391304,2284.576087,13785.75,501.7065217,238.8478261,497.2608696,16847.11957,455.3152174,131.8695652,2256.728261,13165.75,1509.347826,345.5326087,2801.75,11670.29348,610.7934783,293.3369565,1396.01087,6785.369565,1052.391304,435.326087,1296.413043,5074.945652,647.6956522,165.1630435,2803.456522,4612.836957,1405.043478,5022.5,3239.01087,294.423913,858.8369565,92,12.59146257,9.916068596,0.616285037,0.876190476,0.58974359,0.993388346
+4073,35670.41346,917.2692308,556.3653846,1125.423077,32059.28846,765.5480769,791.7788462,1740.730769,18009.77885,608.7596154,966.2980769,1792.807692,21759.17308,1341.163462,3075.365385,3949.125,8088.307692,1404.336538,341.2884615,2367.538462,17648.27885,421.1730769,858.8269231,630.5673077,21383.85577,808.5865385,173.2884615,2989.471154,16409.75962,1646.615385,588.25,2827,14834.75,859.25,316.7403846,1838.317308,9450.125,1143.221154,464.25,1344.346154,6946.076923,858.2115385,176.8942308,4661.903846,6293.855769,1460.682692,1499.269231,3264.519231,350.6153846,858.0480769,104,12.56011788,10.89782866,0.497169611,0.95412844,0.722222222,-1.202799819
+4074,23492.368,964.216,473.872,1076.984,21016.424,756.136,638.664,1511.224,12288.328,555.8,596.648,1716.312,15207.952,1330.392,1430.944,2258.152,5523.128,1335.088,295.176,2312.904,11525.16,423.984,241.192,606.52,14038.72,629.176,120.352,1664.96,10977.304,1370.072,643.304,2797.784,9661.552,605.608,270.032,1625.704,6943.104,1083.376,386.952,1310.496,5137.992,662.056,158.368,1767.76,4521.52,1521.272,9858.744,3334.016,643.992,861.248,125,15.08139464,10.78881123,0.698743546,0.946969697,0.600961538,0.24643234
+4075,25064.75238,1042.161905,560.8571429,1072.52381,21769.28571,719.1428571,699.4285714,1521.409524,12135.82857,587.7428571,875.9333333,1758.47619,15643.42857,1250.657143,3220.933333,2471.457143,5689.485714,1240.52381,287.4095238,2357.590476,11625.07619,413.2095238,128.0380952,892.4095238,14386.18095,1366.304762,122.4380952,3197.990476,11416.11429,1592.733333,503.0666667,2790.295238,9755.685714,562.6190476,255,1379.371429,6954.457143,986.4380952,390.4571429,1288.590476,4922.504762,588.8761905,152.8571429,3150.152381,4620.704762,1230.447619,183.1428571,3415.304762,764.5142857,858.7809524,105,12.90474042,10.42577094,0.58931629,0.954545455,0.673076923,1.098215271
+4076,39167.27869,883.8852459,527.0819672,1100.934426,36875.78689,779.7540984,994.0491803,1685.918033,20438.4918,587.6885246,2604.52459,1965.491803,25202.91803,1352.57377,4208.754098,4895.131148,9410.672131,1422.508197,329.9672131,2405.04918,20811.08197,438.0327869,524.7868852,1516.295082,25486.39344,1680.442623,542.9016393,1976.393443,19807.98361,2031.344262,469.2131148,2811.229508,17894.31148,701.6885246,349.4590164,1394.442623,11646.11475,1900.442623,475.3934426,1317.262295,8698.770492,740.0655738,187.8852459,3937.196721,7865.229508,1484.409836,1046.131148,3327.213115,359.0819672,860.0655738,61,11.71969017,7.945332173,0.735110518,0.835616438,0.462121212,-0.414581115
+4077,20287.84,894.432,741.416,1115.064,18860.728,717.84,844.968,1643.656,10559.992,607.064,506.416,1742.896,12931.704,1285.408,970.248,978.4,4798.496,1496.624,320.416,2386,10547.888,422.896,413.872,469.904,12980.52,464.136,130.024,844.912,9892.608,1497.176,456.296,2813.68,8800.672,669.504,302.096,1770.8,6207.448,901.896,451.792,1341.184,4630.496,711.056,167.44,1251.472,4251.848,1405.512,338.872,3287.04,486.192,859.928,125,13.15685636,12.17145689,0.379714484,0.946969697,0.73964497,-0.621006843
+4078,28182.45794,908.1401869,1069.588785,1171.925234,24254.4486,735.5233645,1104.401869,1899.233645,12794.35514,535.4205607,711.8224299,1837.457944,17083.2243,1255.682243,1930.205607,2433,6268.392523,1362.205607,317.9813084,2400.88785,13035.7757,475.6915888,528.0560748,723.1214953,16072.88785,500.2056075,134.5514019,1782.037383,12361.33645,1634,444.3364486,2831.504673,10506,761.588785,292.8691589,1400,6700.196262,924.8878505,425.0186916,1344.11215,4121.018692,811.0093458,157.3271028,2324.364486,4174.570093,1297.439252,297.6168224,3297.35514,928.4672897,860.8411215,107,13.85590591,10.86210832,0.620844847,0.87704918,0.633136095,-0.518657139
+4079,31352.21348,906.0898876,779.0674157,1133,27618.92135,724.5842697,1018.47191,1773.157303,14612.55056,572.7640449,951.1910112,1752.235955,19374.17978,1271.033708,2440.730337,2470.314607,7273.314607,1301.674157,325.3595506,2352.348315,15117.98876,559.8539326,1168.88764,858.1910112,18816.75281,484.2022472,129.2696629,2047.393258,14428.22472,2061.269663,427.9662921,2824.764045,12253.83146,773.3707865,336.3595506,1211.269663,7901.235955,1012.05618,426.9213483,1374.426966,4829.011236,931.8314607,162.8651685,4651.449438,4866.707865,1308.595506,661.6179775,3326.089888,938.7303371,858.0449438,89,13.21608061,8.911806981,0.738443438,0.917525773,0.684615385,1.070187659
+4080,35422.95122,892.0121951,755.6219512,1141.012195,12525.06098,488.6097561,497.097561,1384.804878,5765.97561,460.3170732,838.8902439,1656.182927,7764.865854,935.5243902,4115.865854,2396.939024,3195.195122,981.1463415,224.5609756,2536.378049,6564.609756,313.8536585,266.9146341,662.5731707,8331.841463,985.8170732,102.7317073,2486.646341,6204.902439,1662.829268,375.5731707,2780.963415,5275.939024,533,223.3780488,862.8658537,3035.658537,955.0365854,340.3170732,1280.207317,1694.670732,548.6829268,132.6097561,1920.743902,1790.670732,954.7439024,185.5243902,3037.536585,1020,859.4268293,82,12.74249469,8.472724954,0.746915604,0.942528736,0.630769231,-0.623098247
+4081,39208.98851,970.2068966,635.1954023,1146.965517,34179.57471,792.137931,818.0229885,1703.551724,20130.12644,607.4482759,1288.045977,1785.126437,24553.93103,1410.528736,2200.712644,4201.287356,8811.735632,1475.666667,374.9195402,2330.298851,19078.16092,446.9195402,269.5287356,1159.781609,23661.77011,945.2068966,203.5862069,1744.597701,18511.13793,1911.367816,583.5977011,2829.563218,16139.32184,661.954023,321.7011494,1780.402299,10914.33333,1292.275862,479.6091954,1329.758621,8134.873563,690.0114943,179.045977,2354.344828,7398.022989,1547.517241,945.8965517,3368.54023,455.6206897,859.5632184,87,12.05137639,9.533158939,0.611760336,0.945652174,0.608391608,0.889480773
+4082,18100.78906,837.71875,469.2734375,1048.984375,16221.42188,664.4296875,635.796875,1548.757813,9198.9375,657.8828125,502.453125,1731.65625,11527.84375,1191.195313,2880.195313,1795.476563,4343.359375,1220.804688,285.9296875,2290.671875,8772.414063,1815.96875,652.078125,555.328125,10659.17969,581.984375,110.2578125,860.6171875,8537.078125,1608.71875,635.3828125,2784.21875,7348.039063,764.96875,258.8515625,1359,5399.523438,1043.710938,385.9453125,1324.273438,3911.28125,774.046875,153.34375,2948.15625,3618.476563,1295.039063,619.75,3221.734375,707.6953125,861.3359375,128,14.78997494,11.33426776,0.642425667,0.907801418,0.711111111,-1.336795573
+4083,37354.71739,1048.155797,555.057971,1083.996377,32912.08333,729.9275362,681.5362319,1593.40942,18961.03623,557.9746377,1072.503623,1739.365942,24228.75,1301.82971,3692.224638,3322.851449,8704.807971,1307.097826,303.2536232,2396.405797,17938.71014,407.7934783,109.3152174,897.1521739,22217.9058,509.7789855,142.1630435,2344.210145,17497.49275,1824.778986,534.4456522,2802,15083.3913,597.673913,284.2753623,1288.594203,10634.32971,1342.594203,415.4166667,1305.322464,7359.304348,605.5833333,159.057971,1940.688406,6760.300725,1330,380.6268116,3307.163043,787.1992754,863.2101449,276,24.34350948,15.72847527,0.763248117,0.884615385,0.649411765,1.30983531
+4084,26012.10317,1137.063492,586.8253968,1057.809524,22359.07143,712.3333333,608.3412698,1499.809524,12850.78571,568.0952381,736.6587302,1703.880952,15931.0873,1240.357143,2120.873016,2064.452381,6076.920635,1249.150794,291.7539683,2453.222222,12442.90476,376.0952381,150.015873,507.2380952,15479.72222,684.2857143,119.7857143,2457.666667,11784.30159,1581.68254,471.2619048,2787.269841,10232.85714,712.3571429,271.6031746,1210.325397,7084.309524,900.7222222,385.4047619,1298.531746,4644.896825,579.6031746,158.531746,1657.68254,4340.563492,1172.904762,760.4126984,3481,851.8174603,861.2142857,126,13.74590218,12.01076759,0.486337984,0.954545455,0.6,-0.233013822
+4085,25390.92523,1012.242991,754.588785,1153.766355,22380.37383,784.7102804,887.5607477,1807.224299,12300.43925,570.1588785,693.3738318,1784.831776,16093.59813,1370.504673,1185.897196,1404.392523,5843.915888,1431.364486,336.7570093,2402.35514,12012.33645,495.1308411,204.0186916,601.9626168,15369.2243,499.9719626,136.046729,1140.878505,11391.15888,1674.869159,444.7196262,2829.074766,10023.84112,1563.009346,301.7196262,1479.308411,6799.700935,875.5607477,447.4018692,1345.53271,4548.196262,652.9252336,167.8971963,1166.971963,4264.28972,1375.598131,361.4392523,3528.504673,867.8598131,860.7757009,107,13.00654554,10.80109462,0.557115072,0.938596491,0.685897436,1.032055187
+4086,30041.26984,854.8888889,737.3968254,1112.21164,24346.87831,669.3068783,830.0846561,1766.280423,11540.2963,510.9259259,1684.005291,1791.851852,16784.69841,1195.592593,5245.439153,3656.100529,6310.354497,1293.544974,293.3915344,2439.100529,12935.74603,509.8412698,447.4126984,1510.444444,16340.71429,777.5343915,121.4867725,2068.84127,12352.82011,2421.677249,416.1481481,2811.84127,10169.65608,1352.666667,259.4761905,1117.195767,6274.608466,1404.084656,397.3544974,1301.597884,3621.095238,651.5132275,154.4656085,2459.624339,3742.396825,1214.222222,531.4550265,3300.78836,991.5767196,862.6878307,189,18.47888947,13.20930507,0.699296029,0.935643564,0.694852941,-0.773624049
+4087,36792.12324,944.3274648,728.0669014,1141.492958,25858.97887,670.5,729.3239437,1657.545775,10541.39789,586.9366197,1079.873239,1717.433099,16063.90845,1210.369718,5235.214789,2603.359155,6155.711268,1378.721831,327.0598592,2364.052817,12807.70423,405.8239437,572.5950704,921.5985915,16098.46127,455.0352113,127,2691.764085,11928.4331,2536.742958,396.3591549,2798.862676,9806.950704,602.7570423,261.8661972,924.2359155,5376.049296,1078.605634,386.4260563,1298.933099,2929.376761,683.2711268,152.8485915,2446.897887,3157.024648,1144.947183,472.2535211,3166.397887,1036.721831,863.1549296,284,21.46407052,18.09314011,0.537991776,0.937293729,0.676190476,0.836576448
+4088,24783.76289,891.7216495,855.257732,1132.71134,22211.30928,678.8453608,625.2680412,1715.57732,11472.75258,577.9690722,499.5051546,1778.670103,15409.1134,1325.907216,2491.57732,3109.463918,5675.185567,1404.340206,309.3917526,2310.154639,11328.23711,435.1443299,859.5463918,535.1443299,14707.37113,558.1340206,124.6597938,1976.680412,10925.86598,1545.257732,462.3402062,2809.958763,9290.350515,2921.752577,266.7835052,1312.103093,6295.546392,925.1237113,403.7319588,1325.154639,4005.845361,873.9278351,161.5463918,3905.71134,3978.989691,1279.268041,625.1546392,3239.783505,895.1134021,861.2061856,97,13.41729701,9.492127784,0.706758844,0.906542056,0.678321678,0.905672218
+4089,31117.76039,839.8704156,525.8410758,1071.420538,28625.77262,675.8337408,895.596577,1655.476773,13872.98778,575.7017115,1825.92176,1764.821516,18685.46455,1174.03423,4477.775061,3776.117359,7104.933985,1229.782396,299.1026895,2481.07824,14635.63081,2255.929095,585.6259169,1995.136919,18494.82152,545.5354523,148.2518337,2593.110024,14048.9511,2386.501222,413.9633252,2804.317848,11645.19315,635.4205379,267.207824,1075.706601,7233.01467,1285.601467,399.0171149,1338.132029,4163.246944,708.2616137,157.8728606,3620.848411,4277.689487,1196.249389,322.2469438,3247.325183,964.0342298,867.5599022,409,24.56103689,22.05648654,0.439939325,0.93166287,0.715034965,-0.221191203
+4090,22533.19101,811.1235955,502.7865169,1078.539326,19517.66292,646.5168539,496.258427,1580.674157,8837.078652,844.8089888,377.2022472,1688.191011,12638.49438,1191.921348,2225.359551,886.1011236,4793.303371,1190.561798,332.8314607,2270.651685,9995.168539,399.6179775,542.1235955,510.2247191,12655.13483,411.1797753,133.0898876,1098.505618,9651.303371,1542.438202,368.7640449,2840.011236,7988.022472,777,264.5617978,893.1348315,4778.123596,716.7078652,388.8089888,1301.853933,2686.359551,676.8876404,154.8426966,1872.483146,2879.438202,1165.910112,753.5730337,3099.449438,1005.617978,860.6179775,89,11.99586322,9.664712945,0.592363966,0.917525773,0.741666667,1.33415999
+4091,23854.48485,786.0505051,541.8181818,1073.090909,13005.57576,489.0606061,390.6868687,1327.808081,5792.525253,407.4444444,423.5353535,1675.010101,8662.717172,972.3434343,3859.818182,1834.89899,3213.272727,1083.30303,234.1717172,2277.646465,6490.30303,2298.79798,593.3030303,848.8787879,7945.161616,407.959596,104.8282828,3585.858586,5863.060606,1397.969697,296.6969697,2798.181818,5112.111111,537.7171717,218.7777778,964.7272727,2311.79798,958.7171717,345.3939394,1305.909091,1680.727273,751.8888889,140.6262626,3318.666667,1746.828283,1010.979798,168.1111111,3086.888889,219.3131313,861.3636364,99,12.96455277,9.766645517,0.657637481,0.99,0.707142857,1.531342485
+4092,29269.68571,949.1571429,552.9428571,1107.614286,26154.32857,705.0428571,622.8285714,1661.271429,13783.85714,536.9428571,479.7285714,1757.1,18283.95714,1316.028571,4705.271429,2723.242857,6410.742857,1320.242857,335.5571429,2303.171429,14425.25714,410.7,205.1142857,469.5,17400.52857,431.7571429,132.7857143,2771.857143,13968.7,1482.471429,358.6428571,2822.957143,12207.02857,617.5714286,301.7,1519.842857,6906.242857,834.1142857,448.7285714,1295.042857,4958.014286,659,169.8142857,4766.514286,4592.4,1382.014286,2750.457143,3186.385714,285.3428571,860.9571429,70,11.94796941,7.469468902,0.780491502,1,0.707070707,0.949865375
+4093,32876.38992,974.8408488,500.5941645,1055.281167,29788.9496,779.7851459,668.9787798,1563.013263,16842.4695,572.2891247,1164.092838,1754.734748,20406.64721,1324.543767,1987.421751,3008.34748,7196.997347,1281.628647,293.4748011,2362.095491,15698.18037,410.9257294,157.6339523,913.3448276,19501.85676,778.6737401,347.4933687,1761.013263,14718.51989,1651.082228,628.9045093,2803.106101,12899.96286,783.5411141,278.3023873,1449.607427,9034.907162,1016.928382,406.4350133,1305.554377,6727.122016,603.4429708,157.1538462,2409.95756,5941.583554,1382.660477,4009.278515,3241.376658,600.5649867,869.8355438,377,27.72902303,17.74716086,0.768357302,0.928571429,0.641156463,0.365081165
+4094,30702.35294,867,572.3235294,1089.343137,28250.46078,708.9215686,748.5098039,1598.95098,15568.87255,557.5980392,1189.45098,1789.686275,18803.08824,1272.401961,3162.176471,4646.382353,7023.264706,1391.029412,325.4607843,2404.470588,15222.9902,407.0490196,479.7352941,1253.627451,18430.97059,838.5784314,133.4117647,3092.529412,14179.65686,1777.745098,542.1078431,2811.852941,12482.20588,923.1862745,298.6470588,2202.862745,8304.45098,1327.078431,435.1862745,1325.617647,6204.45098,727.5098039,180.2843137,5661.598039,5635.352941,1393.421569,863.0784314,3266.264706,377.627451,862.872549,102,14.16480967,9.423330159,0.746608693,0.927272727,0.566666667,1.048819752
+4095,27160.82432,888.8783784,546.5540541,1065.310811,25684.55405,718.4189189,503.4459459,1506.283784,13543.66216,553.3513514,580.6756757,1702.202703,16415.04054,1301.067568,2099.756757,3272.986486,6092.337838,1554.243243,329.5810811,2319.648649,13251.10811,412.0540541,1095.77027,624.2027027,16453,426.4459459,133.1891892,2338.432432,12591.22973,1633.121622,533.3648649,2798.202703,11247.14865,655.527027,283.527027,1580.77027,7486.445946,930.0135135,441.6756757,1343.054054,5805.27027,900.0405405,181.9054054,4438.445946,5273.797297,1412.108108,1256.689189,3244.22973,399.3918919,862.1081081,74,12.38035125,8.845609029,0.699647974,0.813186813,0.517482517,-1.359572676
+4096,29147.77692,1017.569231,938.7,1194,26116.46923,778.8846154,997.9230769,1789.892308,14317.97692,654.2076923,719.0769231,1814.784615,17761.06923,1376.169231,1063.792308,1313.653846,6431.792308,1410.792308,336.6692308,2372.430769,13878.51538,495.7769231,453.3230769,648.7461538,17023.82308,489,142.6230769,987.2615385,13106.55385,1665.069231,442.8230769,2846.715385,11553.89231,723.1,313.4461538,1637.107692,7808.630769,1039.530769,463.2692308,1375.246154,5813.461538,720.7153846,175.0230769,1672.846154,5118.769231,1426.761538,215.4307692,3343.861538,473.4307692,864.2692308,130,14.60049232,11.55807831,0.611010482,0.942028986,0.722222222,-1.174896555
+4097,26083.43939,783.9090909,433,1040.863636,23353.5,647.1363636,742.6212121,1494.787879,13944.5303,506.6212121,1747.681818,1750.409091,17217.86364,1231.090909,1346.287879,2610.484848,6343.121212,1280.5,283.0757576,2369.545455,13662.43939,419.4393939,137.2727273,923.0757576,17185.89394,1824.227273,109.4393939,940.6363636,13156.25758,1373.848485,540.8636364,2782.287879,11449.4697,603.3030303,254.2424242,1623.681818,8490.439394,1947.787879,391.8484848,1280.666667,6285.212121,630.5606061,155.6363636,2520.121212,5900.818182,1397.954545,5646.863636,3175.015152,633.2424242,862.7727273,66,10.54003061,8.347841092,0.610504245,0.929577465,0.66,-1.202539228
+4098,23528.03175,908.4761905,667.6349206,1085.650794,22605.87302,693.3650794,683.2857143,1582.68254,11802.55556,532.5873016,1265.301587,1735.301587,16194.85714,1245.206349,2101.079365,3568.206349,5977.507937,1290.730159,289.7460317,2527.84127,11851.65079,430.6507937,113.015873,881.4603175,15072.88889,504.9206349,134.4920635,1744.52381,11328.09524,1916.015873,567.984127,2811.301587,9728.587302,662.0634921,268.968254,1378.15873,6877.714286,1502.079365,406.0634921,1305.555556,4958.714286,590.7936508,153,2884.063492,4444.698413,1281.698413,670.4444444,3309.746032,801.3968254,862.2063492,63,12.83399869,7.523005235,0.810182434,0.807692308,0.477272727,-1.03361637
+4099,23395.56477,1000.621762,617.3523316,1090.813472,21023.55959,745.1917098,658.1968912,1547.813472,11323.5544,576.611399,675.5284974,1798.160622,14005.99482,1305.668394,2316.020725,2190.932642,5050.507772,1728.07772,314.1088083,2345.165803,11054.79275,402.3005181,1153.559585,506.5233161,13416.56477,535.9274611,132.2227979,1641.61658,10602.1399,1705.621762,704.1295337,2846.606218,9467.430052,694.0777202,287.3834197,1346.772021,6398.595855,964.5233161,434.8911917,1391.336788,4843.388601,884.880829,174.611399,4548.222798,4371.108808,1368.015544,268.6062176,3327.388601,424.0621762,865.4145078,193,20.82888509,12.52022169,0.799174581,0.885321101,0.742307692,1.521942886
+4100,21792.61538,1019.288462,682.25,1157.884615,18973.14423,797.0865385,652.9807692,1708.730769,10742.5,599.7403846,513.6634615,1762.182692,12916.28846,1457.105769,1737.557692,2257.346154,4796.557692,1510.778846,363.4230769,2368.211538,10580.15385,456.9711538,467.2980769,545.375,12683.68269,492.9038462,140.9903846,1426.836538,9815.932692,1786.461538,538.5288462,2907.942308,8822.365385,1328.673077,315.2692308,1938.384615,6010.586538,1015.990385,478.875,1359.153846,4570.990385,760.5480769,185.8653846,2514.423077,4075.951923,1499.423077,2418.605769,3321.086538,445.6442308,864.3557692,104,14.51079401,10.25079846,0.707787162,0.888888889,0.571428571,-0.823354954
+4101,21418.64286,937.2261905,579.577381,1098.934524,19917.43452,748.0535714,830.3988095,1540.547619,11103.30357,561.8035714,807.9702381,1791.803571,13663.16071,1353.404762,1471.916667,1612.696429,4912.035714,1415.047619,322.1488095,2319.964286,10707.15476,443.2142857,168.1309524,888.4464286,13135.28571,486.3690476,130.4107143,885.4285714,9981.833333,1650.767857,450.1071429,2820.142857,8856,697.6011905,291.8095238,1659.869048,6212.184524,1229.839286,440.6011905,1328.321429,4653.541667,635.9940476,172.5654762,1448.642857,4144.910714,1423.60119,326.5357143,3212.714286,499.327381,866.6309524,168,18.20573139,12.40546044,0.731907385,0.903225806,0.717948718,0.052284887
+4102,35976.85915,910.1408451,588.8873239,1118.619718,32134.02817,791.5352113,998.7746479,1659.183099,18159.38028,585.5352113,1949.591549,1811.577465,21458.04225,1351.873239,2718.492958,2604.169014,8045.605634,1424.380282,335.5633803,2470.943662,17203.84507,437.9859155,744.0704225,1149.253521,21182.28169,577.8450704,507.3802817,992.8732394,16377.97183,2102.71831,488.7605634,2805.253521,14391.92958,1036,310.3943662,1261.647887,10128.15493,1436.140845,456.056338,1342.676056,7590.647887,798.4225352,173.6478873,2879.535211,6707.915493,1430.169014,297.8309859,3679.887324,534.2957746,863.084507,71,12.67321803,7.43910937,0.809590914,0.934210526,0.657407407,-1.049335554
+4103,30527.9816,879.2331288,732.7055215,1149.96319,27822.91411,721.7177914,1311.595092,1698.257669,16218.69325,588.4969325,1533.895706,1823.895706,19428.49693,1303.233129,3102.957055,2900.030675,6830.337423,1380.509202,321.8466258,2754.055215,14889.38037,434.2515337,413.3803681,1074.447853,18319.80982,770.7852761,446.0736196,1037.834356,14420.17791,1814.576687,489.398773,2818.91411,12661.34969,741.7361963,305.6871166,1320.466258,8969.355828,1420.91411,445.8895706,1375.90184,6460.09816,708.7668712,168.0368098,3094.791411,5912.92638,1380.588957,345.5030675,3271.490798,552.0184049,865.4907975,163,20.70238691,10.21694654,0.869737064,0.947674419,0.659919028,-1.158102547
+4104,34559.02454,1069.98773,559.5644172,1090.993865,30526.46012,793.6564417,849.2822086,1607.840491,17943.50307,676.2699387,1472.742331,1772.539877,21839.09202,1383.196319,2928.141104,3025.122699,7914.294479,1353.368098,310.3435583,2486.233129,16228.44785,439.8711656,188.2638037,1050.042945,19965.05521,478.3435583,299.3190184,1172.558282,15762.66871,1951.895706,478.7300613,2794.110429,13673.76687,635.9079755,277.2331288,1287.453988,9663.09816,1253.251534,409.8343558,1310.754601,6892.325153,637.4171779,162.803681,2313.779141,6094.907975,1322.552147,337.1104294,3356.521472,730.5030675,868.202454,163,21.23137718,10.63774541,0.865424776,0.831632653,0.626923077,-0.226806925
+4105,30338.28804,977.5,690.3532609,1159.592391,18594.68478,585.3369565,494.7826087,1498.282609,8580.054348,470.7065217,795.2391304,1726.043478,11976.52174,1074.804348,4758.467391,2106.423913,4520.722826,1161.288043,274.3152174,2293.163043,9276.429348,329.2065217,985.5923913,672.798913,11209.79891,394.701087,246.5380435,2953.880435,8385.461957,1623.853261,302.4945652,2816.913043,7287.576087,573.8369565,242.8152174,995.7173913,3316.548913,808.1684783,371.2228261,1296.538043,2404.641304,764.3206522,144.9347826,2231.608696,2362.375,1072.201087,399.201087,3126.353261,234.1086957,867.4782609,184,17.63969987,13.4533348,0.646783471,0.943589744,0.721568627,0.393828675
+4106,44242.47727,938.2954545,485.6136364,1101.454545,38385.22727,783.75,777.3181818,1678.340909,22526.93182,606.4318182,2392.386364,1814.818182,27402.5,1355.636364,2095.522727,4433.886364,9866.795455,1463.795455,345.2045455,2391.954545,21431.45455,417.5909091,308.75,1935.5,25962.45455,1046.5,175.2272727,1269.977273,20987.43182,1966.772727,437.3181818,2853.977273,18466.81818,633.4090909,332.9090909,1336.272727,11984.75,1855.227273,472.0454545,1351.636364,8517.090909,680.3863636,179.8409091,3054.136364,8116.090909,1475.204545,303.1136364,3314.863636,366.8636364,863.2954545,44,8.037324885,7.101722787,0.468255997,0.956521739,0.611111111,-1.461398567
+4107,33967.70492,1026.606557,601.5901639,1113.213115,29789.03279,755.1147541,656.295082,1698.606557,17078.40984,799.5737705,754.8852459,1758.459016,20822.04918,1358.245902,3743.704918,2481.885246,7755.131148,1324.819672,323.1311475,2422.721311,16599.7541,420.9836066,807.4590164,721.5409836,22089.55738,669.4098361,134.8852459,3567.836066,16609.34426,1788.42623,449.9180328,2778.95082,14187.06557,820.9672131,295.557377,1254.868852,9798,1002.114754,423.852459,1374.819672,6054.114754,875.3442623,169.8196721,3888.213115,6025.540984,1352.344262,240.295082,3294.180328,887.2295082,864.7868852,61,10.24049147,7.719821939,0.657043482,0.983870968,0.616161616,0.526461268
+4108,24362.37179,923.1794872,603.6410256,1097.807692,22477.21795,700.0128205,460.4615385,1657.410256,11062.69231,548.6282051,522.5,1757.205128,14751.60256,1286.576923,7264.064103,4309.153846,5288.679487,1310,316.9358974,2282.269231,11535.25641,448.3461538,572.7307692,452.7435897,13890.74359,421.1025641,125.1025641,5720.448718,10846.67949,1495.397436,453.1025641,2806.833333,9287.294872,581.7179487,291.6282051,1943.897436,5240.128205,811.2692308,430.3461538,1298.294872,3773.089744,715.6025641,168.1794872,6681.538462,3450.769231,1327.294872,2968.358974,3147.974359,278.1794872,865.8333333,78,10.73368818,9.529029445,0.46029037,0.951219512,0.590909091,1.124476462
+4109,39385.6747,920.1807229,533.7108434,1114.445783,34626.6506,771.9638554,712.4457831,1684.626506,19439.10843,605.313253,706.5060241,1760.445783,23228.10843,1350.783133,1671.674699,2855.891566,8761.060241,1420.686747,349.2650602,2446.578313,19001.37349,428.7710843,1312.313253,672.3493976,23525.40964,570.1204819,143.1084337,1678.915663,17928.83133,1690.638554,621.060241,2927.674699,16113.90361,1124.168675,312.4216867,1796.710843,10143.71084,1154.542169,470.3253012,1347.13253,7377.542169,995.1084337,181.1204819,2763.337349,6781.072289,1488.879518,2352.698795,3301.337349,343.9277108,866.1566265,83,11.51439534,10.26647017,0.452783614,0.838383838,0.456043956,0.567982786
+4110,27759.63333,1077.075,566.9416667,1070.3,24164.59167,742.1916667,602.5,1496.241667,13337.45833,616.6416667,1202.308333,1743.016667,15882.15,1290.491667,1727.191667,2223.616667,6021.841667,1411.666667,313.4583333,2436.466667,12904.65,387.8666667,313.525,1102.208333,15693.23333,434.3083333,257.8416667,1418.066667,12265.96667,1947.65,494.6083333,2798.325,10936.40833,628.9,283.5416667,1234.791667,7371.55,1086.833333,424.525,1320.916667,5569.283333,676.5166667,167.3583333,2082.258333,4974.975,1307.958333,304.3833333,3356.258333,407.9083333,867.475,120,13.73656237,11.17567641,0.581464809,0.975609756,0.714285714,-0.319744198
+4111,44152.90361,939.0843373,524.2771084,1097.951807,38320.27711,785.8072289,883.1987952,1678.23494,22760.53614,590.5060241,1410.379518,1834.885542,28114.74699,1362.975904,2496.873494,4238.759036,10428.61446,1376.596386,328.8373494,2508.054217,21066.6747,550.4819277,152.4518072,1259.692771,26254.95783,867.2289157,170.6686747,1752.204819,20805.6988,1750.307229,584.7891566,2805.801205,18304.55422,632.4698795,301.3493976,1476.319277,13102.63855,1218.277108,437.0783133,1315.674699,9016.409639,643.5120482,162.9879518,3624.108434,8290.246988,1440.542169,364.9759036,3389.289157,743.4457831,869.5481928,166,18.68974813,13.42563507,0.695689918,0.838383838,0.553333333,0.548559359
+4112,34912.4,973.3545455,528.4454545,1101.3,31015.07273,738.2727273,537.9545455,1629.454545,17486.65455,564.6909091,1276.245455,1772.181818,22245.08182,1345.918182,2503.127273,3963.027273,8160.918182,1368.754545,314.9272727,2869.536364,16521.55455,1981.718182,112.2363636,1050.854545,21102.87273,851.2909091,165.3909091,3089.809091,16147.77273,1852.009091,617.1636364,2809.154545,13763.16364,784.9090909,283.3181818,1459.054545,9697.7,1302.818182,419.1545455,1301.654545,6613.263636,608.9,162.3818182,3429.181818,6105.836364,1327.890909,210.1090909,3332.027273,807.7636364,866.9,110,15.84135493,9.469441221,0.801669796,0.866141732,0.611111111,-1.085335838
+4113,40074.41429,1084.614286,910.2428571,1220,26221.11429,750.3285714,619.1,1749.385714,12328.18571,557.2285714,696.7714286,1689.342857,17301.71429,1416.942857,2706.371429,1916.057143,6604.928571,1415.942857,373,2412.985714,14178.11429,479.9142857,225.5857143,670.6285714,17919.41429,645.2428571,130.8857143,3342.885714,13809.04286,2550.171429,368.4714286,2799.742857,11374.18571,612.0285714,285.7285714,887.3285714,6233.828571,996.4,428.0857143,1323.285714,3377.714286,650.3285714,164.3857143,1384.5,3700.371429,1266.257143,173.3142857,3198.057143,1024.542857,865.9571429,70,11.15080038,8.448213062,0.652680942,0.945945946,0.636363636,-1.11654423
+4114,37359.16456,918.6835443,498.5063291,1086.113924,31646.75949,724.8101266,827.3797468,1622.379747,18515.75949,565.9113924,1624.670886,1736.278481,22928.50633,1307.848101,3037.493671,3870.063291,8675.329114,1315.240506,320.278481,2674.113924,17532.48101,423.9367089,111.8481013,902.835443,21560.40506,859.1012658,127.2405063,2043.253165,17265.83544,1969.164557,506.2278481,2805.632911,14806.32911,625.278481,293.5822785,1334.063291,10404.94937,1916.721519,422.5443038,1321.240506,7217.139241,621.8734177,162.2025316,2004.860759,6573.78481,1407.797468,1197.303797,3206.56962,773.6962025,867.6075949,79,12.30218527,8.913474108,0.689228584,0.963414634,0.564285714,1.316000194
+4115,35842.75385,1154.553846,579.1846154,1107.969231,29778.93846,764.5384615,878.6461538,1650.892308,17434.43077,611.7230769,1430.076923,1792.2,21318.90769,1316.692308,2861.123077,2239.630769,8143.923077,1339.753846,309.3538462,2687.430769,16330.4,415.0615385,128.5230769,652.4153846,20487.06154,486.8769231,130.5230769,1931.676923,15854.49231,2050.861538,454.4153846,2813.307692,13748.15385,647.8923077,279.3384615,1284.769231,9219.246154,1047.030769,431.7384615,1297.476923,6061.969231,606.0153846,159.9384615,1683.569231,5675.384615,1281.876923,363.9692308,3416.953846,857.6461538,868.0769231,65,12.04069638,7.565139452,0.777973167,0.928571429,0.492424242,-0.65523597
+4116,31207.12397,948.107438,601.0826446,1082.876033,25757.55372,697.9586777,606.1404959,1658.07438,13100.15702,764.553719,1420.818182,1741.115702,17496.28099,1207.264463,2613.652893,2787.471074,6401.347107,1227.53719,314.0909091,2339.371901,13238.99174,640.3719008,1499.082645,1306.578512,16616.83471,1117.694215,121.3057851,1929.719008,12729.17355,1823.553719,404.8181818,2799.760331,10694.04132,760.2396694,280.8181818,979.107438,6769.181818,1151.53719,392.9421488,1365.694215,3977.710744,1049.702479,152.9173554,3407.272727,4116.140496,1214.603306,779.2809917,3372.487603,948.3636364,868.5454545,121,15.0769982,10.54497614,0.714722444,0.916666667,0.785714286,0.112545891
+4117,22442.98026,791.3815789,454.1184211,1067.131579,20627.43421,635.4539474,611.2434211,1577.809211,10161.88816,516.75,465.9473684,1790.078947,13239.75658,1184.934211,1876.322368,1509.342105,4912.236842,1262.572368,295.5986842,2263.875,10847.47368,372.8552632,162.9539474,462.5,13396.89474,460.8289474,120.7763158,1322.789474,10056.75658,1390.302632,334.4671053,2836.302632,8931.519737,591.4473684,275.9605263,1422.013158,5159,888.2302632,413.6118421,1306.368421,3837.960526,1116.559211,160.8355263,2255.690789,3482.394737,1422.381579,3869.085526,3188.013158,298.9605263,870.6776316,152,18.04807753,12.51736744,0.720401918,0.791666667,0.527777778,0.532021001
+4118,21026.61842,837.8026316,488.1973684,1065.289474,18924.73684,664.9078947,752.1842105,1792.684211,9421.605263,534.5263158,501.4342105,1896.763158,11849.55263,1173.684211,1968.289474,2357.197368,4334.065789,1254.460526,308.1447368,2283.486842,9551.039474,391.2368421,349.8157895,466.2105263,11509.14474,433.9736842,122.3421053,1107.236842,8779.815789,1426.697368,327.0789474,2816.197368,7859.894737,723.9473684,269.1578947,1402.921053,4523.868421,1089.026316,416.2368421,1308.302632,3358.657895,4150.078947,156.8157895,1457.118421,3061.868421,2193.131579,332.0657895,3215.828947,307.8815789,867.9605263,76,12.61668151,7.982977831,0.774370871,0.938271605,0.64957265,-0.306309208
+4119,32730.54118,927.9411765,468.3764706,1064.882353,29068.95294,741.0941176,407.9058824,1517.341176,17605.68235,548.1176471,756.6941176,1691.270588,21144.49412,1420.4,1411.529412,1765.341176,7814.364706,1325.058824,328.2823529,2299.423529,17034.47059,479.5647059,116.0588235,537.9529412,21145.18824,592.2470588,124.6470588,1179.058824,16608.65882,1483.858824,737.1058824,2792.094118,14463.88235,622.7176471,295.2117647,2113.047059,10817.81176,1183.141176,435.5529412,1310.811765,7759.988235,656.6705882,174.2588235,3452.658824,7230.376471,1627.152941,5034.705882,3241.635294,661.4352941,868.8588235,85,12.2687322,8.97109598,0.682145762,0.95505618,0.726495726,0.253153097
+4120,23104.72059,935.5441176,615.4264706,1047.823529,20611.05882,735.5147059,932.5147059,1521.588235,12813.52941,751.1323529,1994.838235,1812.294118,15318.60294,1351.985294,2233.852941,2572.794118,5738.970588,1287.058824,302.0441176,2545.735294,12010.70588,410.4852941,654.9411765,1699.455882,14845.42647,537.4264706,672.1029412,1028.161765,11652.79412,1910.426471,479.4411765,2791.676471,10280.29412,693.0588235,273.7647059,1217.205882,7317.911765,1018.852941,410.9411765,1345.926471,5332.308824,741.3088235,161,3111.602941,4912.426471,1321.352941,887.4558824,3238.970588,722.1176471,867.4852941,68,10.1811087,8.588781693,0.536972351,0.971428571,0.755555556,-0.521710948
+4121,14601.63934,786.6721311,451.0983607,1051.45082,13255.64754,639.0245902,592.0901639,1504.098361,6992.983607,495.0163934,473.8360656,1746.237705,8834.959016,1180.303279,1343.655738,1062.54918,3302.098361,1236.286885,288.4672131,2288.07377,7549.57377,367.0491803,159.3360656,518.2295082,9081.606557,467.3852459,123,1428.770492,6985.245902,1378.819672,411.6639344,2848.065574,6380.5,617.9918033,271.6639344,1654.147541,3896.827869,843.5491803,408.6803279,1318.655738,2920.262295,883.852459,164.1557377,2199.663934,2688.336066,1391.581967,4409.090164,3183.778689,315.9180328,871.2213115,122,15.7813425,10.1088683,0.767909628,0.910447761,0.625641026,-0.511168223
+4122,23839.72727,952.6262626,473.9494949,1069.787879,22317.18182,758.6262626,453.969697,1474.545455,12486.36364,570.5050505,930.2020202,1706.454545,16162.31313,1392.30303,996.7676768,2578.656566,5660.151515,1287.444444,313.3838384,2305.131313,12561.31313,476.2424242,149.2222222,754.6363636,15954.52525,863.2121212,122.7474747,904.5050505,12311.26263,1528.111111,721.989899,2786.626263,10632.9697,610.4949495,271.5555556,2116.939394,7955.969697,1269.616162,408.0707071,1324.545455,5829.232323,637.3030303,183.4646465,3735.858586,5515.878788,1558.787879,6609.939394,3212.424242,671.4949495,868.5757576,99,12.04216295,10.93345969,0.419118477,0.951923077,0.818181818,1.443892648
+4123,29132.73134,1037.223881,561.3134328,1065.283582,24176.20896,728.9402985,662.3432836,1499.104478,13973.01493,636.1343284,629.5671642,1716.641791,18288.35821,1279.41791,2851,2949.776119,6538.492537,1255.328358,295.2835821,2340.970149,13330.43284,456.6567164,218.880597,867.7164179,16632.02985,687.1791045,117.8358209,2586.447761,13295.92537,1526.80597,631.1940299,2791.985075,11433.08955,574.9253731,246.7462687,1354.313433,8119.522388,819.8955224,394.0447761,1300.656716,5666.283582,616.3432836,148.3134328,2143.432836,5421.238806,1262.746269,1160.059701,3286.343284,760.8059701,868.5522388,67,9.893167663,8.785254835,0.459819647,0.905405405,0.67,-1.444589126
+4124,30876.224,914.944,583.456,1096.8,20635.88,706.008,730.952,1583.984,10588.136,517.008,1795.664,1820,14919.144,1176.2,3112.12,2756.536,5560.816,1191.704,291.008,2560.296,11319.984,391.536,502.608,2030.8,14464.744,524.688,618.728,3067.536,10909.824,2216.032,400.56,2801.664,9178.648,742.616,256.352,1016.768,5971.28,1063.416,388.792,1317.728,3584.592,716.528,150.288,3244.384,3605.04,1169.32,1151.896,3391.928,937.696,870.36,125,14.81552912,11.11052838,0.661523419,0.919117647,0.744047619,0.007569202
+4125,30917.84685,920.2432432,600.8378378,1108.225225,27104.9009,748.3783784,1014.072072,1662.603604,14971.09009,615.7567568,1395.207207,1829.630631,18025.54955,1324.531532,4747.477477,4189.756757,6736.963964,1373.324324,330.5765766,4417.990991,14955.11712,415.1891892,1555.855856,1578.63964,18083.12613,476.2792793,137.5225225,2606.207207,13769.72072,2369.072072,482,2819.171171,12337.88288,823.9099099,300.6396396,1699.657658,7660.756757,1234.72973,450.963964,1441.207207,5630.324324,1031.072072,176.1531532,4464.387387,5069.666667,1397.072072,1720.126126,3268.963964,336.4054054,871.4774775,111,14.62550931,9.976411014,0.731236514,0.932773109,0.566326531,0.802454685
+4126,26646.36601,923.6666667,510.0718954,1090.588235,24381.51634,733.3856209,702.1764706,1556.013072,13471.96732,570.1830065,1130.810458,1826.464052,16580.21569,1315.882353,3327.738562,3059.718954,6086.509804,1379,330.3856209,2321,13311.72549,401.8627451,1323.346405,1016.424837,15776.30065,623.3529412,138.8366013,2182.522876,12268.94118,1723.947712,485.8562092,2816.183007,11100.6732,1079.803922,299.8888889,1619.699346,7084.183007,1372.45098,440.9281046,1334.20915,5226.875817,881.0653595,174.9542484,3296.48366,4658,1419.830065,2482.607843,3215.496732,354.7973856,870.4313725,153,20.18591575,10.03942589,0.867551102,0.884393064,0.607142857,-1.188699276
+4127,37203.824,923.28,505.504,1097.448,34297.016,759.736,794.368,1644.984,18832.984,595.864,1227.072,1770.8,23212.32,1341.632,2281.704,3407.208,8419.4,1435.6,343.168,2432.552,18658.576,415.344,551.664,931.84,22583.096,479.08,189.624,1917.752,17681.928,1858.288,537.904,2821.944,15674.176,757.928,321.536,1742.168,10271.48,1184.768,463.616,1369.912,7560.088,751.264,179.976,4447.144,6864.336,1465.576,725.864,3294.656,374.24,872.6,125,17.43064013,9.70047342,0.830835229,0.905797101,0.525210084,0.644638735
+4128,33231.55034,935.0067114,669.9597315,1134.926174,30282.51007,795.557047,1057.912752,1700.087248,17499.97987,599.0738255,1610.61745,1851.872483,21118.36242,1378.503356,2974.691275,2997.302013,7581.95302,1410.154362,341.852349,2496.416107,16621.56376,459.6442953,308.9530201,1019.261745,20259.02685,475.409396,434.3020134,1799.221477,15819.71141,2164.416107,479.8657718,2814.147651,13923.72483,711.0939597,308.6510067,1524.516779,9880.436242,1134.731544,467.852349,1345.322148,7307.281879,678.7852349,177.6845638,3012.530201,6392.38255,1431.704698,417,3345.422819,525.9261745,872.8053691,149,19.93028846,10.36496898,0.854129023,0.881656805,0.515570934,0.70966873
+4129,29139.87129,917.0990099,783.0891089,1128.247525,27312.45545,739.4752475,1034.663366,1679.445545,15097.41584,587.2574257,746.7821782,1794.544554,18085.78218,1339.316832,2016.019802,1445.207921,6454.287129,1473.693069,329.950495,2423.712871,14273.36634,467.6534653,317.4653465,538.2871287,17473,488.9405941,149.4752475,1681.821782,13469.38614,1689.623762,464.2772277,2827.148515,11938.88119,1680.267327,308.960396,1420.356436,8425.019802,951.049505,453.7524752,1358.970297,6321.435644,673.009901,168.5049505,1653.910891,5498.841584,1422.950495,327.0693069,3415.237624,536.8019802,871.3663366,101,13.36294554,10.57756017,0.611092715,0.863247863,0.561111111,-0.578304043
+4130,28186.96429,842.9880952,451.6071429,1065.345238,24667.45238,702.8333333,640.25,1519.27381,15288.21429,520.297619,492.6904762,1679.119048,17679.20238,1247.928571,1148.22619,2061.214286,6637.52381,1278.238095,283.2738095,2323.654762,14730.64286,417.3571429,191.9047619,490.5,18015.46429,532.7142857,116.8095238,1347.714286,14389.65476,1347.119048,620.0714286,2783.952381,12823.45238,638.5833333,268.2619048,1880.380952,9205.845238,866.2738095,396.6071429,1322.142857,6658.857143,658.6666667,154.4404762,1885.214286,6218.345238,1483.285714,5948.75,3163.380952,620.1904762,871.1071429,84,12.34534192,9.246352106,0.662598289,0.923076923,0.545454545,0.630518933
+4131,28967.61818,858.9090909,511.3636364,1103,24123.87273,699.5636364,662.6181818,1672.054545,11423.14545,554.6909091,876.2,1695.472727,15768.96364,1264.418182,2887.381818,1830.345455,6073.163636,1256.618182,314.1636364,2288.563636,12518.49091,411.8181818,653.6363636,985.9454545,15886.41818,458.4545455,126.2909091,1729.8,12126.50909,1804.927273,375.5454545,2865.345455,10036.56364,760.4545455,277.4909091,901.2727273,5783.818182,912.1272727,394.5272727,1309.4,3252.963636,690.3636364,154.6181818,2169.690909,3445.072727,1245.436364,1212.654545,3159.272727,1003.309091,868.0545455,55,11.64808809,6.953117674,0.802291761,0.873015873,0.572916667,-1.524336826
+4132,26375.89308,896.7672956,480.5660377,1075.427673,23505.15094,722.9622642,613.163522,1566.427673,13530.06918,563.6100629,665.2767296,1723.163522,16220.12579,1320.125786,2707.433962,2024.081761,5986.899371,1420.641509,322.2515723,2423.962264,13332.27673,472.6603774,602.7861635,575.0251572,15998.40252,663.6226415,131.5471698,1151.987421,12785.36478,1823.289308,663.4465409,2833.628931,11425.77987,1036.597484,298.6792453,1491.081761,7665.616352,1014.138365,457.2578616,1325.408805,5690.36478,757.5157233,176.0251572,2869.408805,5197.559748,1466.018868,2250.72956,3258.578616,397.2830189,874.4716981,159,18.07165094,11.42193697,0.774938891,0.963636364,0.679487179,0.25268042
+4133,32501.16842,1020.694737,671.9578947,1137.136842,29519.02105,744.8421053,782.9789474,1652.957895,16495.87368,583.6315789,739.0947368,1794.105263,19871.82105,1343.336842,2215.484211,2162.936842,7339.673684,1460.926316,336.5578947,2386.315789,16048.4,420.5473684,208.8736842,759.3789474,19443.03158,591.3263158,154.8105263,1354.842105,15520.13684,1652.926316,504.2736842,2828.231579,13641.86316,743.9684211,312.4,1614.2,9254.505263,960.9052632,459.8526316,1340.789474,6937.926316,661.1368421,186.0421053,1753.526316,6193.305263,1472.726316,1826.315789,3309.663158,450,871.4736842,95,14.74765943,8.373560388,0.823174058,0.95959596,0.56547619,-1.007672416
+4134,17954.13187,886.4395604,900.8461538,1137.67033,16876.61538,727.1318681,932.6043956,1670.637363,9077.868132,548.7362637,595.0549451,1811.043956,11349.52747,1298.054945,897.6153846,1036.791209,4363.802198,1438.351648,328.1978022,2441.494505,9328.736264,464.2967033,123.9340659,580.9230769,11502.46154,474.7802198,128.2197802,893.1978022,8663.802198,1505.67033,445.3736264,2809.758242,7728.714286,692.5934066,300.5274725,2094.362637,5475.43956,1008.802198,454.989011,1379.472527,4155.989011,622.956044,171.7692308,1282.593407,3796.956044,1431.021978,198.3956044,3373.472527,489.3626374,870.6153846,91,12.07523584,9.934020066,0.56850891,0.957894737,0.689393939,1.252383101
+4135,18315.83333,1054.020833,530.2604167,1031.729167,17839.48958,739,575.9583333,1423.041667,8352.572917,638.4583333,641.40625,1759.0625,11761.48958,1235.625,3198.677083,3207.708333,4028.322917,1228.416667,279.1875,2295.96875,8059.21875,740.9895833,393.0520833,865.5,10514.21875,480.96875,137.5833333,2075.927083,7543.03125,1585.34375,699.1145833,2782.71875,6559.333333,628.0520833,238.6666667,1520.572917,4810.239583,829.5208333,377.0104167,1326.197917,3639.5,641.1875,151.7916667,2247.270833,3153.427083,1240.78125,1755.4375,3292.520833,753.9791667,874.0208333,96,16.81155629,8.166456967,0.874089736,0.780487805,0.545454545,0.426585201
+4136,28440.39604,1074.336634,593.6237624,1099.831683,22750.70297,742.029703,935.4851485,1583.752475,12728.69307,642.7722772,1709.267327,1746.138614,16718.83168,1310.70297,2141.881188,2549.138614,5787.336634,1255.435644,311.8811881,2532.742574,11843.14851,426.039604,437.8019802,1503.247525,14955.34653,493.6633663,129.4851485,1256.267327,11444.23762,2249.762376,419.950495,2802.386139,9901.544554,1069.336634,269.1584158,1101.009901,6643.485149,1130.60396,405.8316832,1338.70297,4387.752475,699.8712871,161.0594059,1850.405941,4344.326733,1275.227723,704.7623762,3408.445545,865.990099,871.6732673,101,11.82093816,11.19500165,0.321090572,0.935185185,0.647435897,-0.745617743
+4137,27604.79487,913.1987179,584.3076923,1086.371795,24335.89744,707.5576923,750.1474359,1620.397436,13712.08974,875.4423077,1128.147436,1746.826923,16561.25641,1245.891026,3875.717949,2685.384615,6394.987179,1262.025641,313.6410256,2505.141026,13463.25641,412.3333333,519.724359,984.4615385,17543.5641,468.1538462,123.4230769,2209.512821,13192.75,1741.891026,451.6089744,2797.602564,11359.41026,655.8974359,284.2371795,1269.294872,7763.217949,1234.801282,414.6987179,1370.525641,4908.461538,740.1666667,159.1410256,2871.814103,4880.839744,1305.339744,861.4487179,3274.685897,880.1858974,874.9358974,156,18.63925456,11.36619051,0.792556447,0.825396825,0.586466165,-0.309994287
+4138,44002.97436,875.991453,523.3333333,1096.982906,36681.92308,729.1880342,827.4529915,1689.709402,19928.13675,539.9487179,1832.461538,1835.034188,26064.81197,1240.538462,3369.726496,3386.803419,9819,1294.521368,321.7008547,2364.444444,20375.46154,501.3333333,788.3333333,1599.358974,25230.29915,489.6581197,279.025641,1267.188034,19683.97436,2484.547009,428.4871795,2820.564103,16717.4188,650.3162393,298.8119658,977.3846154,10565.58974,1304.34188,432.957265,1323.735043,6246.273504,792.025641,156.7179487,2419.435897,6371.760684,1306.521368,172.8974359,3305.401709,925.1880342,871.1367521,117,15.93042181,10.3934306,0.757851937,0.829787234,0.609375,1.219964997
+4139,16901.43902,775.7398374,421.6504065,1063.300813,15553.09756,623.0406504,557.796748,1568.747967,7967.341463,501.1707317,552.8617886,1761.99187,10348.26829,1201.073171,1389.308943,1004.837398,3920.723577,1225.04878,285.6097561,2259.780488,8610.439024,365.1463415,137.3089431,541.5609756,10491.95935,443.3821138,119.7154472,1038.252033,8107.130081,1401.414634,314.6585366,2890.902439,7207.650407,584.9186992,267.0162602,1157.00813,4157.186992,776.7317073,403.3821138,1315.382114,3026.878049,629.7642276,158.1056911,2373.747967,2790.739837,1310.325203,6082.894309,3164.772358,287.0325203,872.8211382,123,13.80947598,11.77521831,0.522415312,0.953488372,0.732142857,1.551507869
+4140,26610.19626,847.1028037,422.7102804,1055.719626,24479.36449,696.7943925,569.7476636,1481.64486,13825.95327,542.8878505,1161.401869,1708.102804,16937.91589,1279.803738,1441.803738,2078.663551,6368.588785,1541.719626,302.5420561,2356.495327,13099.60748,450.2897196,313.8598131,558.5794393,16053.94393,979.2897196,154.4766355,891.1401869,12338.20561,1380.364486,618.411215,2794.102804,10769.26168,621.7476636,272.3084112,1651.457944,7834.158879,1445.943925,400.2429907,1303.672897,5878.869159,702,151.4205607,1711.102804,5111.158879,1526.878505,10784.26168,3164.841121,632.3271028,871.682243,107,13.74003179,10.60576283,0.635758786,0.899159664,0.636904762,-1.145231821
+4141,17922.35338,829.2932331,486.1654135,1065.691729,16644.6391,684.5413534,726.7593985,1552.496241,9019.593985,805.962406,554.518797,1754.616541,11833.85714,1231.390977,3036.894737,1881.142857,4400.804511,1233.458647,311.7518797,2342.443609,8989.729323,461.1954887,767.7293233,619.3082707,10904.40602,587.3834586,118.5413534,1269.578947,8766.691729,1720.571429,545.3834586,2792.24812,7611.406015,1061.390977,258.037594,1454.383459,5667.142857,896.0601504,398.4736842,1408.345865,4133.947368,837.2932331,156.8045113,2778.744361,3798.864662,1333.774436,1019.714286,3258.917293,706.6616541,873.2631579,133,16.46872059,10.97397049,0.745637016,0.956834532,0.738888889,-0.533997056
+4142,23696.58537,807.6146341,541.6731707,1085.892683,21328.21463,685.8390244,841.3853659,1657.170732,11034.99024,582.2634146,1389.126829,1795.02439,14393.77561,1164.878049,2871.556098,2797.731707,5556.053659,1202.858537,302.6341463,2512.829268,11382.34634,6235.331707,321.3268293,907.1365854,14458.97073,558.6682927,165.2243902,1299.673171,10766.00488,1784.307317,439.3804878,2786.156098,9128.839024,736.1121951,261.4829268,1188.170732,5934.04878,1976.15122,396.995122,1329.507317,3626.019512,673.8585366,153.5317073,3436.053659,3616.819512,1215.887805,837.5073171,3248.907317,911.697561,874.004878,205,18.22146514,14.74125373,0.587801962,0.949074074,0.709342561,0.640593541
+4143,38857.11236,897.8426966,555.7640449,1130.280899,26217.89888,608.6179775,945.2359551,1546.168539,11808.37079,618.7640449,1593.022472,1707.191011,17139.04494,1113.438202,4586.179775,2591.685393,6455.898876,1164.41573,279.3595506,2318.808989,13328.88764,364.0224719,527.8202247,1462.797753,16785.40449,548.6741573,113.6404494,1323.202247,13221.80899,2494.752809,361.6966292,2775.044944,10857,717.5393258,246.3595506,856.3033708,6036.764045,1186.988764,380.8202247,1291.191011,3339.157303,665.4494382,145.4494382,2141.662921,3639.955056,1103.213483,333.3033708,3202.134831,1010.617978,872.3707865,89,12.90020041,9.114412776,0.707680447,0.936842105,0.622377622,-1.065388904
+4144,37359.1844,1011.659574,703.4326241,1191.695035,22904.51773,628.9574468,482.5035461,1567.156028,10924.68794,494.3262411,928.8085106,1719.503546,15030.05674,1174.58156,7167.212766,2993.113475,5749.829787,1226.163121,294.4822695,2308.950355,12172.6383,367.0921986,561.7588652,692.2553191,14772.50355,410.3546099,144.0070922,3954.595745,11171.46809,1789.106383,378.8794326,2821.326241,9786.319149,600.4893617,273.1276596,1147.716312,4625.234043,906.1631206,404.5035461,1299.361702,3350.496454,707.5886525,155.3262411,2018.234043,3192.41844,1187.382979,972.5602837,3189.765957,245.3333333,874.8014184,141,17.66820744,10.37626371,0.809380603,0.94,0.5875,-0.730601931
+4145,28616.10042,994.8284519,733.5732218,1141.711297,25739.79079,782.2887029,915.9330544,1713.719665,14645.43096,602.3933054,789.7824268,1804.506276,17602.11297,1357.786611,2170.92887,2992.439331,6462.125523,1400.112971,330.8158996,2408.292887,13769.92887,552.7364017,164.1882845,868.7656904,16815.20502,534.6443515,148.9790795,2400.16318,12921.75314,1564.301255,541.6276151,2818.820084,11438.41423,727.2426778,301.4979079,1845.301255,8054.012552,1005.435146,452.6066946,1348.485356,5953.171548,636.6903766,172.1087866,2521.832636,5203.334728,1410.267782,213.5271967,3336.154812,511.3430962,876.7991632,239,19.29326013,16.87570513,0.484674983,0.885185185,0.598997494,-1.004200974
+4146,35522.53521,853.6056338,520.0985915,1099.15493,33111.50704,710.4647887,822.5633803,1686.873239,19622.66197,557.5774648,1191.084507,1770.859155,23510.67606,1303.408451,3553.366197,3784.323944,8176.619718,1358.014085,312.5070423,2549.647887,18341.22535,423.084507,210.7042254,792.028169,22409.52113,573.8169014,148,1975.619718,17726.16901,1880.84507,584.2957746,2814.521127,15324.3662,623.7605634,298.1126761,1316.225352,10798.87324,1154.028169,441.8873239,1332.338028,7933.239437,645.4507042,167.7887324,2579.126761,7183.816901,1373.647887,234.0985915,3295.126761,569.3380282,873.0422535,71,10.33646092,8.863882156,0.514424796,0.922077922,0.645454545,0.355993434
+4147,19237.78075,814.4705882,576.5561497,1096.518717,17227.97861,645.973262,589.0534759,1588.037433,8978.946524,950.8181818,562.8342246,1757.791444,12002.98396,1169.139037,1803.855615,1743.262032,4626.593583,1200.668449,325.0106952,2366.673797,9072.84492,411.144385,795.0909091,691.513369,11634.13369,497.1122995,117.7700535,1487.716578,8830.780749,1593.438503,453.7593583,2804.823529,7517.304813,733.8235294,253.5668449,1211.743316,5109.823529,934.7326203,394.171123,1379.283422,3250.566845,801.9572193,154.1069519,2805.497326,3244.486631,1225.117647,470.2299465,3193.524064,893.2139037,875.0695187,187,19.00400102,12.82569436,0.7379143,0.968911917,0.647058824,-0.728572631
+4148,23411.98462,928.2923077,591.0615385,1114.969231,20568.46154,697.2461538,445.3846154,1688.553846,10019.66154,527.0153846,460.1384615,1756.569231,13415.64615,1276.846154,6048.953846,2636.584615,4804.630769,1280.123077,316.9846154,2295.738462,10300.21538,5515.230769,958.1538462,445.5076923,12487.69231,441.1846154,130.5692308,7546.584615,9510.753846,1450.923077,398.0461538,2797.2,8201.938462,665.2,287.0769231,1180.046154,4405.615385,848.2923077,418.9538462,1306.092308,3192.353846,813.6769231,173,5626.292308,2942.615385,1292.384615,1991.815385,3206.107692,272.1230769,873.0153846,65,10.33613656,8.121839749,0.618517114,0.955882353,0.656565657,1.492928914
+4149,35194.90566,1018.037736,593.9811321,1080.245283,32748.92453,761.2264151,944.9811321,1592.830189,18943.64151,622.2830189,1796.264151,1736.735849,22291.77358,1352.471698,3377.90566,3158.056604,7760.339623,1309.207547,301.3773585,2737.377358,17199.13208,606.8490566,144.9433962,953.0754717,21910.07547,1748.264151,137.3396226,1196.849057,16763.75472,1725.773585,519.1886792,2802.415094,14347.13208,640.9245283,295.2830189,1158.150943,9989.830189,1181.226415,441.8113208,1330.641509,7532.773585,628,164.5283019,2262.056604,6638.566038,1344.679245,356.5849057,3396.660377,578.6226415,871.7169811,53,11.3399294,6.049853926,0.845799976,0.963636364,0.688311688,1.232758635
+4150,31860.16049,920.8024691,440.1975309,1066.407407,29001.83951,770.1111111,588.6049383,1552.061728,16785.95062,582.0493827,1393.432099,1719.259259,20157.87654,1436.135802,1606.185185,2010.925926,7070.049383,1374.469136,313.3950617,2431.444444,15948.34568,656.7283951,143.0987654,708.2962963,19969.07407,1249.962963,713.2962963,969.5185185,15399.5679,1499.641975,591.5432099,2802.209877,13319.22222,669.4938272,294.9259259,1560.407407,9548.259259,1487.283951,429.9382716,1297.814815,6906.876543,645.0246914,169.8271605,2027.246914,6075.716049,1566.802469,4738.506173,3216.814815,639.8024691,875.4938272,81,16.47821609,6.658627258,0.914720708,0.870967742,0.482142857,-0.660016524
+4151,21117.84921,929.9126984,467.2142857,1034.801587,19230.7619,735.0634921,788.3888889,1557.825397,10855.53175,740.8492063,1097.404762,1767.428571,13464.15873,1321.436508,2554.539683,3012.84127,4948.47619,1250.190476,300.0396825,2483.02381,10317.45238,1546.34127,499.8253968,679.4206349,12560.59524,714.7063492,116.968254,1521.746032,10088.07143,1545.031746,638.8412698,2782.253968,8763.388889,765.7142857,267.1507937,1462.97619,6376.277778,1451.396825,403.7857143,1355.968254,4642.920635,723.1349206,157.5,2570.571429,4200.531746,1362.595238,448.2698413,3262.547619,696.0238095,875.7301587,126,15.44873567,10.66832979,0.723271966,0.940298507,0.763636364,0.09393026
+4152,25187.14667,1005,551.2533333,1073.873333,22348.18,715.4066667,616.5333333,1521.466667,12110.06667,566.5866667,1250.853333,1755.626667,15546.27333,1263.953333,2774.54,4240.833333,5538.4,1270.14,293.0733333,2357.14,11722.98,389.0666667,117.6933333,1275.153333,14785.34,595.7,121.4533333,2510.966667,11324.74667,1897.873333,509.62,2786.86,9668.346667,626.04,273.8133333,1450.36,6495.186667,1192.833333,393.4066667,1287.7,4518.953333,585.9266667,159.1333333,2716.413333,4285.12,1243.173333,309.14,3364.393333,827.3666667,875.4066667,150,16.13220658,11.87131368,0.677115646,0.955414013,0.714285714,-0.844825048
+4153,28216.48889,836.7111111,572.2111111,1083.144444,25292.94444,669.3444444,776.3666667,1704.388889,11865.62222,555.3222222,1773.055556,1796.288889,16550.74444,1172.366667,4542.055556,4654,6373.744444,1371.166667,379.2777778,2412.055556,13093.15556,436.6555556,1246.011111,1581.822222,16703.98889,791.7777778,123.4666667,2426.311111,12406.1,2302.611111,445.9111111,2801.888889,10243.31111,640.7,264.4222222,1095.133333,6165.711111,1783.288889,405.3444444,1322.977778,3528.066667,1200.611111,155.4333333,3298.766667,3686.133333,1212.044444,362.4777778,3268.133333,980.6777778,873.5,90,12.99018122,9.285266801,0.699337963,0.927835052,0.629370629,-1.375205089
+4154,32836,943.7692308,644.2,1090.076923,30440.86154,763.5692308,680.4307692,1646.292308,16496.46154,593.2769231,1823.615385,1821.569231,19959.49231,1303.907692,3210.523077,4746.892308,7392.261538,1387.784615,335.0769231,2415.246154,16285.8,406.6153846,542.7846154,1243.676923,19000.15385,547.6,143.4923077,2639.076923,14979.76923,2075.584615,953.5230769,2828.2,13615.18462,628.6153846,308.0461538,1540.6,8665.969231,2011.630769,450.5076923,1343.707692,6441.076923,707.4461538,191.9692308,8739.892308,5661.723077,1417.030769,562.3846154,3274.323077,365.4923077,874.6923077,65,11.78204618,7.461075537,0.773940726,0.915492958,0.541666667,1.136925125
+4155,26099.43023,822.6627907,646.6162791,1081.837209,17750.33721,586,589.5813953,1542.116279,7717.604651,673.5581395,846.5930233,1692.023256,11128.39535,1058.348837,5171.406977,2891.337209,4447.988372,1308.953488,272.5232558,2365.453488,9160.081395,346.5,660.9651163,634.744186,11787.11628,732.2906977,113.9883721,2752.848837,8909.872093,1805.302326,379.6744186,2781.813953,7328.755814,600.127907,233.5116279,946.6511628,4094.976744,984.3372093,362.0697674,1291.465116,2294.930233,690.6860465,148.6744186,2932.848837,2472.290698,1056.569767,933.0116279,3097.348837,1020.267442,876.1860465,86,12.65666064,8.806394653,0.718243994,0.934782609,0.661538462,-0.002879625
+4156,22571.8932,750.2524272,505.0776699,1045.650485,18547.75728,587.3398058,501.4660194,1471.436893,7567.378641,659.4854369,863.4757282,1669.776699,11830.5534,1094.912621,2097.902913,1784.058252,4476.368932,1296.038835,271.4368932,2338.194175,9233.475728,354.7087379,546.5631068,712.8834951,11795.49515,402.3398058,111.0776699,2437.621359,8924.058252,1625.679612,370.3300971,2800.145631,7205.572816,607.776699,229.6019417,891.2038835,3985.165049,838.3300971,364.961165,1282.398058,2227.854369,660.2815534,144.3300971,2896.980583,2444.970874,1114.38835,4847.854369,3078.514563,1029.184466,876.6893204,103,13.34422198,10.88859008,0.578083112,0.851239669,0.66025641,0.025862607
+4157,28833.81203,1112.473684,749.6390977,1123.533835,21258.4812,594.962406,381.3984962,1468.225564,10185.00752,481.3233083,484.5789474,1674.022556,14181.93233,1115.488722,4886.81203,2135.180451,5170.451128,1151.526316,263.0827068,2257.714286,11071.1203,425.6015038,232.2857143,492.3157895,13260.05263,357.7142857,111.0300752,3721.353383,10510.65414,1410.12782,335.5037594,2780.398496,9221.75188,532.3157895,247.7443609,1044.661654,4388.496241,785.0526316,369.6842105,1288.308271,3101.646617,579.0676692,148.112782,2256.93985,3022.526316,1111.180451,170.2631579,3206.721805,252.2932331,880.7969925,133,18.06876882,10.28446132,0.8222099,0.904761905,0.558823529,-0.607826424
+4158,22578.74545,993.4272727,741.2909091,1105.036364,19122.73636,592.9545455,417.7272727,1551.027273,8879.363636,489.9636364,460.4909091,1735.3,12099.04545,1136.1,6125.636364,1774.536364,4588.272727,1182.936364,279.4909091,2265.9,9855.018182,6486.245455,479.2727273,417.8454545,12030.64545,439.0090909,117.8727273,3903.245455,9159.463636,1391.863636,338.0545455,2812.727273,8130.554545,619.5727273,268.1272727,1068.890909,4211.272727,827.3545455,383.6636364,1303.690909,3032.854545,704.8545455,151.0909091,3099.954545,2849.518182,1172.454545,319.1727273,3218.5,263.3545455,876.9818182,110,14.68841339,9.958887378,0.735052916,0.924369748,0.705128205,0.786152507
+4159,34763,1063.96,605.44,1085.813333,29950.04,797.9466667,746.48,1620.186667,17097.14667,624.3333333,1287.56,1754.12,20617.26667,1359.746667,2581.933333,2716.24,7395.226667,1441.533333,338.5333333,2341.28,16094.97333,478.6666667,448.1733333,1098.093333,19336.30667,457.1866667,345.7333333,1877.24,15472.14667,2048.066667,590.96,2815.293333,13615.14667,729.04,303.5866667,1395.8,8967.626667,1147.386667,448.5866667,1326.84,6695.933333,715.0933333,174.32,3546.08,5976.666667,1376.373333,273.1066667,3425.986667,418.3866667,876.48,75,12.13746349,8.615687368,0.704360442,0.862068966,0.619834711,0.51063641
+4160,23532.37349,1058.963855,641.060241,1093.204819,21258.77108,776.9277108,608.9036145,1573.614458,11709.85542,620.746988,624.0843373,1762.927711,13966.61446,1334.26506,2765.927711,2403.903614,4782.072289,1532.024096,307.3975904,2324.891566,10524.33735,397.6626506,1108.891566,562,12489.78313,434.8192771,127.1445783,2172.180723,10092.26506,1593.156627,514.4819277,2812.144578,8954.927711,688.253012,283.4337349,1313.951807,5874.674699,870.4096386,427.060241,1364.349398,4328.795181,869.0240964,174.4578313,4216.686747,3762.506024,1340.686747,206.5783133,3346.26506,427.1927711,875.7349398,83,10.79164525,10.43580607,0.254676076,0.943181818,0.685950413,-1.280120918
+4161,29509.06338,1096.598592,736.8732394,1124.521127,26442.96479,804.1197183,868.4859155,1660.161972,14624.60563,627.5492958,1159.274648,1772.978873,17448.1831,1401.366197,2199.295775,2082.204225,6338.816901,1474.669014,332.443662,2362.450704,13622.03521,435.4788732,137.8450704,1010.619718,16303.88732,487.0070423,135.6056338,956.7605634,12816.10563,1972.295775,436.8450704,2828.802817,11280.0493,629.2394366,307.584507,1474.049296,7515.901408,1170.119718,449.2746479,1327.676056,5620.683099,620.9084507,169.9577465,1191.669014,4874.690141,1384.021127,223.3309859,3433.373239,458.6056338,877.2746479,142,15.37469022,11.88831581,0.634114243,0.959459459,0.676190476,-1.010863728
+4162,39643.5814,1017.244186,750.2674419,1405.534884,34455.17442,846.1627907,1053.848837,1985.27907,19571.97674,662.8372093,1384.069767,1870.337209,24005.61628,1394.55814,2240.290698,4408.046512,8349.569767,1463.77907,339.372093,2449.639535,18194.2907,454.2674419,277.0581395,608.2325581,22073.22093,524.1395349,174.255814,2178.267442,17557.86047,2059.848837,538.127907,2836.744186,15452.94186,670.627907,331.1046512,1939.360465,10465.04651,1316.139535,474.7790698,1356.05814,7559.465116,671.6046512,180.1395349,2262.244186,6703.395349,1457.232558,194.2790698,3392.44186,471.7209302,875.2093023,86,11.43373463,10.06822853,0.473912072,0.914893617,0.710743802,-0.545204458
+4163,25686.51572,911.5283019,663.245283,1324.566038,23455.40252,725.2389937,780.3962264,1794.333333,12513.68553,571.3459119,924.7295597,1834.006289,15458.93082,1296.062893,1759.069182,2511.91195,5791.748428,1400.981132,316.0503145,2529.91195,12458.45283,434.7735849,208.5597484,549.3018868,15033.03145,589.0691824,129.3773585,1505.176101,11594.54088,1590.622642,463.5974843,2831.069182,10282.91824,637.591195,297,2300.150943,7043.194969,1131.503145,448.4402516,1347.503145,5333.283019,645.5408805,171.7861635,3352.201258,4700.113208,1405.761006,315.8176101,3331.779874,481.1761006,879.3584906,159,17.05503674,12.46104705,0.682765733,0.924418605,0.719457014,-0.233259892
+4164,25017.27481,1033.198473,1804.450382,1250.076336,22695.94656,796.1068702,1586.267176,1911.198473,13237.39695,614.0305344,1423.480916,1856.068702,15453.66412,1374.419847,2553.770992,2482.022901,5539.358779,1443.717557,333.0152672,3003.610687,12357.43511,524.6946565,316.0992366,742.5877863,14885.42748,479.2671756,136.9389313,1304.732824,11610.0687,1844.51145,482.8320611,2832.832061,10317.12214,726.7175573,308.5419847,1534,7239.29771,1031.007634,471.9389313,1410.152672,5311.938931,665.5572519,174.0305344,3152.335878,4802.648855,1392.625954,307.8549618,3428.694656,557.3740458,877.5877863,131,15.85779244,10.8592945,0.728738277,0.909722222,0.668367347,-0.743705213
+4165,30984.34375,1134.822917,551.0833333,1084.854167,28413.63542,792.6875,680.7083333,1631.322917,16171.28125,617.8020833,918.9270833,1764.427083,18538.84375,1378.208333,3359.8125,3253.395833,6468.697917,1304.90625,299.71875,2379.583333,13674.52083,411.4166667,132.7291667,839.40625,16601.35417,1059.708333,118.8020833,2154.541667,13023.3125,1486.479167,559.2395833,2797.052083,11287.02083,623.6875,286.2395833,1380.895833,7826.083333,1154.895833,408.8958333,1305.354167,5638.229167,592.5,150.4270833,1748.666667,4579.697917,1268.59375,304.6770833,3359.333333,590.4791667,877.5,96,13.65027656,9.398386671,0.72522443,0.96969697,0.615384615,0.966143667
+4166,31072.94186,992.7093023,510.3837209,1097.534884,28577.53488,794.872093,742.8139535,1609.44186,16704.63953,594.1162791,938.5813953,1740.569767,20074.90698,1491.627907,860.9418605,1775.895349,7341.255814,1441.337209,339.0697674,2403.895349,15383.48837,505.627907,112.1162791,979.8372093,19052,705.6627907,136.8488372,805.5116279,14681.45349,1743.116279,595.1860465,2811.046512,12926.27907,827.4651163,305.9186047,1773.860465,9359.197674,1409.767442,440.744186,1323.069767,6929.546512,648.8604651,175.0465116,1874.593023,6079.94186,1598.348837,1487.872093,3196.953488,656.5465116,877.4767442,86,12.28733201,9.303741222,0.653204474,0.945054945,0.558441558,-0.012729042
+4167,25490.93103,881.7471264,480.0114943,1075.517241,21936.74713,697.3908046,538.6666667,1512.264368,12381.44828,684.1264368,415.6781609,1686.54023,15856.48276,1314.195402,1723.034483,2162.770115,5585.08046,1312.149425,308.137931,2264.873563,11558.98851,410.4252874,267.4597701,521.6896552,14206.62069,535.4252874,119.2183908,1267.114943,11335.04598,1397.471264,527.7126437,2843.229885,9871.367816,618.1954023,266.954023,1531.931034,6938.850575,835.816092,409.4597701,1311.632184,4846.689655,644.862069,164.091954,1445.425287,4465.206897,1427.701149,4991.942529,3182.034483,764.3448276,877.5747126,87,12.35057511,9.192712797,0.667829204,0.966666667,0.743589744,-0.361016837
+4168,21107.21212,897.3787879,495.3333333,1086.69697,18648.40909,648.6363636,578.0151515,1570.015152,10000.51515,495.7727273,680.0151515,1763.212121,12850.57576,1157.984848,3258.257576,2855.833333,5025.984848,1287.242424,275.1212121,2376,9763.575758,2711.878788,197,765.9848485,12225.16667,836.0757576,117.1818182,1575.651515,9504.530303,1693.227273,657.8636364,2785,8191.984848,761.8939394,257.0151515,1273.606061,5708.363636,1018.621212,381,1302.590909,3760.636364,637.1969697,160.6212121,2730.363636,3663.5,1231.272727,153.7878788,3319.333333,846.1060606,875.5909091,66,9.846357746,8.89385532,0.429086347,0.891891892,0.66,1.200075505
+4169,20243.05172,818.2586207,665.4655172,1104.017241,18832.44828,661.5344828,788.0517241,1562.706897,10481.98276,502.2586207,515.8103448,1785.189655,12357.87069,1222.827586,5286.068966,1544.663793,4440.146552,1343.060345,296.3275862,2341.793103,9740.862069,422.9137931,204.8448276,502.8965517,12133.89655,451.3706897,123.8017241,2930.551724,9461.396552,1407.560345,482.4741379,2788.198276,8393.672414,967.862069,277.0603448,1434.594828,5920.224138,822.1982759,424.137931,1332.275862,4326.939655,639.7844828,160.9741379,1834.396552,4001.241379,1309.060345,351.9224138,3309.767241,544.5258621,878.2844828,116,13.12705098,11.73981345,0.447423463,0.935483871,0.686390533,-1.038609272
+4170,17207.09829,809.1623932,415.0683761,1031.858974,15185.02564,647.4273504,524.4529915,1405.021368,8692.457265,491.6068376,548.4401709,1696.32906,10644.73077,1237.705128,992.7051282,1233.115385,4003.799145,1252.337607,269.7521368,2320.440171,8567.081197,398.7948718,173.3846154,532.6965812,10616.65385,516.4230769,112.4957265,980.2094017,8153.653846,1303.217949,599.8076923,2800.982906,7254.978632,710.6752137,255.0982906,1768.628205,5277.995726,848.8888889,387.8205128,1298.24359,3971.217949,634.517094,154.7564103,1745.880342,3536.653846,1390.07265,6168.833333,3161.529915,613.1196581,883.4786325,234,23.56236359,13.52038647,0.818986471,0.906976744,0.565217391,-0.437882742
+4171,37556.40659,933.6739927,537.996337,1091.74359,33883.53846,740.7435897,913.1062271,1635.344322,19356.67033,682.1684982,1661.930403,1748.395604,24273.68864,1326.47619,3152.014652,3921.472527,8823.89011,1362.087912,328.3186813,2521.622711,18429.31868,497.3186813,482.981685,1224.267399,22768.7619,979.6007326,123.8315018,1726.010989,18049.00733,1881.003663,519.3846154,2790.967033,15547.32601,730.7912088,283.3406593,1419.622711,11147.47253,1468.172161,414.2307692,1331.879121,7880.3663,747.4945055,162.1538462,3333.102564,7197.490842,1418.575092,1040.461538,3234.095238,714.3076923,881.959707,273,25.47444581,14.74182367,0.815547135,0.875,0.56875,-1.040425984
+4172,24819.21154,882.6153846,462.5865385,1061.682692,21781.52885,710.5961538,566.7019231,1498.288462,12298.43269,559.8942308,718.1442308,1701.798077,15997.69231,1369.326923,1102.798077,1229.913462,5762.653846,1279.336538,313.4615385,2315.951923,11882.23077,415.8269231,109.375,699.7403846,14810.73077,622.5,123.4423077,790.6538462,11677.25962,1412.951923,461.6826923,2809.336538,10079.73077,746.4230769,280.9807692,1464.346154,7153.326923,1053.807692,412.2403846,1307.038462,5118.932692,615.3846154,168.0769231,1443.817308,4696.211538,1591.528846,15255.07692,3106.75,774.8365385,876.8365385,104,13.65583218,10.10948463,0.67227085,0.95412844,0.787878788,-0.968343656
+4173,25855.06522,922.4927536,469.1956522,1053.818841,22692.84058,723.2391304,754.7826087,1487.086957,12708.28986,594.8115942,1559.043478,1768.384058,16328.76812,1284.978261,4443.869565,2659.275362,5867.644928,1275.753623,294.9275362,2419.891304,11898.42029,397.8478261,285.8768116,1468.065217,15013.07246,472.0652174,243.7971014,987.0652174,11715.86232,2000.652174,454.2173913,2793.753623,10087.26812,600.5144928,265.7463768,1128.355072,7109.84058,1484.123188,405.6376812,1297.130435,4902.289855,648.9492754,165.7028986,2317.586957,4508.768116,1332.333333,2569.608696,3231.514493,794.7391304,878.442029,138,14.50740546,12.29297391,0.53102119,0.945205479,0.704081633,-0.725250502
+4174,29843.25,1007.138889,470.8055556,1067.041667,25684.22222,734.0277778,541.8611111,1541.111111,14563.125,584.7222222,843.1666667,1753.916667,18313.38889,1276.208333,1977.625,2041.527778,6597.402778,1251.166667,291.8055556,2593.819444,13730.73611,681.4166667,100.5416667,796.0694444,17718.01389,444.4722222,144.4444444,2126.416667,13755.61111,1585.333333,480.625,2772.972222,11989.20833,752.75,263.4166667,1186.041667,8305.361111,900.1944444,388.4166667,1290.541667,5599.444444,593.0416667,155.6527778,2914.097222,5313.263889,1264.222222,571.25,3227.875,806.7083333,875.6111111,72,12.38052255,7.691815087,0.783585823,0.923076923,0.818181818,-1.463322214
+4175,21334.4717,781.4528302,565.9433962,1076.471698,18707.88679,644.3207547,949.0754717,1612.849057,8231.396226,475.4150943,2605.54717,1744.528302,12134.16981,1161.622642,5749.188679,6312.075472,4659.056604,1156.603774,280.490566,2736.811321,9522.471698,443.0188679,217.7924528,1496.358491,12344.32075,2145.415094,149.245283,2561.471698,8929.528302,2133.471698,387.5849057,2787.924528,7283.301887,628.1132075,249.4716981,1149.716981,4453.849057,2055.283019,387.0943396,1264.264151,2515.924528,602.4339623,153.1698113,3576.754717,2686.566038,1166.698113,1127.188679,3220.377358,992.1320755,874.8867925,53,9.016280278,7.849761672,0.491954593,0.946428571,0.736111111,-0.931348401
+4176,35406.20284,855.2920892,547.4705882,1100.261663,27472.74442,660.9249493,791.2312373,1623.598377,12268.67748,493.5334686,1972.488844,1762.720081,17964.58621,1176.079108,4468.795132,3491.119675,6868.770791,1191.939148,291.2474645,2444.099391,14136.67748,391.4685598,200.8864097,1695.056795,17865.91481,785.6572008,202.1419878,2302.823529,13751.92292,2501.505071,362.5841785,2803.237323,11269.53955,599.68357,260.5091278,933.2860041,6245.762677,1638.807302,390.3914807,1297.685598,3518.586207,610.9655172,157.474645,2431.770791,3775.200811,1189.574037,1632.014199,3151.776876,1003.371197,885.969574,493,27.02157059,24.26051777,0.440361782,0.901279707,0.652116402,-1.530312202
+4177,26988.33333,1000.266667,610.4777778,1089.366667,21689.08889,637.3333333,729.6888889,1502.744444,12038.08889,514.6444444,1409.8,1739.8,15939.25556,1212.388889,3757.211111,3402.422222,5716.4,1216.688889,294.6333333,2723.344444,11907.35556,416.5888889,122.3888889,1460.1,15494.16667,1371.3,126.8444444,2149.077778,11862.02222,1656.888889,441.7888889,2788.7,10077.88889,596.5222222,259.8555556,1198.633333,7023.055556,1385.088889,397.8888889,1306.111111,4629.1,594.2444444,159.0555556,2544.966667,4531.5,1228.344444,447.6444444,3282.077778,855.0333333,878.4777778,90,11.80876504,10.19774759,0.504221376,0.909090909,0.681818182,-0.580223415
+4178,23566.47436,877.1025641,578.5128205,1075.166667,21203.71795,744.7692308,695.8717949,1603.358974,11154.87179,559.2564103,1289.730769,1853.461538,14083.57692,1290.358974,4710.487179,4156.217949,5295.102564,1368.230769,309.2692308,2374.615385,11716.39744,387.9230769,1466.358974,1235.153846,14618,437.6666667,206.9230769,2654.564103,10759.51282,2002.423077,497.0897436,2806.820513,9616.75641,754.9230769,308.1410256,1571.551282,5988.012821,1068.897436,432.0512821,1332,4442.871795,921.1538462,175.3205128,5335.435897,4059.820513,1429.512821,4134.589744,3244.858974,322.3974359,878.5769231,78,11.19217879,9.047472817,0.588668447,0.928571429,0.709090909,-1.063265731
+4179,27302.20652,841.8695652,564.5326087,1082.163043,24934,779.6195652,898.2608696,1673.184783,13256.72826,564.2173913,2065.554348,1911,16228.46739,1232.076087,3928.836957,4051.902174,6119.206522,1426.423913,308.6847826,2600.043478,13635.31522,394.5,1335.271739,1584.434783,16384.82609,492.7717391,669.5326087,3258.097826,12341.3587,2101.684783,493.8369565,2834.054348,11117.65217,648.1521739,282.6521739,1681.434783,6989.130435,1266.641304,428.0108696,1311.043478,5086.065217,902.2391304,166.3478261,6127.26087,4555.652174,1353.23913,633.0434783,3256.021739,331.5869565,880.8152174,92,13.25242839,10.01137274,0.655221465,0.786324786,0.505494505,-0.266165842
+4180,19772.98137,981.4099379,614.2981366,1061.925466,18081.7764,714.0062112,641.2670807,1535.63354,9689.503106,569.5093168,703.2484472,1734.708075,11828.28571,1236.590062,3985.701863,2355.521739,4621.782609,1427.801242,299.0496894,2327.335404,9847.267081,1519.534161,245.2360248,638.8074534,11605.01242,514.4099379,122.7950311,1768.652174,9081.63354,1802.900621,866.9192547,2819.267081,8156.074534,872.1614907,273.4906832,1437.509317,5610.298137,1026.937888,411.5652174,1313.291925,4188.571429,681.242236,158.2484472,2363.546584,3677.645963,1282.080745,192.9689441,3374.832298,412.2298137,884.7329193,161,19.39941241,11.56185345,0.802991945,0.847368421,0.503125,0.449689441
+4181,29838.46565,970.4961832,588.9160305,1106.648855,26080.31298,756.5725191,616.3206107,1611.282443,14732.19084,580.5954198,526.9465649,1735.244275,17610.25954,1306.114504,2447.167939,3357.396947,6507.122137,1538.038168,317.2366412,2352.022901,13860.77099,402.4122137,446.7709924,503.2900763,16873.21374,559.5496183,126,2028.916031,13174.83206,1487.534351,598.4961832,2822.51145,11754.00763,622.7633588,293.7480916,1749.290076,7819.427481,913.0916031,434.9847328,1320.908397,5776.129771,735.8244275,173.3969466,3441.129771,5249.320611,1365.564885,532.6564885,3239.534351,441.4580153,881.0534351,131,13.46328622,12.79827358,0.310401726,0.942446043,0.584821429,0.356768326
+4182,22458.23529,975.0367647,475.4264706,1060.735294,19880.52206,736.5661765,488.2794118,1472.75,11173.98529,565.8970588,522.3088235,1683.397059,14314.40441,1367.852941,1944.897059,1528.485294,4955.411765,1278.294118,301.0955882,2296.875,10758.32353,1603.308824,323.4264706,626.5,13236.52941,626.4926471,116.0808824,814.8161765,10362.58824,1613.551471,980.2720588,2791.463235,9076.573529,653.1838235,273.4264706,1519.558824,6549.911765,1006.941176,400.3897059,1293.926471,4973.735294,668.9411765,170.5661765,2349.522059,4584.352941,1506.647059,5279.764706,3236.919118,672.2352941,879.5808824,136,14.76211986,12.84870938,0.492373954,0.883116883,0.647619048,0.769094966
+4183,39530.18919,955.9279279,548.5765766,1095.486486,33776.45045,806.963964,926.0990991,1657.666667,19958.35135,584.5405405,1851.918919,1792.036036,24537.46847,1377.207207,2204.864865,3554.936937,9098.657658,1353.864865,325.1801802,2358.324324,18352.97297,465.5765766,177.5765766,1505.468468,22597.61261,529.1351351,542.2252252,1488.288288,18005.72973,2047.792793,664.0630631,2819.774775,15773.25225,773.045045,285.9369369,1571.81982,11221.30631,1453.315315,429.4684685,1311.18018,7841.351351,646.5765766,165.0720721,2852.477477,7040.837838,1448.864865,1158.837838,3378.234234,740.1171171,879.3693694,111,16.48917955,9.245990435,0.827998187,0.828358209,0.578125,1.338078364
+4184,26317.61682,972.4859813,554.9906542,1052.504673,24341.16822,726.635514,743.9626168,1505.485981,13554.04673,996.4579439,1976.476636,1761.476636,15890.5514,1281.635514,3895.841121,4054.280374,5779.317757,1442.794393,303.8317757,2581.813084,12267.65421,403.4953271,363.728972,969.7570093,15436.38318,1459.700935,126.7850467,1772.46729,11375.57944,1785.691589,537.8037383,2769.336449,9883.28972,903.4766355,267.8130841,1160.738318,7040.420561,1231.700935,410.3738318,1333.121495,5238.168224,674.8971963,158.9719626,2603.878505,4531.672897,1248.242991,266.7476636,3384.626168,578.364486,880.4018692,107,13.44871162,10.70907355,0.604915165,0.884297521,0.587912088,1.191208112
+4185,18681.27143,904.5285714,412.8142857,1020.128571,17143.01429,704.5,515.6857143,1410.085714,9681.2,549.4285714,709.4571429,1679.7,11733.52857,1261.314286,1422.214286,1963.257143,4698.9,1413.371429,282.2857143,2339.128571,9588.242857,423.7714286,431.3285714,749.4,11555.08571,645.8428571,122.1,893.8571429,9142.357143,1490.771429,594.6142857,2775.928571,8149.671429,649.6571429,254.2714286,1650.085714,6118.257143,1027.314286,390.7857143,1310.114286,4479.828571,753.4285714,145.9714286,1373.542857,4092.171429,1436.728571,5345.3,3175.928571,626.6428571,880.4,70,10.6679244,9.429149394,0.467716512,0.875,0.53030303,-0.218008521
+4186,32524.47126,849.7241379,556.1264368,1110.011494,29113.65517,683.7701149,1049.114943,1722.264368,13372.48276,516.1034483,2303.735632,1882.827586,19018.70115,1219.37931,6179.735632,4499.896552,7251.37931,1237.597701,307.7011494,2402.609195,14916.81609,432.862069,280.7586207,2026.310345,18936.49425,829.4022989,124.7931034,2917.425287,14155.86207,2420.126437,412.8505747,2812.551724,11481.36782,718.5172414,268.2528736,1085.896552,6760.195402,1878.724138,397.7356322,1301.333333,3760.149425,660.5172414,157.2068966,2970.712644,4014.16092,1212.264368,679.7816092,3202.735632,985.7816092,882.4942529,87,13.86805378,8.478146043,0.791365271,0.887755102,0.54375,0.003650595
+4187,37062.30872,945.1677852,681.8255034,1151.194631,33362.57047,779.3288591,831.4966443,1769.395973,18700.97987,589.6442953,1115.42953,1816.154362,22747.14765,1356.013423,3105.577181,3709.208054,8185.04698,1468.979866,347.3892617,2453.597315,18309.95973,429.2483221,689.2214765,897.8053691,22321.88591,628.3892617,184.0604027,2515.268456,17208.45638,1834.852349,628.3557047,2823,15417.95302,662.2147651,329.5503356,1731.09396,9911.644295,1260.805369,474.6510067,1347.818792,7255.469799,784.5033557,178.4899329,3816.194631,6377.966443,1469.114094,507.9194631,3360.09396,360.6040268,882.7516779,149,18.33541881,10.63211697,0.814710661,0.914110429,0.591269841,0.935831796
+4188,27116.08163,994.7142857,467.5102041,1086.091837,24948.70408,783.1530612,594.3469388,1583.44898,13828.37755,689.0408163,632.9795918,1699.295918,17257.41837,1458.397959,1866.071429,2375.785714,6069.336735,1494.265306,325.6836735,2348.408163,12405.27551,466.6326531,223.8877551,555.877551,15394.05102,897.5510204,130.8877551,1210.142857,11782.90816,1529.581633,741.6734694,2778.285714,10160.94898,700.6836735,293.2653061,2044.94898,7414.020408,1057.438776,431.8673469,1341.663265,5467.122449,690.377551,168.0714286,2196.612245,4325.612245,1424.5,1040.163265,3224.602041,644.0204082,882.4387755,98,12.95680059,9.829857996,0.651482121,0.98,0.628205128,-0.730094082
+4189,38293.89954,904.3561644,552.9634703,1115.744292,33245.27397,715.7260274,840.8127854,1664.525114,17042.6621,542.0913242,1516.598174,1785.561644,23540.07306,1279.045662,3698.812785,3941.328767,8653.671233,1295.273973,328.9908676,2455.118721,17779.73973,1173.146119,237.6712329,1504.940639,22548.25114,859.6438356,129.2237443,2583.634703,17153.95434,2099.178082,427.4018265,2796.894977,14222.94521,615.5525114,286.1826484,1098.429224,9221.872146,1452.767123,419.4931507,1298.328767,5420.90411,678.6621005,161.7351598,2971.73516,5569.621005,1292.351598,501.1141553,3309.579909,926.0182648,883.9086758,219,18.04693704,16.45071139,0.411186062,0.897540984,0.675925926,-0.839738626
+4190,37756.2,906.1428571,642.8571429,1105.785714,33753.97143,783.8857143,1108.114286,1675.557143,20033.07143,604.7714286,2089.528571,1816.657143,23599.67143,1323.6,3568.3,4552.314286,8494.857143,1383,321.6857143,2899.285714,19728.98571,494.0142857,222.1285714,1182.542857,22990.32857,601.1714286,154.5,2966.771429,17661.22857,2254.971429,518.5285714,2844.357143,15469.87143,655.0142857,301.8,1395.6,10842.47143,1454.114286,440.6,1323.371429,7952.557143,661.7142857,178.5857143,4831.1,7057.942857,1392.742857,292,3372.571429,566.7714286,881.9285714,70,12.70143345,7.696866342,0.795476779,0.843373494,0.538461538,1.190753199
+4191,27848.33333,813.6161616,568.4343434,1070.79798,25675.74747,651.030303,929.2727273,1669.717172,12132.9697,622.1212121,807.040404,1739.838384,16224.46465,1150.181818,6189.959596,3616.121212,6292.424242,1227.494949,325.6262626,2415.979798,13377.9899,413.3939394,891.4848485,909.1010101,17357.79798,527.9494949,124.1818182,5544.212121,12769.0303,2020.434343,448,2784.838384,10567.26263,611.7979798,267.8181818,1252.747475,6154.232323,1045.79798,391.8383838,1325.89899,3505.010101,954.969697,159.8282828,5480.161616,3676.626263,1171.666667,299.8484848,3246.323232,974.7878788,882.6565657,99,11.53553297,11.10833494,0.269620097,0.942857143,0.75,-1.17690393
+4192,12779.16187,773.3956835,462.6330935,1037.852518,11765.16187,603.5503597,397.3309353,1486.061151,5810.176259,485.4820144,479.8021583,1734.71223,7671.809353,1195.122302,1607.866906,952.1618705,2954.471223,1226.017986,277.9856115,2291.388489,6535.352518,352.6546763,322.1834532,473.5863309,8015.122302,419.1330935,118.7302158,1189.057554,6115.089928,1386.352518,323,2841.669065,5496.399281,590.323741,254.3489209,1027.510791,3049.456835,750.9316547,390.1906475,1298.877698,2210.877698,636.4892086,157.6402878,1850.302158,2094.546763,1253.888489,6227.564748,3172.528777,279.9964029,888.8093525,278,22.98223483,16.3358817,0.703389371,0.920529801,0.631818182,0.646186958
+4193,22586.15167,854.4832905,490.311054,1077.393316,20931.00771,678.1182519,551.8714653,1578.246787,10520.51671,534.7197943,674.8560411,1740.102828,13636.82519,1291.136247,2107.053985,1562.167095,5068.305913,1356.03599,317.0102828,2284.976864,11335.14139,381.7429306,460.2390746,618.059126,14041.32905,441.9280206,128.8303342,1316.678663,10595.59383,1602.275064,366.9023136,2839.994859,9564.012853,859.6812339,292.6246787,1125.573265,5488.547558,934.1748072,431.9048843,1309.336761,3997.550129,689.1748072,167.933162,1921.930591,3703.357326,1404.845758,7498.521851,3191.755784,299.5475578,885.5192802,389,31.72055931,18.62788004,0.809406029,0.832976445,0.572058824,-1.362907324
+4194,30508.67033,1096.527473,599.0769231,1079.593407,27269.30769,798.021978,532.4175824,1643.362637,14826.07692,640.2857143,563.3626374,1749.186813,17202.87912,1361.868132,5049.362637,2435.087912,6279.736264,1415.978022,321.1428571,2292.285714,13668.2967,396.8571429,1021.901099,490.3956044,16298.03297,430.6373626,128.2307692,2050.098901,12663.81319,1647.483516,469.3956044,2817.186813,11193.65934,629.4725275,295.9010989,1195.945055,6788.461538,918.5934066,427,1327.340659,4855.901099,797.9340659,167.1538462,1760.813187,4260.934066,1304.802198,689.956044,3331.692308,341.8791209,883.6043956,91,12.13086647,9.873644742,0.580966582,0.919191919,0.631944444,1.158837892
+4195,39188.26786,877.7321429,472.4285714,1066.803571,35538.76786,738.0357143,803.2857143,1578.464286,20015.60714,555.1964286,1714.75,1824.321429,24753.80357,1342.25,1917.821429,2394.946429,8806.160714,1419.410714,335.3392857,2376.142857,19687.75,413.5714286,540.2142857,1101.375,24275.375,463.8214286,138.1428571,1155.535714,18978.67857,1875.392857,486.9821429,2840.053571,16868.01786,935.1785714,320.8571429,1479.428571,11042.58929,1368.767857,461,1360.607143,7962.875,747.6785714,177.0714286,3045.535714,7314.982143,1480.660714,1542.392857,3330.946429,371.4285714,882.9107143,56,9.484211359,7.882021664,0.556171276,0.918032787,0.565656566,0.052908768
+4196,25192.66265,854.4698795,423.4698795,1028.722892,21857.08434,694.1445783,601.8072289,1447.963855,12703.42169,532.3614458,1191.771084,1781.686747,16311.6988,1328.313253,1228.192771,2156.036145,6101.46988,1278.674699,294.0481928,2405.783133,12377.66265,599.746988,145.2168675,1374.180723,15356.3012,606.3614458,122.1204819,851.3373494,11785.61446,1815.506024,826.746988,2800.975904,10337.6747,739.5903614,272.7590361,1883.216867,7688.433735,1535.13253,418.1927711,1310.325301,5693.084337,615.4337349,167.8072289,2102.096386,4938.240964,1424.939759,1111.86747,3241.86747,663.1566265,884.253012,83,11.40192462,9.701625242,0.525366395,0.943181818,0.628787879,-0.120919478
+4197,26700.2381,900.2108844,730.1088435,1117.816327,24034.47619,717.5510204,941.6394558,1669.442177,12457.7619,619.4829932,1534.258503,1753.156463,15981.87075,1235.217687,2965.931973,3836.061224,6078.578231,1287,316.9931973,2353.891156,12649.70068,488.4761905,278.2040816,1466.836735,16455.40136,668.3197279,125.2721088,2213.102041,12074.68707,2175.557823,489.4013605,2791.496599,10101.33333,804.4489796,279.6394558,1321.92517,6661.727891,1389.482993,417.9659864,1316.959184,3999.027211,657.2312925,156.1564626,2373.585034,4049.346939,1269.857143,245.7414966,3345.564626,906.6734694,885.5510204,147,16.68191301,11.64527508,0.716021803,0.924528302,0.6125,0.954111765
+4198,22961.35065,847.6038961,490.8766234,1080.337662,21103.37013,685.8636364,609.9415584,1540.12987,11404.35065,589.0844156,570.1363636,1748.474026,14210.33117,1250.714286,1796.701299,2133.480519,5373.253247,1346.532468,321.9935065,2341.292208,11719.46104,405.1363636,1039.525974,571.8636364,14339.27922,459,133.1623377,1581.818182,11114.35714,1643.142857,587.6883117,2875.694805,9931.064935,1317.558442,293.1428571,2074.506494,6637.844156,903.0909091,435.7857143,1391.214286,4923.655844,887.1818182,176.6428571,3868.006494,4544.5,1398.909091,1732.409091,3262.344156,382.4480519,885.8441558,154,16.54422016,12.05129149,0.685121185,0.944785276,0.733333333,-1.118294597
+4199,33018.26582,930.9746835,679.9493671,1146.177215,29879.72152,807.2025316,1061.392405,1745.911392,16956.24051,575.443038,1384.987342,1820.303797,20617.02532,1356.202532,1426.493671,1992.620253,7438.962025,1478.797468,348.1518987,2413.392405,16046.6962,463.4303797,139.1392405,1267.772152,19781.24051,505.556962,271.164557,905.9493671,15607.37975,1789.126582,454.3164557,2813.43038,13619.51899,660.835443,330.0632911,1627.987342,9597.632911,1152.050633,486.6708861,1353.607595,6951.835443,631.1012658,173.164557,2094,6225.886076,1461.481013,204.6329114,3348.126582,521.6455696,883.4810127,79,12.77454197,8.225334902,0.765122352,0.908045977,0.675213675,-1.387509974
+4200,25958.37143,804.5,480.0428571,1048.114286,23426.45714,662.7428571,1002.757143,1522.242857,13044.45714,518.1857143,2311.371429,1864.571429,16732.64286,1188.214286,3755.785714,4254.242857,6463.428571,1274.442857,293.7857143,2517.7,12815.41429,400.1857143,106.4142857,2716.842857,16573.42857,436.1714286,393.3,2256.814286,12578.48571,2587.771429,495.4714286,2797.9,10921.97143,585.1714286,272.2285714,1229.6,7631.814286,1501.614286,406.9857143,1280.471429,5231.228571,602.1857143,163.7142857,3735.642857,4974.314286,1283.485714,455.4428571,3179.642857,807.1428571,882.8428571,70,13.78727043,6.798390467,0.869977266,0.853658537,0.555555556,-1.339535848
+4201,36893.98168,901.7326007,523.5238095,1118.637363,29989.5641,701.96337,811.4395604,1673.846154,14756.5641,517.7838828,2213.582418,1808.336996,19697.56777,1204.190476,4494.974359,4014.948718,7356.512821,1250.96337,295.7912088,2491.102564,15259.34432,482.9340659,174.5750916,2041.783883,19338.37363,630.992674,245.6080586,1999.058608,14426.32967,2256.347985,396.1062271,2803.710623,12071.12821,677.7362637,268.6849817,953.4835165,7397.615385,1346.655678,397.8571429,1301.919414,4225.43956,599.4175824,154.4542125,2573.18315,4423.545788,1202.446886,705.5347985,3309.131868,942.6153846,888.3406593,273,25.31981305,14.43497157,0.821571304,0.866666667,0.565217391,-0.912399773
+4202,11927.18841,836.7391304,529.3188406,1092.652174,10976.78261,663.2826087,642.8188406,1548.753623,4214.992754,509.6666667,461.1594203,1687.318841,6672.043478,1220.768116,2216.898551,1094.166667,2628.369565,1192.036232,289.9710145,2271.623188,5534.905797,390.8695652,364.7463768,603.8985507,7059.528986,479.3550725,113.884058,1466.586957,5304.188406,1542.971014,340.6449275,2815.949275,4393.108696,829.5652174,257.8043478,1022.369565,2398.456522,776.3768116,371.0869565,1294.202899,1375.507246,621.9057971,154.9565217,2603.695652,1601.934783,1265.644928,13685.51449,3152.57971,1039.376812,885.3478261,138,13.85249592,12.80690358,0.381134573,0.945205479,0.704081633,0.750225452
+4203,32304.52113,854.1549296,487.7183099,1105.71831,28756.80282,699.028169,710.2816901,1630.521127,16289.22535,530.0422535,1278.338028,1768.507042,20492.28169,1247.619718,2905.901408,3956.774648,7519.84507,1255,301.5070423,2545.225352,15751.87324,443.971831,218.5915493,1356.619718,19687.69014,769.1408451,141.1408451,2343.802817,15517.91549,1923.746479,564.7887324,2790.887324,13306.6338,635.9577465,282.8873239,1373.028169,8998.619718,1430.211268,415.9859155,1310.169014,5892.140845,649,168.6760563,3729.084507,5743.887324,1308.690141,345.8732394,3205.859155,845.4366197,884.028169,71,13.17566662,7.121741811,0.841329679,0.934210526,0.546153846,0.949263015
+4204,26400.55769,1061.423077,934.3846154,1511.173077,23658.01923,773.6634615,752.3557692,2024.394231,13252.64423,673.1442308,664.4903846,1835.240385,15981.94231,1350.634615,1726.5,2578.221154,5722.663462,1442.557692,321.9038462,2367.519231,12806.73077,437.9038462,329.3557692,506.7788462,15653.36538,509.4615385,130.8653846,2813.038462,12309.34615,1693.673077,486.7788462,2810,10843.77885,660.0769231,305.4903846,1929.807692,7345.548077,906.7115385,447.3653846,1360.192308,5487.278846,674.2115385,173.3365385,1648.480769,4977.221154,1372.692308,174.9519231,3385.317308,468.7403846,886.75,104,12.67550131,10.45978538,0.564845065,0.945454545,0.727272727,-0.050355497
+4205,24644.75325,971.3766234,516.8831169,1050.577922,21981.14935,679.1558442,605.1428571,1438.87013,12092.22078,555.6883117,1184.87013,1737.668831,14571.28571,1318.863636,2428.357143,2767.201299,5519.084416,1262.558442,290.9545455,2310.714286,11275.98701,398.3766234,303.7662338,1241.136364,14169.83766,1220.344156,117.2987013,2352.441558,10476.12338,1446.006494,513.3181818,2791.876623,9070.967532,603.9220779,267.2142857,1362.506494,6400.188312,1213.961039,411.7142857,1301.24026,4835.305195,816,156.6168831,2323.532468,4127.38961,1343.5,1946.409091,3198.409091,591.1428571,887.5194805,154,19.10355775,11.30771135,0.805999279,0.823529412,0.578947368,1.468604957
+4206,36604.65116,1056.488372,459.8255814,1075.72093,31591,783.5581395,499.3023256,1543.383721,18567.69767,616.5581395,748.1162791,1682.05814,22217.10465,1458.686047,1899.244186,2175.395349,7368.011628,1373.127907,334.127907,2502.244186,16177.86047,459.9883721,138.7093023,871.8837209,20199.67442,792.372093,133.0348837,976.4651163,15759.66279,1416.825581,605.5465116,2783.709302,13479.05814,642.2093023,276.5465116,1529.627907,9720.406977,1152.790698,410.5,1321.534884,7094.162791,640.0930233,169.3837209,1101.639535,6253.034884,1433.488372,1773.569767,3211.093023,632,887.1976744,86,12.08955052,9.27155604,0.641758734,0.977272727,0.651515152,-0.736425656
+4207,22810.37423,926.6871166,466.1104294,1059.07362,20352.79755,740.1349693,515.5889571,1488.815951,11549.23926,628.5030675,752.202454,1698.895706,14280.03681,1368.337423,1657.674847,2369.883436,4972.460123,1274.828221,309.6871166,2267.03681,9255.398773,404.9815951,453.5705521,716.392638,11369.88344,462.8282209,115.2638037,1087.208589,8940.815951,1413.619632,610.190184,2792.337423,7901.693252,602.3803681,265.5705521,1365.08589,5730.214724,1153.496933,401.1595092,1314.527607,4161.969325,697.8773006,165.8834356,1865.018405,3893.644172,1431.208589,2202.392638,3197.907975,686.0736196,886.0552147,163,19.82572536,10.59379208,0.845266005,0.931428571,0.740909091,-1.410177375
+4208,21780.30303,842.7373737,414.7070707,1048.838384,19127.05051,665.1111111,491.9393939,1455.20202,10685.66667,533.020202,378.7272727,1677.777778,13697.28283,1265.767677,947.7171717,951.1717172,5085.444444,1229.30303,296.7575758,2265.818182,10440.92929,447.1212121,193.1616162,488.3232323,12925.93939,439.8080808,121.1818182,771.6767677,10180.60606,1391.292929,556.4747475,2834.313131,9002.565657,866.2828283,263.8888889,1434.676768,6391.040404,819.2727273,403.0505051,1307.59596,4544.060606,614.5858586,157.7171717,1633.606061,4259.343434,1474.989899,10514.83838,3157.313131,751.6969697,885.8585859,99,13.58052893,9.477364229,0.716230154,0.961165049,0.642857143,-1.217033427
+4209,28829.86047,805.2790698,457.4263566,1072.55814,26603.96899,682.8062016,701.5426357,1564.728682,14635.04651,516.1472868,1285.209302,1756.116279,18425.42636,1185.72093,3581.255814,3189.178295,6820.046512,1251.100775,294.7751938,2504.565891,14267.69767,389.5658915,114.5581395,1513.806202,17857.02326,808.1007752,278.0155039,2097.945736,13817.51938,1590.914729,486.3875969,2790.860465,11861.56589,637.8914729,271.3565891,1459.976744,7933.984496,1107.449612,409.3255814,1308.953488,5379.682171,598.5503876,155.744186,3747.612403,5120.085271,1259.666667,347.3953488,3266.116279,830.0310078,888.3178295,129,15.83141275,11.57978094,0.681902254,0.865771812,0.5375,0.550069269
+4210,29709.05747,850.7816092,506.954023,1097.551724,27530.41379,714.6551724,941.8735632,1583.62069,15142.68966,529.908046,1963.022989,1846.885057,19181.13793,1230.275862,3090.448276,4191.16092,7097.057471,1271.356322,304.3333333,2433.758621,14726.93103,405.137931,128.1149425,2011.126437,18380.49425,1974.885057,151.816092,2481.022989,14327.57471,1696.045977,537.6091954,2785.83908,12406.98851,595.3218391,274.1494253,1501.137931,8308.885057,1644.137931,420.2758621,1307.011494,5514.505747,608.9655172,164.2988506,4843.793103,5299.011494,1294.425287,275.2528736,3268.252874,839.1954023,887.7931034,87,15.66255117,7.378763472,0.882075185,0.90625,0.564935065,0.556556027
+4211,23555.60465,826.5271318,463.9302326,1052.255814,20934.97674,662.255814,725.9767442,1577.767442,11220.56589,529.6821705,897.0542636,1812.635659,14401.86822,1193.124031,4262.232558,2191.302326,5308.232558,1248.046512,284.7906977,2348.333333,11035.27907,4667.403101,309.9844961,865.8139535,14379.86822,588.0775194,169.0620155,910.7364341,10789.45736,1946.317829,673.2945736,2778.744186,9216.79845,1259.744186,266.2713178,1115.550388,6248.829457,1136.984496,397.3875969,1309.341085,3986.534884,657.2945736,156.7596899,2535.186047,3979.96124,1264.031008,1235.604651,3286.224806,869.0775194,888.6356589,129,15.73101806,11.15869895,0.704862738,0.816455696,0.551282051,-0.073255533
+4212,33667.91045,1021.656716,540.6119403,1084.373134,28365.1194,750.2985075,762.6119403,1546.402985,16236.23881,618.3283582,1321.19403,1804.626866,19268.8806,1297.925373,2444.895522,3136.850746,7083.686567,1397.41791,311.6567164,2333.791045,14734.29851,389.5671642,195.0149254,1268.402985,17927.40299,437.0597015,132.9552239,1631.686567,14289.83582,2074.432836,517.7164179,2805.80597,12538.73134,594.3880597,296.1791045,1397.477612,8298.402985,1206.149254,432.7910448,1315.985075,6010.014925,637.641791,160.6119403,1862.656716,5581.746269,1311.328358,187.1940299,3416.970149,422.7462687,886.358209,67,10.82608878,8.840841074,0.577170402,0.87012987,0.553719008,-0.46890596
+4213,29514.91209,948.3626374,716.0879121,1135.318681,26986.31868,754.3516484,897.8131868,1693.120879,14604.6044,586.0659341,646.3736264,1769.494505,17858.21978,1343.175824,1053.846154,1565.263736,6345.450549,1431.824176,343.5934066,2386.351648,13903.34066,457.1208791,155.5384615,602.2087912,17650.3956,682.6593407,131.978022,966.4505495,13817.42857,1537.175824,457.6263736,2829.67033,12139.61538,751.8021978,296.2637363,1499.747253,8406.527473,1110.945055,457.5164835,1346.428571,6188.428571,627.3736264,173.2417582,1455.769231,5669.956044,1418.10989,202.1538462,3418.615385,531.1098901,887.7692308,91,13.24019605,9.186902466,0.720105553,0.919191919,0.636363636,-0.373637211
+4214,24234.8843,941.9752066,563.9421488,1085.768595,22538.05785,731.3305785,787.9504132,1598.677686,12182.59504,590.1239669,682.6694215,1789.595041,14745.66942,1278.710744,3902.404959,2740.190083,5440.702479,1741.239669,310.6446281,2351.264463,12120.43802,431.1735537,2161.404959,634.1570248,14306.20661,495.107438,137.1570248,1721.933884,11232.72727,1863.876033,601.9917355,2823.909091,10172.04959,746.231405,292.2396694,1449.46281,6443.53719,1056.132231,432.7768595,1326.438017,4710.743802,1098.239669,169.1157025,2920.834711,4226.735537,1354.07438,846.6115702,3346.181818,354.0826446,890.8347107,121,15.15986736,10.79848218,0.701867864,0.930769231,0.581730769,0.392610351
+4215,22974.25893,886.5803571,770.7857143,1118.982143,20820.80357,694.3839286,814.4196429,1633.553571,11587.70536,583.0178571,537.75,1753.125,14200.45536,1246.776786,1563.142857,2739.196429,5143.866071,1367.839286,308.6339286,2378.428571,11363.20536,402.5892857,427.75,478.3303571,13622.28571,455.1875,123.7053571,1908.8125,10924.10714,1467.080357,491.4464286,2810.089286,9666.75,628.125,282.9017857,1793.241071,6627.6875,1086.428571,447.5267857,1336.241071,4825.491071,678.25,168.6160714,3584.285714,4385.741071,1368.794643,592.6339286,3291.1875,448.7410714,889.8482143,112,13.26361912,10.98340027,0.560602982,0.957264957,0.662721893,-0.768692319
+4216,15371.144,806.4,481.992,1073.856,13514.384,637.768,592.464,1482.272,7540.744,500.968,876.392,1695.912,9607.24,1165.6,1304.304,1720.576,3588.896,1244.528,281.608,2266.68,7336.232,386.424,98.696,1250.648,8984.136,1346.232,120.056,975.92,7154.512,1302.216,534.168,2811.048,6259.72,596.376,260.744,1968.432,4431.352,1010.96,394.192,1329.656,3141.936,624.104,153.96,2221.976,2992.136,1302.688,818.992,3214.168,774.12,888.544,125,13.30604674,12.28461413,0.384234684,0.932835821,0.686813187,-1.471422456
+4217,20684.13761,781.5321101,451.1192661,1045.889908,18060.78899,629.1100917,431.266055,1450.706422,9412.981651,488.1009174,466.3394495,1712.220183,12515.51376,1191.963303,1290.651376,1028.201835,4761.853211,1173.348624,288.5229358,2297.669725,9715.605505,392.559633,146.2752294,649.7155963,12678.14679,395.7706422,117.8348624,932.0550459,9373.357798,1358.376147,430.4495413,2804.577982,8016.605505,759.0733945,259.9174312,1031.93578,5490.844037,806.9266055,396.9174312,1286.302752,3457.715596,600.4678899,153.1743119,2045.155963,3483.073394,1239.66055,1478.440367,3107.40367,882.9266055,888.0091743,109,12.80545256,11.03317793,0.507587863,0.947826087,0.648809524,1.267352676
+4218,32252.24107,1047.5625,728.5892857,1135.098214,16197.58929,606.0803571,452.5892857,1527.473214,7470.991071,477.3035714,495.6339286,1695.580357,10461.42857,1144.410714,4882.303571,3161.017857,4004.080357,1163.330357,278.3482143,2604.705357,8457.839286,392.9553571,1161.785714,444.2767857,10586.5625,367.4285714,118,4780.598214,7879.973214,1503.625,340.4553571,2796.348214,7006.303571,544.2321429,260.4553571,1146.392857,3517.098214,824.3303571,387.6517857,1318.241071,2554.223214,783.2946429,156.0892857,3668.214286,2494.089286,1162.089286,1200.169643,3146.205357,262.3214286,888.4732143,112,13.82469476,10.40942511,0.658067698,0.965517241,0.861538462,-1.351465613
+4219,31347.86957,899.6956522,618.9130435,1098.478261,28566.52174,756.7608696,564.0652174,1716.543478,15206.80435,582.7826087,1037.76087,1797.913043,18672.02174,1277.086957,4747.826087,4857.043478,6888.608696,1389.347826,325.1086957,2518.630435,15538.93478,409.4782609,991.1304348,855.6521739,18740.5,444.326087,193.5652174,4789.934783,14612.6087,1700.26087,529.2608696,2809,13086.36957,1015.73913,305.5869565,1625.956522,7907.891304,1056.065217,454.326087,1346.282609,5736.086957,859.4130435,182.326087,7234.913043,5229.23913,1413.847826,710.5869565,3267.521739,322.9347826,886.6304348,46,10.10729776,6.123909488,0.795548519,0.884615385,0.597402597,1.501220559
+4220,27343.11667,911.3916667,623.6,1127.666667,24407.04167,750.225,640.35,1621.033333,13464.45833,573.575,557.0416667,1739.041667,16157.84167,1333.216667,1661.416667,2693.291667,6047.941667,2055.758333,334.3083333,2329.108333,13242.63333,416.5083333,196.6583333,494.2,15684.94167,445.9166667,129.075,1730.658333,12502.65,1487.066667,496.125,2822.566667,11375.68333,692.8083333,306.0916667,1586.525,7528.483333,904.1416667,447.9083333,1309.2,5571.908333,645.3166667,174.1416667,2680.1,4964.408333,1436.95,947.6416667,3285.116667,436.3083333,893.1333333,120,16.5276393,9.748414418,0.807531114,0.923076923,0.606060606,-0.090260937
+4221,24347.6,914.8933333,714.4933333,1138.96,22097.66,723.6533333,923.5066667,1688.8,12218.57333,567.8,928.0533333,1807.34,14793.75333,1325.14,1411.206667,2215.486667,5269.833333,1390.193333,327.9,2400.586667,11653.04,465.1733333,228.7466667,593.1,14246.58667,917.26,125.1133333,1286.96,11238.14,1492.5,476.48,2813.526667,9999.833333,971.9266667,291.6066667,1562.193333,6872.38,1054.353333,456.1533333,1345.14,5030.113333,655.18,169.9133333,1910.513333,4591.586667,1413.006667,452.2133333,3360.52,541.14,891.0733333,150,15.54964903,12.45988646,0.598266818,0.949367089,0.669642857,-0.34072622
+4222,25417.67213,979.9836066,514.2131148,1041.639344,22250.67213,701.5245902,614.1967213,1494.213115,12637.77049,702.0163934,787.9836066,1708.311475,15939.91803,1283.459016,2073.57377,3359.295082,5779.901639,1317.901639,305.8032787,2350.885246,11954.59016,757.147541,377.9836066,645.3442623,14942.55738,862.6065574,125.8360656,2058.754098,11875.90164,1607.704918,767.704918,2789.967213,10354.18033,719.6885246,268.6885246,1857.704918,7306.311475,1061.655738,399.1147541,1311.491803,5304.754098,683.8032787,152.4918033,2944.754098,4891.688525,1349.655738,3153.655738,3186.098361,739.3278689,887.0819672,61,11.50566914,6.896564627,0.800445318,0.968253968,0.693181818,1.074731303
+4223,26399.84615,931,559.6923077,1060.935897,23843.39744,705.8461538,676.2948718,1544.935897,12852.57692,558.3076923,2703.679487,1750.641026,16431.88462,1253.730769,3139.448718,3944.641026,6003.346154,1245.705128,311.0512821,2496.782051,12487.58974,585.1410256,503.7820513,1778.974359,16199.44872,1609.269231,191.6923077,1036.846154,12242.07692,1977.282051,485.0897436,2795.269231,10541.14103,643.8974359,271.3461538,1078.525641,7184.858974,1873.153846,416.0641026,1338.282051,4655.435897,682.0128205,159.5,3251.910256,4554.358974,1283.371795,569.7051282,3271.089744,858.7179487,888.2051282,78,11.94265677,9.026524432,0.654776976,0.906976744,0.644628099,0.605559802
+4224,14798.11215,754.3271028,424.0093458,1058.817757,13024.56542,601.4205607,512.0327103,1555.098131,5135.308411,473.4158879,380.8084112,1699.570093,7782.845794,1098.38785,1194.747664,639.6588785,3059.028037,1126.850467,259.7570093,2243.836449,6317.448598,351.3971963,134.3224299,511.9345794,7932.556075,437.088785,111.8831776,1021.957944,5966.61215,1298.915888,340.6308411,2822.266355,4919.331776,608.3411215,239.0560748,995.8598131,2585.149533,672.9672897,358.9299065,1306.509346,1487.35514,598.1962617,146.8457944,3004.415888,1648.060748,1119.462617,2753.88785,3117.420561,1027.943925,892.9626168,214,18.58496106,14.88973211,0.598435465,0.959641256,0.703947368,0.004564381
+4225,31227.98113,856.6226415,543.1320755,1088.45283,27333.5283,701.8867925,659.8301887,1583.584906,15024.11321,572.0377358,679.4528302,1769.301887,18453.09434,1260.584906,2657.716981,4156.283019,6883.981132,2174.283019,318.245283,2478.716981,14676.54717,403.2641509,903.0377358,616.1886792,18118.75472,597.0943396,124.9622642,1643.509434,14113.98113,1632.566038,566.2264151,2800.698113,12540.37736,647.8490566,290.6226415,1637.018868,8302.566038,1035.603774,443.6981132,1341.886792,6153.603774,877.7735849,168.245283,3889.09434,5650.415094,1393.54717,236.5283019,3321.037736,428.9811321,889.4716981,53,10.60792958,6.580453993,0.784338166,0.963636364,0.736111111,-0.573671065
+4226,35562.5411,1007.80137,736.6232877,1102.726027,31464.63699,775.8493151,950.0547945,1596.657534,18724.52055,613.3561644,1204.171233,1757.527397,21245.26712,1359.979452,3181.80137,2525.691781,7778.760274,1372.513699,318.109589,2389.616438,16946.69178,446.2945205,121.9589041,919.4931507,20856.36986,452.869863,132.4520548,2113.732877,16126.67808,2031.931507,512.760274,2802.616438,14226.65068,625.8082192,307.0410959,1212.219178,9932.226027,1162.047945,449.7465753,1314.383562,7209.753425,622.0890411,162.8219178,1573.80137,6366.842466,1368.178082,178.9589041,3415.041096,563.8150685,890.5342466,146,17.22237989,11.37055076,0.751072722,0.906832298,0.640350877,1.380610614
+4227,31588.09375,1129.0625,576.8125,1060.125,29093,788.40625,640.59375,1551.25,16304.125,852.1875,1621.28125,1782.8125,18752.90625,1353.0625,3270.90625,2816.21875,6669.84375,1403.5,297.90625,2335.375,14319.25,420.875,273.34375,678.1875,17171.90625,566.3125,125.875,1477.625,13361.21875,2038.65625,465.0625,2780.21875,11958.84375,794.8125,283,1079.75,8108.125,1173.4375,416,1319.4375,5890,662.46875,154.75,1282.71875,5008.46875,1263.0625,168,3355.21875,575.21875,887.5625,32,7.225725822,5.697434629,0.615043659,1,0.666666667,1.414799554
+4228,36228.73,890.37,496.83,1091.94,32624.95,719.07,775.28,1590.48,17879.57,551.68,1697.68,1781.78,22774.29,1281.39,2848,3803.9,8440.42,1332.38,303.54,2616.28,17151.31,399.4,135.01,2030.53,22419.15,481.83,130.99,2235.87,17092.13,2363.05,521.73,2796.68,14956.35,641.87,292.54,1251.51,10331.51,1615.62,419.09,1298.41,6844.41,625.6,164.66,2042.73,6517.74,1350.48,836.61,3267.21,811.47,890.59,100,12.51794471,10.87920311,0.494656442,0.884955752,0.591715976,-0.449148635
+4229,36279.6625,835.0625,562.4,1083.3375,23876.6,616.075,660.725,1538.65,11808.675,500.3125,849.975,1709.5,16245.8125,1109.825,4343.9375,3313.25,6207.7625,1151.95,270.1375,2277.0125,12720.5375,370.325,329.0625,755.65,16150.8125,531.2625,116.9125,3306.925,12193.5625,1630.3875,419.2625,2771.775,10224.075,545.275,250.9875,1082.5125,6162.6375,1006.7125,376.9125,1296.6375,3528.4,639.8875,149.375,2418.775,3748.425,1118.6375,316.3125,3159.4,953.6,891.6375,80,13.23517559,8.047833686,0.793888017,0.909090909,0.615384615,-0.290741728
+4230,18410.78448,1033.982759,782.2155172,1156.474138,17163.30172,813.8103448,1105.896552,1753.568966,9027.706897,670.6982759,1326.215517,1819.732759,11148.16379,1432.905172,981.5258621,1688.172414,4070.155172,1530.517241,339.0775862,2499.017241,9044.732759,478.9482759,218.3534483,1103.534483,11343.16379,553.7931034,269.387931,982.4741379,8465.793103,1822.060345,449.3706897,2822.258621,7506.758621,1125.137931,313.4137931,2249.146552,5170.086207,888.6206897,472.3793103,1353.758621,3944.060345,655.3448276,178.4310345,2836.258621,3492.275862,1446.439655,307.0689655,3385.344828,503.1206897,891.0172414,116,15.06146947,10.77435562,0.698757256,0.852941176,0.743589744,-1.213288019
+4231,28496.77647,924.7411765,918,1140.235294,25090.87059,752.4,882.1529412,1726.023529,14588.52941,587.6235294,700.5294118,1801.811765,18100.62353,1358.129412,893.1058824,1230.2,6441,1470.858824,338.5529412,2420.035294,14216.90588,497.9411765,188.3058824,764.6588235,17764.08235,505.7294118,138.5529412,862.9647059,14217.82353,1572.305882,441.9176471,2818.905882,12450.74118,781,316.8588235,1886.388235,8651.976471,917.6941176,470.2117647,1350.105882,6285.129412,654.2705882,173.3176471,1781.341176,5907.023529,1480.235294,520.0352941,3336.752941,513.2823529,892.6588235,85,14.19060785,7.743335452,0.838002606,0.944444444,0.758928571,-0.130336502
+4232,16434.53165,1028.050633,498.6455696,1037.886076,16092.03797,736.5316456,408.1012658,1391.822785,8919.582278,592.1139241,921.2531646,1699.139241,10991.98734,1387.35443,1400.56962,2158.911392,4258.974684,1422.607595,300.8227848,2281.037975,9253.518987,431.3291139,245.7088608,1208.898734,11555.64557,493.7848101,118.4050633,868.6835443,8705.037975,1510.506329,553.6329114,2765.303797,7801.189873,724.8481013,274.3797468,1397.21519,5794.164557,1317.139241,411.2658228,1296.455696,4362.683544,692.3924051,164.7721519,1685.278481,3993.189873,1443.303797,1542.063291,3130.164557,623.0253165,891.4050633,79,12.80220255,8.319553484,0.760059667,0.877777778,0.552447552,0.526872957
+4233,38632.20536,926.875,479.2589286,1092.633929,34845.79464,739.5178571,632.1428571,1620.098214,19765.9375,597.7857143,465.1785714,1702.633929,25182.5,1346.875,2067.464286,2716.205357,8884.098214,1310.285714,317.4732143,2289.794643,18602.6875,411.1785714,196.4553571,498.5089286,23644.71429,456.1160714,121.4732143,2091.955357,18432.20536,1469.053571,561.0089286,2785.3125,15883.23214,624.7053571,279.9732143,1742.232143,11402.875,868.1964286,411.2053571,1312.178571,7991.866071,672.1160714,160.8125,2740.616071,7376.446429,1400,594.2410714,3281.669643,698.3482143,891.7321429,112,14.43830059,10.33808674,0.69808156,0.941176471,0.583333333,-1.34439397
+4234,32659.48193,805.8313253,574.6144578,1096.13253,28208.93976,656.8433735,774.4096386,1686.783133,12992.45783,524.7831325,1436.795181,1813.325301,18332.60241,1143.26506,4812.168675,5157.60241,6968.481928,1199.698795,294.3373494,2340.686747,14606.6988,432.3614458,415.1686747,1827.313253,18826.03614,817.2409639,121.4216867,4324.686747,13880.54217,2261.26506,467.3975904,2783.144578,11538.03614,598.8915663,264.060241,1318.084337,6654.204819,1346.746988,382.9518072,1302.843373,3771.73494,673.1204819,152.3855422,3960.168675,3977.650602,1157.120482,187.253012,3249.204819,977.7831325,890.7831325,83,15.90207163,7.166173981,0.892703724,0.83,0.488235294,-1.379740584
+4235,21323,846.6516854,594.7191011,1109.393258,19504.04494,682.4382022,650.0786517,1666.101124,9935.764045,541.5280899,1367.314607,1870.044944,12657.38202,1262.404494,3099.820225,3371.359551,4821.494382,1316.41573,309.0674157,2361.898876,10475.69663,393.8988764,445.6629213,1314.05618,13003.65169,444.7865169,212.4044944,2557.640449,9537.853933,1912.52809,417.6853933,2835.404494,8503.719101,1296.247191,277.7640449,1670.303371,5088.808989,1155.651685,428.1235955,1323.741573,3725.449438,706.9213483,160.247191,3056.977528,3361.134831,1333.685393,1371.595506,3197.606742,312.0224719,890.6853933,89,15.92573355,7.958711597,0.866175988,0.839622642,0.581699346,-1.349806637
+4236,19145.52903,1056.535484,613.6258065,1062.903226,17607.56129,688.5870968,662.9806452,1508.845161,8756.141935,555.9290323,1100.83871,1774.212903,10565.84516,1186.987097,5772.154839,3702.43871,4165.303226,1267.219355,282.3741935,2503.329032,8870.529032,356.5290323,840.7677419,777.0709677,10204.73548,517.9806452,131.6387097,3243.819355,7691.509677,1708.554839,477.316129,2808.845161,7075.870968,607.3677419,265.3225806,1447.522581,4324.664516,1069.974194,400.0516129,1316.374194,3175.787097,780.5032258,161.4,4106.567742,2794.483871,1227.412903,550.4,3335.812903,332.3290323,892.1870968,155,21.035324,9.70917229,0.887106319,0.885714286,0.640495868,-1.475796837
+4237,24421.60448,911.5746269,525.5447761,1073.746269,22593.76866,703.8432836,597.880597,1533.402985,12154.51493,570.8731343,1014.970149,1730.828358,14424.70896,1290.753731,1991.425373,2326.507463,5546.477612,1529.567164,311.8283582,2425.514925,11794.56716,408.9328358,423.5970149,732.9850746,14562.26866,609.3059701,122.6268657,1382.455224,11284.90299,1664.559701,505.358209,2836.022388,10062.1791,627.2313433,288.5074627,1503.276119,6756.268657,1054.970149,429.1716418,1319.947761,4935.350746,767.7164179,165.7238806,3151.126866,4422.246269,1363.067164,384.9925373,3286.58209,404.1641791,895.1791045,134,14.80526692,12.06115586,0.579948625,0.917808219,0.525490196,-0.391878626
+4238,31845.39024,909.7682927,647.3414634,1270.890244,29362.39024,749.3170732,904.4390244,1747.54878,16147.56098,628.8780488,1632.5,1768.52439,19675.87805,1342.097561,1178.02439,3319.609756,7220.317073,1397.890244,331.6585366,2837.182927,15908.56098,440.1585366,270.8414634,869.2073171,19686.70732,1605.353659,172.1707317,958,15351.91463,1613.804878,463.4756098,2835.097561,13487.43902,646.6097561,301.4268293,2107.731707,9217.536585,1158.780488,457.5731707,1362.841463,6869.060976,672.6829268,176.195122,2574.414634,6137.353659,1424.719512,597.9390244,3270.585366,479.9512195,890.7073171,82,14.81955351,7.615545853,0.8578591,0.88172043,0.650793651,-1.209057283
+4239,21108.42268,915.5773196,849.5876289,1125.649485,18716.49485,693.7835052,1012.082474,1581.989691,10568.25773,560.0309278,1215.587629,1849.948454,12608.81443,1281.484536,2543.639175,2405.103093,4517.237113,1344.958763,309.7938144,2639.164948,9859.041237,419.1443299,131.7216495,482.8041237,12239.52577,517.9072165,123.814433,1301.56701,9464.525773,1873.443299,449.0309278,2801.721649,8396.783505,829.9381443,272.556701,1331.216495,5865.247423,981.8350515,430.4742268,1328.701031,4371.793814,602.1649485,172.1649485,2426.515464,3950.587629,1332.907216,875.8350515,3310.587629,552.3298969,893.4742268,97,12.7684196,9.925446606,0.629076506,0.923809524,0.62987013,0.02256922
+4240,27610.3937,1000.944882,492.3937008,1037.472441,24316.96063,729.5984252,656.7086614,1458.637795,13718.35433,588.3937008,916.4330709,1714.992126,17248.72441,1328.559055,2032.669291,3150.629921,6334.275591,1334.968504,295.015748,2336.818898,13057.80315,478.0629921,165.3385827,746.7322835,15854.32283,1380.070866,123.8582677,1816.307087,12631.09449,1451.574803,687.1811024,2785.488189,10947.04724,664.7401575,273.9527559,1493.700787,7703.425197,1043.511811,391.8425197,1298.76378,5494.377953,613.7480315,160.5511811,1856.818898,4978.787402,1339.937008,1380.968504,3253.779528,735.7795276,894.511811,127,15.61012275,10.95951803,0.712100413,0.907142857,0.604761905,1.096788405
+4241,25124.62602,929.2682927,503.0325203,1069.097561,21997.53659,727.3333333,453.6504065,1436.821138,12436.65854,670.8455285,522.7723577,1715.406504,15426.9187,1317.512195,3245.845528,1756.373984,5801.780488,1362.861789,304.8699187,2279.617886,11807.33333,410.0569106,548.9186992,758.7723577,15053.69106,431.5121951,126.2276423,1402.886179,11709.21138,1716.98374,538.8292683,2801.04878,10305.73171,615.0162602,275.2439024,1160.195122,7126.373984,883.7073171,411.8130081,1324.593496,4915.642276,736.6097561,164.2764228,2194.300813,4628.455285,1426.414634,3884.560976,3106.878049,800.195122,892.7235772,123,14.50891008,11.10268303,0.643754539,0.92481203,0.683333333,1.193623719
+4242,37651.77451,1012.823529,509.4215686,1108.401961,33537.0098,755.9901961,720.2156863,1620.77451,18219.03922,586.7254902,1697.04902,1763.421569,22943.52941,1319.892157,3670.235294,3050.156863,8033.647059,1285.313725,309.9607843,2359.147059,16927.45098,412.9215686,217.254902,1267.637255,21409.57843,729.127451,187.0980392,2159.77451,16368.85294,2070.558824,479.7941176,2808.039216,13976.88235,599.3529412,278.4705882,1155.196078,9199.509804,1367,398.0196078,1311.72549,5982.715686,627.2156863,156.8137255,2312.803922,5594.598039,1260.470588,240.0490196,3364.686275,850.5784314,893.3333333,102,13.01510667,10.41611745,0.599586708,0.918918919,0.607142857,-1.324881801
+4243,20224.88679,722.3773585,562.4339623,1020.311321,17789.64151,584.745283,585.1603774,1461.679245,8396.528302,731.3301887,633.9433962,1715.764151,11984.42453,1072.698113,4641.320755,2999.264151,4596.820755,1110.40566,286.1037736,2306.59434,9288.056604,341.1320755,1796.95283,721.3490566,11875.59434,462.4622642,112.9339623,3125.349057,8774.801887,1725.971698,502.7641509,2804.830189,7357.811321,643.1226415,235.4433962,1206.141509,4510.358491,862.754717,357.4716981,1390.575472,2538.45283,1029.764151,144.8679245,3845.320755,2745.867925,1078.660377,446.4339623,3112.584906,962.8018868,892.3113208,106,12.64433071,10.74132914,0.527592413,0.963636364,0.803030303,-0.379551961
+4244,24748.90769,810.9384615,571.4615385,1060.307692,23614.07692,665.0769231,655.6307692,1584.384615,12250.66154,556.8307692,570.9846154,1786.707692,15093.21538,1188.153846,4799.046154,2343.276923,5556.2,1532.523077,316.4769231,2309.446154,12186.2,609.4,2510.523077,506.4461538,14766.69231,463,120.4769231,1274.938462,11497,1781.153846,768.0461538,2821.492308,10325.61538,639.7230769,276.1384615,1340.769231,6362.230769,987.6769231,420.3076923,1329.015385,4556.446154,1131.892308,158.9692308,1889.261538,4238.692308,1293.446154,259.3538462,3224.892308,345.8615385,893.9230769,65,10.74328448,8.174752129,0.648848754,0.915492958,0.677083333,0.037052998
+4245,29566.67416,915.752809,701.2921348,1129.348315,27231.16854,771.1685393,925.9325843,1704.359551,15447.30337,571.6629213,1408.382022,1814.752809,18762.29213,1337.505618,1474.820225,1883.191011,6793.348315,1402.88764,332.9775281,2355.764045,14858.23596,457.9775281,157.8202247,942.6067416,18256.89888,504.1123596,312.6067416,856.2696629,14566.60674,1905.88764,518.8426966,2816.539326,12834.06742,777.9438202,307.4382022,1667.719101,8976.674157,1417.865169,453.7078652,1328.853933,6534.808989,625.6067416,172.6292135,2009.370787,5924.123596,1433.696629,217.5730337,3329.786517,522.6853933,893.4157303,89,12.86229758,9.930601663,0.635536786,0.801801802,0.570512821,0.809045931
+4246,19958.20567,877.2624113,575.3546099,1090.390071,18761.00709,714.1205674,603.1205674,1543.992908,9981.312057,630.1489362,765.1134752,1743.326241,12305.91489,1303.304965,1470.163121,1387.453901,4700.453901,1433.326241,317.0638298,2402.588652,10222.7305,424.822695,442.6382979,657.7446809,12349,606.7801418,128.4184397,864.4751773,9593.12766,1583.489362,452.5106383,2853.524823,8684.276596,832.9574468,294.6808511,1966.957447,5923.93617,923.0780142,438.8723404,1346.865248,4481.546099,678.9716312,174.7304965,2354.865248,4099.496454,1412.205674,1079.156028,3225.191489,488.7021277,895.5744681,141,17.17709416,10.92492357,0.771675061,0.946308725,0.677884615,-1.096740141
+4247,29801.64948,1119.721649,538.3814433,1071.927835,26714.92784,783.443299,540.0824742,1545.360825,15459.59794,688.257732,578.257732,1704.505155,18305.5567,1407.783505,2042.082474,2561.43299,6394.494845,1357.030928,308.4639175,2302.824742,14191.29897,421.0206186,141.8041237,566.9072165,17937.09278,849.6391753,118.9896907,1544.185567,13653.03093,1429.113402,527.8659794,2780.28866,11828.57732,677.5773196,283.5154639,1569.43299,8343.247423,1187.886598,396.5257732,1308.257732,6079.57732,629.3917526,159.8762887,1796.402062,5518,1442.412371,1003.494845,3393.896907,646.0103093,894.3814433,97,11.68477312,10.74648353,0.392622304,0.950980392,0.621794872,-0.081724248
+4248,30529.05455,864.5727273,485.8636364,1058.936364,27817.68182,677.5727273,929.9454545,1506.509091,15797.35455,542.1363636,1638.672727,1710.381818,20208.92727,1253.3,2472.990909,2472.490909,7206.663636,1709.054545,290.6181818,2475.127273,14598.46364,393.5818182,184.1,1277.581818,18211.96364,1180.027273,151.6363636,1294.054545,14355.11818,1632.372727,495.2727273,2801.218182,12324.21818,692.8181818,265.3363636,1271.4,8862.390909,1409.336364,399.4,1289.881818,6251.963636,621.3545455,159.1545455,2816.390909,5795.263636,1324.936364,275.3909091,3228.336364,713.0727273,894.7181818,110,13.07663962,10.8682497,0.556093912,0.956521739,0.650887574,-0.975853345
+4249,22233.13077,822,484.8076923,1071.792308,20143.48462,655.6461538,681.6538462,1530.4,11203.48462,499.6538462,424.9384615,1692.392308,14083.24615,1213.930769,914.5769231,781.8692308,5313.292308,1217.253846,283.9923077,2279.646154,11532.17692,406.5692308,106.3230769,494.0307692,13702.23846,525.4769231,117.3615385,844.7153846,10749.11538,1315.969231,574.7538462,2843.261538,9467.661538,624.2307692,261.9230769,1832.146154,6639.307692,784.1,399.0923077,1332.523077,4662.738462,621.5,154.1307692,2157.823077,4419.069231,1324.576923,1094.846154,3191.876923,758.9,893.7846154,130,16.57296836,10.20425298,0.787967624,0.942028986,0.8125,-1.391765437
+4250,34209.58667,1008.853333,568.2,1093.28,30675.30667,757.5333333,744.2,1574.493333,17695.74667,624.88,929.52,1792.466667,20882.53333,1346.96,2854.373333,4101.253333,7440.106667,1340.906667,303.3466667,2339.866667,15832.76,419.6533333,505.8933333,603.9333333,20167.41333,494.44,126.3066667,3229.44,15647.13333,1791.106667,540.7466667,2804.92,13765.78667,635.1333333,295.4933333,1540.186667,9444.16,1042.96,441.2,1319.733333,7017.8,964.6133333,162.68,2693.52,6330.933333,1356.466667,195.8,3370.146667,575.8,894.68,75,14.3599841,6.877435813,0.877852766,0.903614458,0.535714286,-1.062238825
+4251,33028.07576,861,470.1363636,1071.19697,29453.48485,721.7575758,811.6212121,1587.984848,16600.93939,524.0757576,850.7878788,1761.242424,20997.4697,1240.530303,3994.666667,3036.954545,7710.893939,1297.075758,302.3484848,2489.136364,15850.51515,403.9242424,109.8636364,1006.227273,20180.5,567.5606061,134.0151515,2894.651515,15630.59091,1504.575758,475.5,2788.484848,13456.06061,591.8484848,281.9242424,1495.893939,9063.772727,955.0909091,415.1969697,1287.727273,5863.787879,609.8333333,155.9848485,3164.060606,5697.545455,1306.106061,279.8787879,3254.924242,825.0909091,895.0757576,66,13.44426765,6.577996107,0.872127391,0.942857143,0.5,0.787896272
+4252,24244.97414,812.1551724,459.25,1067.87931,21269.52586,662.8275862,862.2586207,1590.62931,11335.16379,600.7413793,1379.137931,1976.663793,14404.23276,1204.284483,4044.146552,3055.646552,5554.732759,1246.025862,312.4655172,2314.284483,11339.82759,466.0689655,511.3362069,1493.103448,14362.50862,485.5172414,161.9224138,1289.982759,10900.94828,1996.5,445.8362069,2827.387931,9508.844828,753.3189655,268.5172414,1126.008621,6278.310345,1679.25,400.4827586,1322.732759,3926.387931,687.7672414,161.7327586,2265.741379,3909.87931,1264.75,1597.482759,3162.793103,879.0258621,896.8965517,116,15.66760729,9.951573281,0.772373459,0.90625,0.591836735,1.02853435
+4253,30060.10891,1012.19802,921.4653465,1181.722772,26515.36634,804.8811881,945.5247525,1807.792079,14556.66337,657.0693069,551.7227723,1805.475248,17333.08911,1431.60396,1051.732673,1518.653465,6204.336634,1513,360.9108911,2398.29703,13829.50495,504.2475248,465.6930693,478.8613861,17037.61386,512.3168317,134.039604,1253.376238,13092.49505,1655.772277,475.0891089,2816.980198,11572.50495,746.4653465,325.8316832,1737.514851,7752.356436,895.2277228,481.009901,1358.693069,5762.059406,709.7029703,181.1485149,1494.247525,5215.673267,1507.891089,214.980198,3374.722772,460.7821782,896.1584158,101,12.66625662,10.31721264,0.580102962,0.90990991,0.647435897,-1.468816767
+4254,28296.86111,889.1574074,501.9537037,1067.175926,24582.31481,717.25,723.1666667,1487.861111,14267.78704,554.0833333,949.4444444,1748.351852,17145.7037,1343.592593,2526.351852,2483.990741,6296.37963,1286.814815,303.1574074,2384.361111,13341.63889,432.5925926,266.2592593,785.1574074,16942.89815,1134.185185,122.1296296,1633.851852,12738.76852,1632.87037,506.1666667,2806.805556,11048.37963,602.0092593,282.2314815,1264.814815,7753.425926,1034.898148,431.1388889,1310.231481,5745.583333,862.1481481,158.9814815,2846.740741,5167.111111,1405.240741,1557.314815,3216.898148,587.0925926,897.3055556,108,14.14184945,9.798302019,0.721073477,0.947368421,0.692307692,0.629109607
+4255,33126.06364,868.9909091,484.1545455,1097.036364,30452.15455,753.6636364,1024.981818,1614.472727,16299.15455,546.0636364,1472.118182,1915.6,21161.97273,1259.081818,3407.018182,3943.227273,7799.327273,1339.645455,308.0181818,2706.154545,15780.4,524.4272727,132.5818182,2106.609091,20741.63636,1211.936364,365.4363636,2009.318182,15690.79091,1800.554545,484.2545455,2774.363636,13547.13636,606.8,281.7090909,1301.436364,9179.763636,1369.163636,420.4363636,1294.409091,6072.172727,619.5636364,161.4090909,3757.109091,5766.327273,1315.081818,245.8818182,3300.518182,818.6272727,899.4272727,110,15.06874777,10.55237771,0.713866,0.833333333,0.458333333,0.689786391
+4256,32930.0641,891.6025641,578.9871795,1105.717949,30385.64103,733.5769231,1025.525641,1676.397436,16145.51282,576.1923077,2620.217949,1787.282051,19684.11538,1303.730769,6393.269231,4572.423077,7404.769231,1353,320.2435897,3074.628205,16448.89744,401.4102564,341.7051282,2035.115385,20044,485.4102564,142.7179487,2972.974359,15470.96154,2498.358974,375.3076923,2839.230769,13790.20513,632.6410256,315.7948718,1504.589744,8061.897436,1740.730769,452.8076923,1315.487179,5771.410256,705.0641026,176.9230769,4430.025641,5338.230769,1387.576923,333.3846154,3264.24359,318.2179487,897.8205128,78,11.82236623,8.728513574,0.674466858,0.975,0.541666667,-0.775408594
+4257,16279.90826,1178.357798,682.4862385,1112.908257,14870.77064,827.4311927,477.3577982,1518.724771,8208.752294,623.9174312,467.3302752,1702.963303,10092.73394,1544.330275,903.3853211,1847.513761,3472.311927,1376.229358,334.0550459,2303.091743,9325.247706,531.146789,143.7614679,661.9633028,10153.84404,518.3119266,129.733945,1424.770642,7700.889908,1681.807339,535.2201835,2791.238532,7076.46789,641.7431193,301.4678899,1485.706422,5015.357798,1250.669725,432.6788991,1306.321101,3738.706422,641.1284404,177.7431193,1503.880734,3601.779817,1565.889908,720.6422018,3254.220183,617.293578,898.5779817,109,13.04724709,11.03453336,0.533600729,0.956140351,0.698717949,0.827875566
+4258,24827.27419,836.1290323,459.7258065,1049.483871,22875.3871,662.6935484,569.983871,1438.080645,13012.80645,545.0645161,488.4193548,1687.677419,16023.56452,1247.693548,1905.66129,3371.758065,5845.516129,1261.983871,292.6451613,2267.741935,12271.70968,385.6290323,292.1774194,601.6774194,15597.90323,458.6129032,120.1935484,1338.403226,11595.20968,1378.306452,672.3225806,2785.387097,10166.90323,640.2258065,265.2903226,1777.66129,7445.596774,892.1129032,392.4354839,1293.403226,5482.225806,648.5,159,2525.33871,5060.403226,1347.177419,917.9677419,3092.33871,680.483871,895.4032258,62,11.98651416,7.494629544,0.780420409,0.911764706,0.52991453,-1.124161482
+4259,42912.10067,887.2550336,499.2818792,1123.208054,38504.65101,723.6577181,622.114094,1660.067114,22631.61074,557.9328859,756.0134228,1725.456376,28359.47651,1337.442953,2136.791946,4473.838926,10217.7047,1354.959732,315.7986577,2328.053691,21466.58389,421.5302013,122.9060403,515.852349,27072.85906,486.9932886,122.7785235,2227.369128,21379.24161,1469.040268,718.6174497,2793.577181,18782.66443,625.8255034,295.0201342,1878.926174,13416.72483,1041.369128,427.9261745,1304.201342,9457.758389,634.0872483,166.590604,2707.879195,8735.234899,1483.295302,307.4765101,3231.557047,689.1409396,900.1879195,149,17.48822421,12.3946829,0.70546525,0.837078652,0.551851852,-1.401847333
+4260,38907.56579,875.6644737,532.4210526,1134.210526,29504.33553,613.3684211,696.8947368,1591.072368,13206.38816,468.0328947,1172.335526,1740.269737,19242.46711,1131,4003.598684,2929.138158,7373.407895,1164.197368,280.7171053,2350.388158,15040.98684,367.1513158,188.9473684,1420.572368,19076.19737,608.5328947,114.6513158,2968.322368,14379.22368,1681.546053,391.2434211,2793.046053,11797.47368,697.0986842,260.9934211,959.4868421,6587.381579,1093.381579,381.0723684,1282.578947,3631.348684,590.5921053,144.0592105,2254.421053,3923.960526,1133.407895,376.4276316,3101.703947,985.4736842,898.0526316,152,16.20184437,12.63131428,0.626250381,0.932515337,0.571428571,-1.252382285
+4261,26712.74843,970.2138365,670.5345912,1102.36478,25543.41509,759.5471698,650.7672956,1756.157233,11546.53459,593.509434,683.5345912,1804.628931,15864.08176,1355.666667,5818.54717,3416.823899,5698.371069,1355.408805,342.1006289,2391.666667,11243.67925,573.8238994,791.1132075,513.5534591,13980.47799,493.4025157,127.754717,4346.981132,10297.55346,1808.540881,480.3144654,2745.427673,8994.150943,650.0628931,286.5534591,1206.566038,4488.654088,994.9685535,423.2893082,1270.515723,3252.27673,764.7421384,164.5597484,3399.440252,3220.232704,1330.012579,2059.018868,3300.754717,270.4528302,899.5220126,159,17.71325077,12.33122174,0.71788857,0.883333333,0.630952381,1.530666596
+4262,36239.54412,936.4117647,622.1862745,1325.77451,32222.69118,743.2696078,933.9558824,2165.823529,18031.65196,599.6715686,1622.647059,1778.946078,21694.41176,1327.661765,2485.303922,3789.617647,8288.308824,1580.779412,333.6715686,2648.196078,17819.16176,430.1127451,215.1862745,1003.759804,21770.07353,937.4705882,128.5539216,1670.666667,17059.48529,1799.289216,512.7696078,2837.441176,15196.04902,657.5392157,310.6127451,1551.955882,10111.2598,1518.465686,459.4901961,1331.220588,7355.083333,664.127451,175.2205882,2950.068627,6659.573529,1435.764706,268.7205882,3297.107843,422.6813725,901.6176471,204,20.9183488,13.4815921,0.764615741,0.842975207,0.566666667,-0.828390068
+4263,21681.1413,1037.782609,563.0434783,1061.054348,19210.69565,760.3695652,451.0652174,1480.065217,11140,660.1413043,479.2391304,1742.097826,13720.29348,1431.891304,915.7391304,1898.173913,5055.065217,1334.597826,310.0543478,2276.913043,10953.97826,430.326087,119.5978261,541.3913043,13769.40217,451.1195652,120.173913,948.3043478,10568.69565,1452.021739,616.0869565,2794.76087,9253.630435,715.3478261,275.0652174,1408.347826,6653.380435,997.1086957,407.3586957,1294.869565,5062.51087,616.2065217,168.1086957,3204.945652,4693.858696,1447.423913,1404,3165.684783,631.2717391,897.9891304,92,13.302449,8.980205695,0.737745328,0.978723404,0.707692308,-1.008733476
+4264,33355.84354,945.3605442,586.7414966,1124.387755,18592.42177,614.5238095,614.7414966,1551.693878,8255.435374,479.2244898,1003.612245,1750.646259,11619.95918,1131.836735,5748.22449,3053.367347,4366.92517,1167.897959,276.1972789,2318.190476,9327.285714,331.1564626,851.2108844,822.3061224,11030.72789,430.1360544,257.5170068,4900.530612,8239.693878,2087.081633,311.6530612,2796.312925,7278.088435,572.6598639,255.6326531,1118.734694,3294.047619,932.5782313,385.2789116,1305.945578,2345.789116,758.2040816,149.0544218,3488.911565,2277.619048,1173.44898,758.9455782,3172.272109,256.5102041,903.3129252,147,19.91171596,11.10843481,0.829918699,0.812154696,0.480392157,-0.698293111
+4265,27093.15789,888.75,617.3289474,1128.723684,24169.09211,708.0921053,625.1315789,1721.289474,12078.65789,563,878.0131579,1813.486842,15529.39474,1303.421053,3802.25,4495.197368,5758.223684,1325.078947,301.8815789,2335.184211,12570.94737,394.4605263,656.2763158,1342.447368,15457.86842,499.2894737,183.5657895,5257.723684,11719.89474,1684.421053,517.9342105,2815.026316,10442.61842,1132.828947,286.8684211,2196.157895,5985.210526,1017.263158,436.4736842,1326.026316,4216.513158,730.5526316,169.5921053,5445.302632,3855.263158,1333.434211,824.2631579,3303.144737,306.8289474,898.2894737,76,12.03444309,8.315815592,0.722853533,0.915662651,0.633333333,-1.363988507
+4266,36067.98387,908.6290323,549.8387097,1097.096774,31323.30645,734.9516129,811.6129032,1608.129032,18266.27419,590.1129032,972.3064516,1743.387097,21892.58065,1289.580645,3056.66129,3026.774194,7980.096774,1527.66129,330.9193548,2441,17376.75806,427.1935484,422.1935484,670.8548387,21545.80645,748.1451613,131.1451613,2282.66129,17296.19355,1734.33871,522.9677419,2842.33871,15298.79032,624.7096774,314.7580645,1545.177419,10244.95161,1130.387097,463.9677419,1331.951613,7225.016129,761.4193548,175.3548387,3202.548387,6765.725806,1439.758065,245.8709677,3307.177419,413.3064516,898.1290323,62,10.67862006,7.505139251,0.711368517,0.96875,0.688888889,-0.645411121
+4267,18616.69271,838.4739583,456.1770833,1063.067708,16599.79688,668.3177083,480.59375,1459.484375,9014.375,585.375,444.5625,1710.072917,11689.22396,1231.166667,2297.270833,1015.333333,4287.989583,1289.807292,296.4114583,2276.296875,8788.947917,393.5572917,292.4791667,620.3020833,11113.73438,522.8020833,120.9739583,806.8072917,8867.25,1433.598958,532.328125,2837.96875,7618.302083,646.59375,265.65625,1732.796875,5253.635417,829.578125,402.59375,1314,3654.458333,694.515625,163.6875,2027.421875,3468.229167,1407.109375,6597.916667,3178.963542,789.0572917,901.90625,192,17.37446838,14.2425901,0.572732257,0.941176471,0.705882353,0.815737557
+4268,35119.10497,879.5027624,510.4751381,1100.546961,32028.79006,730.0773481,958.4585635,1649.629834,17683.0442,548.7790055,2005.486188,1846.895028,22197.30387,1262.552486,4051.425414,3893.342541,8141.502762,1288.314917,311.6077348,2607.40884,17274.24309,436.0607735,201.7679558,2462.088398,21643.69613,845.5635359,510.1104972,2280.508287,16851.09945,2121.497238,519,2825.027624,14629.39227,605.8729282,287.198895,1317.679558,9700.790055,1287.508287,421.4033149,1293.447514,6338.348066,633.5911602,160.9281768,3469.060773,6102.403315,1308.541436,364.8508287,3323.823204,837.1657459,902.3038674,181,17.22633899,14.48754009,0.541018064,0.878640777,0.532352941,-0.138248494
+4269,22424.50467,839.2056075,587.2803738,1095.53271,19784.57009,682.5046729,912.5794393,1606.327103,10699.83178,725.2056075,1383.383178,1810.878505,13356.96262,1216.841121,3087.411215,2659.719626,5066.046729,1232.990654,313.6168224,2897.766355,10552.78505,961.8785047,1047.196262,614.7943925,13451.09346,600.2336449,127.7757009,1195.962617,10401.39252,2192.766355,484.4392523,2820.803738,9055.121495,1079.205607,269.2616822,1192.401869,6058.850467,1317.560748,407.5327103,1398.766355,3877.943925,846.4766355,163.5700935,2842.878505,3800.242991,1294.869159,2871.046729,3277.757009,864.2149533,900.364486,107,12.40992368,11.18693911,0.432880988,0.955357143,0.685897436,-0.127727694
+4270,27343.328,779.784,508.816,1055.088,23793.2,641.88,1017.672,1610.016,10890.552,517.472,2044.872,1913.616,15175.472,1127.704,4685.072,4044.016,5820.944,1163.232,278.928,2413.448,12058.912,374.616,369.32,2175.984,15324.544,473.264,117.016,2775.384,11410.488,2398.24,385.92,2797.76,9491.944,716.32,255.696,1037.88,5358.512,1596.912,384.808,1312.568,3029.944,650.096,149.592,2531.744,3226.176,1144.984,1419.904,3178.856,972.568,900.6,125,16.33363393,10.33452557,0.774385223,0.932835821,0.600961538,0.995844537
+4271,24652.31765,951.0705882,600.5882353,1114.094118,22401.36471,764.9294118,933.1647059,1637.152941,11928.48235,624.5176471,1106,1816.164706,14596.76471,1320.788235,2783.247059,3957.882353,5393.517647,1339.941176,321.1176471,2441.223529,11561.22353,416.7411765,993.6823529,917.1058824,13859.61176,519.6235294,133.0235294,2150.894118,10746.98824,1823.623529,558.5529412,2820.952941,9624.529412,625.6823529,294.6941176,1867.152941,6099.482353,1321.117647,436.4823529,1358.647059,4359.717647,810.0470588,169.2705882,5157.447059,3931.223529,1373.047059,555.2,3253.341176,360.4823529,900.0352941,85,11.69211394,9.384538254,0.596466082,0.934065934,0.643939394,-1.193747331
+4272,33027.1791,948.2686567,797.2686567,1164.80597,29284.49254,760.3283582,932.0447761,1743.477612,16606.73134,591.8208955,766.9104478,1780.671642,20414.76119,1337.074627,862.7014925,1514.328358,7437.731343,1458.955224,339.9253731,2417.701493,16114.79104,471.3283582,150.2238806,537.4776119,20234.55224,857.6865672,133.8358209,987.8955224,15806.97015,1485.164179,442.9104478,2816.447761,13847.02985,757.1641791,316.7761194,1907.80597,9338.283582,969.2686567,478.9850746,1358.477612,6924.328358,643.7910448,173.8059701,1038.164179,6288.238806,1485.104478,171.2985075,3329.865672,474.2238806,899.4776119,67,10.18690804,8.847745269,0.495617672,0.881578947,0.609090909,0.714548509
+4273,23807.40909,926.5454545,464.7181818,1053.709091,21706.79091,740.2363636,483.8818182,1458.163636,12418.89091,557.5454545,451.4727273,1672.372727,14979.26364,1392.427273,882.9363636,1518.190909,5065.090909,1246.818182,301.2818182,2277.845455,11764.55455,432.5727273,114.0636364,587.9272727,14958.68182,513.0454545,120.8545455,1071.645455,11439.75455,1407.790909,517.6,2795.609091,10229.76364,650.0181818,279.6454545,1417.345455,7047.645455,918.6727273,425.8363636,1315.736364,5147.163636,617.3727273,162.4545455,1841.9,4888.990909,1514.163636,6616.336364,3175.172727,599.6545455,900.4272727,110,13.50696855,10.60722422,0.619096473,0.956521739,0.650887574,-0.749958654
+4274,24049.92079,951.1881188,461.8514851,1052.881188,21935.93069,711.6930693,547.9207921,1460.217822,12458.35644,595.6138614,1069.643564,1703.326733,15433.47525,1363.772277,939.3168317,2345.475248,5929.792079,1309.80198,309.8613861,2309.772277,11882.42574,624.980198,147.0891089,771.049505,14900.91089,1429.792079,117.6534653,969.3762376,11264.37624,1368.930693,546.6930693,2793.366337,9933.722772,646.2772277,273.0693069,1565.623762,7234.673267,2095.683168,406.950495,1309.752475,5340.435644,632.039604,166.029703,2033.782178,4926.940594,1412.841584,1182.831683,3208.029703,653.039604,901.6237624,101,12.64800737,10.63318722,0.541500252,0.926605505,0.647435897,-0.539426205
+4275,31163.01235,996.691358,459.4197531,1070.851852,27237.95062,746.5061728,623.6790123,1557.962963,16502.04938,588.5555556,547.8395062,1703.506173,19584.62963,1374.506173,3070.432099,2217.91358,6855.604938,1299.271605,305.5802469,2290.123457,15187.83951,411.1234568,387.9135802,645.308642,18911.08642,477.1975309,120.4074074,1687.493827,14674.4321,1483.419753,517.0493827,2774.296296,12997.25926,593.8518519,275.1358025,1371.716049,9201.654321,988.9876543,428.691358,1300.814815,6528.432099,678.7283951,161.5308642,2099.160494,6047.024691,1410.209877,343.2098765,3281.901235,671.2469136,899.8271605,81,11.7760997,9.243932375,0.619528676,0.91011236,0.613636364,-1.120757969
+4276,31594.15455,841.0545455,660.3727273,1120.063636,28723.34545,706.7818182,983.2363636,1725.9,14817.37273,528.1363636,1844.972727,1787.145455,19518.61818,1236.172727,4070.845455,3694.681818,7365.590909,1289.963636,324.2363636,2329.854545,15472.81818,424.9909091,376.1636364,1921.990909,20163.29091,571.3090909,128.4181818,1873.136364,14999.4,2162.1,525.5454545,2810.218182,12583.49091,710.2,291.2090909,1231.354545,8134.236364,1470.445455,420.8818182,1318.454545,4905.790909,673.3909091,158.6636364,2450.118182,4899.654545,1292.309091,1181.409091,3258.345455,907.5090909,900.2727273,110,15.16012592,9.821918667,0.761743745,0.901639344,0.564102564,-1.035468775
+4277,39236.06897,992.3103448,471.5,1059.189655,35045.03448,788.2068966,547.0344828,1549.103448,19721.96552,623.1896552,550.0862069,1701.327586,24072.46552,1490.87931,1485.37931,2068.413793,8803.586207,1468.586207,364.4655172,2278.068966,19093.08621,456.4655172,296.2241379,511.3448276,24337.98276,527,139.5172414,1606.982759,19127.58621,1562.327586,536.5862069,2800.862069,17121,668.0862069,332.3793103,1274.862069,11305.93103,1028.224138,479.6896552,1312.448276,8070.689655,711.6206897,181.8793103,1697.896552,7632.741379,1610.224138,435.2068966,3186.913793,396.2758621,900.6206897,58,11.90913143,6.413714026,0.842590801,0.935483871,0.58,0.65223071
+4278,23830.78512,965.8181818,735.4545455,1143.545455,21069.47107,741.1983471,872.0330579,1685.07438,11615.61983,595.5371901,547.6363636,1760.586777,14092.29752,1335.380165,1033.669421,1360.942149,5106.735537,1436.421488,322.9752066,2345.413223,11455.80165,441.2644628,214.7272727,441.5867769,13874.32231,465.3636364,127.5867769,1299.950413,10884.3719,1517.735537,443.5041322,2858.008264,9677.545455,665.2892562,300.5289256,1641.520661,6498.371901,1002.190083,450.4958678,1344.85124,4727.305785,636.5785124,169.785124,1467.595041,4272.942149,1403.066116,315.3636364,3358.380165,443.4297521,902.0826446,121,13.76151651,11.31747841,0.568908935,0.96031746,0.715976331,-0.7535337
+4279,24948.2293,980.8343949,612.477707,1118.33758,22625.52866,763.6433121,694.8917197,1656.66879,12328.64968,617.2356688,498.5159236,1766.535032,15259.15924,1384.267516,1027.624204,986.2101911,5634.484076,1450.796178,340.5159236,2333.038217,12129.70064,457.4140127,250.2993631,475.1273885,14789.61146,508.4649682,134.9490446,942.3566879,11599.80255,1513.082803,426.9363057,2900.363057,10248.33758,1301.694268,309.4904459,2098.11465,6948.910828,888.9235669,457.8535032,1351.318471,5134.426752,671.4203822,172.0509554,1663.585987,4580.66879,1431.394904,374.4585987,3330.88535,499.7770701,902.5732484,157,16.80709436,12.41238581,0.674230886,0.963190184,0.615686275,-0.982003593
+4280,43085.98113,1046.886792,547.8301887,1111.113208,37286.50943,800.5660377,623.754717,1643.641509,21444.81132,595.2641509,528.8679245,1717.849057,27085.81132,1360.566038,2987.377358,4680.396226,9378.09434,1316.773585,312.5471698,2273.622642,18621.50943,402.2075472,106.9433962,579.6981132,23491.49057,479.5660377,129.5849057,2742.113208,18413.69811,1455.056604,625.8113208,2792.056604,15771.01887,593.754717,281.509434,1819.113208,10922,965.6226415,413.3018868,1299.377358,7631.377358,629.0754717,166.9433962,3832.90566,6845.433962,1342.943396,181.5283019,3350.698113,702.6792453,899.5660377,53,10.93773002,6.553780255,0.800606736,0.913793103,0.588888889,-0.86551795
+4281,20413.792,852.44,494.52,1073.872,18285.32,682.936,624.24,1552.864,10230.376,512.808,406.928,1713.12,12575.16,1229.816,1090.944,809.776,4788.72,1249.288,293.272,2277.384,9867.04,398.792,99.856,504.328,12019.432,507.832,117.384,899.616,9794.08,1325.512,460.848,2852.696,8499.312,592.048,263.072,1590.408,5768.456,797.688,398.88,1304.304,4094.8,623.232,156.2,2187.4,3869.352,1341.768,626.816,3181.904,776.424,902.864,125,16.92834235,10.08379261,0.803225457,0.919117647,0.558035714,0.786727417
+4282,41136.37895,917.3578947,553.2421053,1115.010526,38142.97895,749.5052632,877.2526316,1713.168421,20755.42105,585.8631579,1182.231579,1820.136842,25109.49474,1306.421053,2991.726316,3336.421053,9250.389474,1394.294737,332.9263158,2387.421053,20600.82105,445.9473684,453.9263158,665.5789474,24599.23158,667.5157895,127.9894737,2676.642105,19265.07368,1708.747368,454.1052632,2820.421053,17311.84211,625.2842105,314.4947368,1557.568421,10402.46316,1271.842105,448.3578947,1329.368421,7360.515789,719.0736842,173.3368421,3453.010526,6723.389474,1408.073684,305.6210526,3279.8,337.8736842,901.1894737,95,16.6558571,7.999019193,0.877130213,0.811965812,0.558823529,-1.381900498
+4283,38563.62585,902.4829932,488.0544218,1076.061224,35524.91156,747.047619,734.8027211,1606.190476,19210.16327,617.0544218,1094.285714,1772.435374,23499.19728,1334.387755,1836.938776,3902.687075,8780.70068,1413.52381,332.0612245,2333.034014,19441.86395,418.9387755,613.2585034,804.1564626,23720.68027,1276.346939,132.0748299,1872.85034,18646.72109,1624.795918,613.5510204,2816.653061,16819.9932,706.0136054,312.2244898,1931.340136,10810.86395,1201.306122,456.9047619,1345.29932,7672.829932,781.0408163,176.5782313,3955.931973,6957.945578,1472.367347,878.122449,3297.959184,369.1360544,905.0544218,147,17.55112328,11.23022317,0.768493326,0.890909091,0.6125,-0.668788266
+4284,26830.92771,839.2650602,697.060241,1098.927711,24240.60241,673.2168675,556.8795181,1532.084337,13967.92771,651.373494,491.2891566,1741.349398,17279.6747,1248.53012,1595.783133,1898.024096,6193.590361,1433.795181,328.373494,2374.096386,13748.71084,400.7228916,469.746988,440.6024096,16934.57831,423.8433735,126.5180723,1465.650602,13486.56627,1498.024096,615.6144578,2801.361446,11965.43373,681.9638554,291.746988,1908.13253,8187.120482,804.1807229,438.2650602,1393.13253,5981.73494,685.7228916,162.9879518,1872.108434,5465.698795,1397.373494,588.3614458,3220.53012,467.2048193,904.5783133,83,12.05378852,9.639750605,0.60036267,0.882978723,0.538961039,-0.187815469
+4285,26272.57419,877.716129,665.9677419,1141.567742,23212.73548,717.4903226,860.8129032,1671.812903,13183.48387,629.3032258,906.6580645,1799.051613,15835.62581,1309.496774,2443.670968,2746.174194,5659.625806,1445.322581,330.9806452,2478.664516,12571.27742,438.4774194,352.4709677,656.6709677,15417.63226,466.316129,130.7225806,2123.135484,11921.2129,1613.264516,749.4258065,2806.606452,10624.41935,706.6709677,292.5419355,1563.916129,7277.309677,977.8258065,444.6258065,1341.277419,5289.870968,684.1225806,166.5741935,1928.251613,4785.903226,1391.632258,316.9741935,3281.464516,543.8967742,905.5612903,155,18.4888007,10.90004931,0.807732798,0.950920245,0.615079365,-0.542230308
+4286,28873.86139,1168.90099,607.7029703,1071.821782,25340.09901,774.6435644,609.5544554,1521.752475,14955.66337,644.1089109,433.0990099,1676,17688.76238,1382.445545,2738.118812,2197.584158,6911.90099,1332.39604,298.2079208,2271.247525,14269.0099,414.1386139,142.3366337,470.7326733,17625.06931,519.5247525,119.9009901,1855.336634,13549.55446,1514.683168,516.8316832,2771.306931,11866.13861,648.3267327,270.6138614,1264.722772,8589.257426,1068.90099,408.2475248,1322.90099,6277.683168,628.7623762,154.7128713,1497.405941,5801.623762,1401.09901,638.1386139,3446.059406,640.9009901,903.8415842,101,13.11226832,9.951622743,0.651142977,0.961904762,0.655844156,0.468574936
+4287,28386.51316,941.995614,493,1072.350877,25508.51316,719.1578947,816.745614,1534.026316,14404.40351,599.3815789,1355.868421,1752.578947,17769.31579,1288.855263,2191.578947,3213.447368,6530.552632,1354.995614,298.754386,2387.280702,13199.47368,376.8552632,279.2236842,1177.372807,16795.04386,664.3377193,116.8859649,1448.684211,13010.72807,1644.684211,543.8596491,2797.855263,11323.60526,624.5789474,270.0438596,1358.938596,7862.846491,1318.236842,405.8070175,1326.039474,5552.298246,647.6096491,157.6578947,3128.004386,5169.285088,1311.97807,493.7894737,3232.324561,731.0877193,906.4517544,228,21.53956965,13.68155064,0.772362356,0.938271605,0.670588235,0.652731677
+4288,39345.37879,790.3181818,445,1074.409091,33096.37879,676,906.2272727,1603.893939,16406.83333,485.9393939,2167.030303,1813.287879,22388.5303,1161.166667,3505.257576,3079.560606,8447.287879,1197.606061,302.5909091,2351.878788,17480.71212,502.4393939,117.1666667,2279.393939,22308.65152,487.6363636,139.030303,1564.772727,16542.93939,2391.075758,380.4848485,2850.515152,14015.18182,566.7575758,264.7121212,895.6515152,8262.575758,1358.818182,412.8181818,1296.590909,4681.954545,580.3484848,159.8484848,2018.969697,4982.469697,1190.757576,188.5,3174.090909,944.0151515,900.5,66,12.25032341,7.142605433,0.812433088,0.929577465,0.611111111,-1.058844917
+4289,30744.33333,968.6767677,629.020202,1098.444444,25477.10101,717.3434343,566.8080808,1699.323232,12184.73737,581.8787879,1363.020202,1791.838384,16033.20202,1294.868687,6370.292929,4478.020202,5807.434343,1412.323232,308.7171717,2737.282828,12341.59596,380.7070707,1362.808081,1170.373737,15707.39394,536.3535354,128.2222222,4685.282828,11323.0202,2143.343434,398.2525253,2817.939394,9848.151515,597.5858586,277.8282828,1448.636364,5472.181818,1350.444444,410.8484848,1319.333333,3850.191919,916.1717172,157.1717172,4072.626263,3563.79798,1259.141414,380.2121212,3360.464646,296.8383838,904.0707071,99,12.89120989,9.909979219,0.639562305,0.933962264,0.634615385,-0.817409032
+4290,38534.05172,928.862069,590.8793103,1119.931034,36174.75862,784.6034483,793.8275862,1747.603448,19210.34483,585.6896552,1218.413793,1756.224138,23678.27586,1348.896552,3735.327586,3540.344828,8673.603448,1401.327586,332.2758621,2406.482759,19653.10345,429.0172414,242.3275862,676.8793103,23703.58621,763.0517241,141.9655172,5356.293103,18380.34483,1783.448276,456.5172414,2814.241379,16543.34483,624.4137931,326.637931,1690.362069,9778.810345,1130.586207,453.7068966,1332.810345,7064.258621,686.5862069,173.6034483,4560.327586,6299.655172,1426.689655,225.6206897,3333.224138,326.9482759,901.3103448,58,9.160127015,8.679621564,0.319625947,0.90625,0.644444444,-0.662370546
+4291,21561.35366,892.3780488,661.1097561,1140.304878,19956.21951,737.3292683,865.7926829,1646.085366,11017.0122,569.097561,546.402439,1795.02439,13542.9878,1333.134146,738.097561,904.0365854,4897.365854,1421.134146,324.9512195,2370.207317,10725.7561,604.8902439,249.8902439,458.1097561,12998.86585,495.0609756,128.9634146,833.4878049,10387.57317,1455.939024,437.3902439,2803.45122,9108.085366,875.097561,296.4756098,1968.487805,6342.012195,896.9268293,455.2073171,1362.841463,4527.073171,646.3902439,166.902439,1242.146341,4202.304878,1412.146341,294.0609756,3289.914634,521.0609756,902.4634146,82,12.66764519,8.618534058,0.732879907,0.953488372,0.621212121,0.958999394
+4292,25508.93827,1092.148148,582.7530864,1067.975309,23350.75309,751.4197531,860.8148148,1488.259259,12561.53086,610.5308642,1249.876543,1771.987654,15297.90123,1302.160494,2751.617284,3141.864198,5538.098765,1260.851852,279.9135802,2374.246914,11741.98765,380.1111111,177.9506173,969.4814815,14734.66667,743.3209877,120.0617284,2294.506173,11163.58025,1725.395062,466,2791.567901,9915.419753,578.8765432,272.9753086,1303,6857.444444,1160.765432,403.617284,1312.740741,5171.901235,646.7777778,152.5925926,2739.037037,4545.753086,1236.82716,263.5925926,3466.962963,577.6790123,902.3209877,81,13.73172054,7.834370459,0.821276158,0.920454545,0.642857143,1.503269952
+4293,22507.72727,1119.954545,608.6022727,1066.795455,20509.75,796.9886364,982.8522727,1577.681818,11160.96591,609.0681818,1025.443182,1803.863636,13582.77273,1280.295455,3091.772727,2296.136364,4755.715909,1233.659091,293.875,2490.670455,10050.13636,401.3522727,552.3522727,1143.75,13443.875,481,231.4545455,2669.977273,10214.86364,2259.284091,622.6363636,2798.465909,8816.590909,667.7159091,265.7727273,1082.159091,5696.272727,1107.852273,395.1590909,1309.590909,4068.875,717.3181818,159.7613636,2493.488636,3706.443182,1225.568182,510.9090909,3884.568182,807.4204545,903.25,88,12.40789916,9.602891541,0.63326661,0.926315789,0.611111111,-0.887623552
+4294,37960.65094,873.8867925,561.990566,1113.716981,19541.5,568.1132075,496.9811321,1492.188679,8369.169811,449.1226415,1212.084906,1692.537736,12926.93396,1053.792453,4180.141509,2750.603774,4930,1089.641509,268,2300.188679,9994.90566,334.5943396,226.0849057,1819.377358,12714.28302,517.2924528,112.009434,2643.40566,9666.113208,1839.188679,350.5754717,2774.518868,7897.566038,558.5943396,234.6509434,858.9339623,4352.433962,939.6981132,356.8018868,1274.896226,2408.745283,608.245283,139.4245283,1953.915094,2689.518868,1090.698113,1920.226415,3063.150943,995.0283019,904.2264151,106,12.2346491,11.65418154,0.304365138,0.946428571,0.627218935,-0.732774252
+4295,19368.67742,793.3612903,524.283871,1078.612903,16675.72903,622.2387097,500.5870968,1646.858065,6572,469.7548387,356.0193548,1705.045161,10376.60645,1110.470968,2044.812903,1215.619355,4007.212903,1138.922581,269,2226.277419,8335.716129,432.1290323,112.8967742,479.0967742,10484.4129,444.2387097,115.8,1920.967742,7828.819355,1290.541935,344.8451613,2805.812903,6437.432258,636.8967742,248.0774194,992.6903226,3373.522581,694.8322581,366.0322581,1300.496774,1918.470968,613.9483871,150.316129,2187.948387,2167.645161,1124.187097,1029.729032,3133.367742,1017.367742,905.4451613,155,15.08504189,13.23085239,0.480336599,0.93373494,0.691964286,-0.237649764
+4296,22563.456,959.224,921.352,1107.28,19975.56,721.408,796.744,1627.344,11308.704,698.048,598.688,1801.424,13725.288,1305.584,1100.648,1689.16,5071.744,1432.888,327.216,2450.176,11167.624,423.408,665.464,477.608,13602.424,466.872,125.96,1569.288,10719.6,1612.032,514.248,2814.488,9591.176,787.4,295.256,1774.04,6545.024,934.344,446.304,1407.088,4767.464,716.84,170.232,2179.6,4336.552,1383.776,209.56,3394.608,455.736,905.944,125,14.01075491,11.67721863,0.552599726,0.905797101,0.686813187,0.907995217
+4297,29881.36145,891.1204819,524.5783133,1067.108434,27047.68675,692.5421687,868.3253012,1515.698795,15538.80723,562.9036145,1945.975904,1799.60241,18263.93976,1243.891566,2952.180723,2097.963855,6505.253012,1279.662651,295.4939759,2329.457831,14487.80723,400.5783133,118.3855422,1397.240964,17539.68675,569,122.2289157,1184.963855,13766.36145,1636.024096,447.0722892,2797.566265,12118.01205,584.5060241,284.9036145,1141.891566,8358.060241,1269.204819,426.0361446,1327.084337,6294.518072,597.6385542,158.7108434,1427.963855,5560.831325,1294.216867,180.2409639,3313.638554,565.9638554,903.7710843,83,11.9857708,9.044070457,0.656222692,0.902173913,0.628787879,1.025482903
+4298,21736.05128,910.5299145,548.6666667,1034.213675,19439.94017,665.1452991,634.3247863,1496.307692,11378.59829,540.6581197,681.4188034,1727.333333,14015.84615,1206.384615,2223,1923.777778,5265.871795,1424.350427,284.8290598,2293.974359,10423.68376,368.6666667,335.4444444,879.2393162,13073.5812,724.4017094,114.5042735,1694.34188,10318.37607,1470.230769,504.2649573,2779.649573,9039.692308,615.4358974,254.8974359,1417.367521,6357.367521,1006.991453,387.7094017,1330.726496,4530.247863,655.0769231,152.8888889,4321.74359,4241.692308,1249.717949,198.1709402,3269.931624,719.0512821,906.6666667,117,16.40753675,9.378019055,0.820554869,0.9140625,0.664772727,0.261480621
+4299,22132.15584,828.0909091,532.8831169,1080.376623,19874.90909,655.3896104,627.2597403,1524.493506,10666.06494,503.961039,409.4155844,1664.090909,13462.66234,1210.714286,1132.857143,882.1558442,4976.896104,1212.909091,285.0649351,2273.376623,10437.05195,393.7792208,104.9090909,489.038961,12792.72727,509.0649351,115.9090909,1113.207792,10212.88312,1313.142857,522.2207792,2814.480519,8924.246753,578.7532468,257.6233766,1755.298701,6146.376623,798.3636364,409.9480519,1336.090909,4430.272727,618.9350649,159.5454545,2091.272727,4148.220779,1327.077922,1150,3184.766234,758.5454545,902.0779221,77,14.74027857,7.046908204,0.87832088,0.916666667,0.6875,-1.514553861
+4300,31210.53103,877.5931034,552.6413793,1080.493103,27311.06897,712.6896552,738.8724138,1590.27931,14730.24483,646.0758621,1785.544828,1820.093103,18969.74138,1225.82069,4812.341379,3870.372414,6926.675862,1244.972414,311.0862069,2423.882759,14625.08621,426.3275862,648.562069,2099.989655,18279.51034,1074.937931,283.7,1999.52069,14143.25172,2169.848276,506.037931,2792.67931,12312.71034,694.2724138,265.9206897,1133.127586,8193.524138,1527.268966,403.7655172,1316.637931,5225.365517,751.7965517,160.4310345,3343.668966,5083.058621,1262.713793,517.9517241,3290.768966,848.4517241,909.4275862,290,26.12110913,14.98116932,0.819186444,0.876132931,0.575396825,-0.560841812
+4301,43048.88321,888.6934307,528.379562,1128.686131,31117.37956,673.0291971,754.1459854,1662.124088,14753.74453,498.5109489,2047.832117,1834.116788,20575.73723,1179.562044,3997.620438,3697.386861,7719.627737,1200.109489,287.649635,2291.291971,16072.79562,389.1532847,167.350365,2077.664234,20273.80292,864.1751825,130.3868613,2036.160584,14958.42336,2418.372263,385.7737226,2789.839416,12542.54745,569.0510949,266.3284672,956.3649635,7246.131387,1429.649635,387.5620438,1286.080292,4061.072993,599.7007299,150.540146,2057.854015,4301.080292,1185.759124,261.1970803,3238.014599,950.8248175,909.5839416,137,21.42299071,8.801909176,0.911697203,0.840490798,0.566115702,0.105802634
+4302,25084.78528,1073.650307,705.1411043,1107.539877,21903.51534,775.9815951,1164.705521,1734.177914,10565.7362,632.1165644,1693.791411,1888.558282,13805.57055,1332.815951,7430.466258,5018.840491,5005.288344,1316.184049,303.3680982,3191.822086,10844.23313,510.2269939,299.208589,1123.656442,13421.89571,483.4233129,153.1165644,4577.496933,10103.79141,2456.705521,363.0797546,2807.889571,8836.257669,600.5092025,283.1717791,1232.815951,4630.558282,1187.319018,414.5092025,1318.527607,3262.674847,654.2208589,161.9815951,3544.147239,3043.190184,1216.533742,402.7361963,3464.03681,285.0981595,908.2883436,163,17.91301964,11.99161372,0.742870061,0.920903955,0.659919028,0.092764433
+4303,31492.58537,858.0365854,565.5121951,1100.97561,30168.36585,706.9756098,821.2073171,1644.353659,15709.36585,560.6585366,1033.292683,1786.304878,19190.28049,1258.731707,5365.04878,3525.158537,7217.268293,1359.756098,312.1707317,3379.170732,15471.58537,399.6463415,797.0365854,638.3292683,18860.70732,490.4512195,130.4634146,2582.414634,14184.71951,1734.268293,451.9634146,2788.963415,12683.03659,633.9878049,297.0853659,1648.97561,7768.268293,1227.658537,428.5,1373.02439,5577.207317,784.6829268,170.4512195,4612.085366,5057.243902,1360.54878,621.2682927,3246.365854,348.3902439,905.5243902,82,11.48243199,9.393837233,0.575068599,0.891304348,0.621212121,-1.055846577
+4304,27064.52564,947.9615385,659.2179487,1128.371795,24569.34615,754.0769231,738.4102564,1631.397436,14150.42308,599.0128205,490.1538462,1763.538462,17409.38462,1373.205128,1036.846154,974.8589744,6193.435897,1435.307692,344.2051282,2348.217949,13661.5641,454.7692308,273.6538462,453.8717949,16669.70513,484.7692308,132.1282051,838.8846154,13306.5641,1558.038462,422.6153846,2834.666667,11775.73077,983.1538462,305.474359,1951.75641,7987.512821,877.3461538,475.0128205,1337.025641,5849.602564,658.8461538,176,1269.346154,5255.141026,1459.846154,360.5641026,3268.025641,482.1666667,904.9230769,78,11.78319537,8.753124457,0.669459991,0.928571429,0.6,-1.560906253
+4305,43063.45833,959.4027778,657.375,1152.611111,38222.33333,771.125,926.1666667,1723.416667,21743.65278,604.2222222,1235.486111,1796.513889,25790.65278,1377.25,2853.416667,3467.888889,9252.041667,1444.847222,342.5416667,2467.416667,20192.19444,462.8611111,164.4027778,1016.236111,25249.51389,804.3888889,137.1805556,1881.638889,19582.61111,1602.472222,492.625,2821.513889,17390.875,673.0416667,320.875,1260.944444,11756.98611,1221.125,471.8194444,1324.402778,8639.916667,647.9166667,173.8611111,1516.75,7749.75,1456.111111,613.6944444,3443.833333,555.3055556,904.2361111,72,10.91177129,8.569500206,0.619058902,0.935064935,0.654545455,-0.737333932
+4306,22683.38739,928.4324324,667.1981982,1104,18161.86486,702.2522523,738.963964,1599.45045,9579.504505,1029.369369,1047.891892,1776.018018,12309.6036,1228.144144,3305.927928,2116.747748,4619.333333,1420.927928,334.009009,2363.135135,9460.036036,598.3873874,1267.018018,795.5675676,12110.66667,532.2792793,277.2252252,1260.918919,9323.684685,1990.468468,458.5945946,2811.234234,8133.927928,822.9099099,267.3063063,1077.09009,5336.927928,1076.252252,399.954955,1391.072072,3319.666667,926.6666667,159.7387387,3092.756757,3331.702703,1247.009009,613.8198198,3343.342342,873.4234234,906.4234234,111,12.77927591,11.24492802,0.47509469,0.948717949,0.60989011,-0.567393182
+4307,26281.76471,776.9852941,602.3088235,1048.411765,22704.45588,637.4852941,668.2352941,1557.073529,11839.19118,494.2205882,845.9264706,1753.838235,15260.54412,1135.764706,4320.426471,3478.882353,5748.176471,1143.838235,281.0588235,2340.558824,12008.08824,373.8235294,670.7794118,827.7941176,15614.45588,843.6323529,144.6029412,3142.455882,11670.85294,1606.808824,898.7352941,2773.838235,9764.132353,644.6176471,246.1176471,1233.808824,6380.705882,961.3382353,390.6470588,1285.205882,3797.926471,684.7941176,157.0441176,6064.735294,3886.897059,1198.529412,826.1176471,3160.764706,896.7205882,904.1764706,68,10.87279516,8.075357029,0.669610833,0.931506849,0.686868687,1.167272029
+4308,31201.41748,899.5242718,962.9417476,1180.087379,28075.98058,739.9805825,1120.825243,1866.009709,13837.04854,628.0194175,1340.38835,1906.951456,18839.71845,1280.951456,3246.15534,2410.533981,7053.019417,1361.883495,332.5339806,2463.291262,14418.70874,459.3203883,569.6116505,1616.640777,18586.39806,511.7087379,130.9320388,1052.058252,13765.20388,2276.281553,419.368932,2817.087379,11490.41748,682.8446602,296.9805825,1069.737864,7200.194175,1101.592233,424.1747573,1346.718447,4317.718447,734.1262136,160.368932,2135.368932,4304.514563,1274.067961,434.8252427,3335.417476,914,906.6116505,103,13.31562316,10.04115648,0.656772974,0.980952381,0.66025641,-0.766640688
+4309,39624.71429,962.2410714,516.3928571,1092.830357,35066.38393,792.8303571,615.4375,1617.616071,20027.64286,619.1785714,1138.839286,1752.776786,23935.05357,1440.375,2241.383929,3417.875,8841.946429,1446.633929,355.8660714,2321.303571,19610.74107,478.0892857,180.3125,834.7857143,24048.69643,939.6428571,137.3392857,2071.678571,19079.70536,1607.910714,555.3125,2823.366071,17239.78571,799.6696429,334.8660714,1483.276786,11614.10714,1515.089286,484.0803571,1321.098214,8112.1875,672.8839286,190.3482143,2623.392857,7308.526786,1573.223214,1872.544643,3174.125,392.2946429,908.1071429,112,13.57876811,11.09253589,0.57677513,0.903225806,0.615384615,0.503523964
+4310,17323.25954,949.1374046,646.1603053,1103.916031,15372.46565,754.9465649,805.6717557,1603.664122,8510.206107,650.8091603,545.4122137,1756.946565,10483.40458,1340.778626,1154.847328,1331.992366,3771.908397,1446.267176,333.389313,2353.938931,8348.977099,466.6335878,610.740458,499.8320611,10052.62595,495.9694656,129.2061069,1172.068702,7988.473282,1497.961832,498.0763359,2819.114504,7160.351145,745.7099237,286.2061069,1524.908397,4996.076336,863.2137405,445.7328244,1380.030534,3567.450382,706.870229,176.3206107,1967.129771,3369.51145,1423.099237,605.129771,3257.48855,531.4274809,907.648855,131,14.98383932,11.22531613,0.66238734,0.97037037,0.850649351,-0.151509624
+4311,17226.63855,1216.73494,567.5903614,1005.771084,15030.6506,780.7831325,675.9879518,1369.13253,8663.590361,629.2650602,792.0240964,1703.60241,10288.43373,1308.86747,1008.337349,1535.807229,3767.060241,1215.108434,274.2650602,2274.349398,7942.566265,369.7710843,271.5180723,957.9879518,10185.38554,449.5903614,106.6385542,1021.216867,7743.53012,1687.024096,470.626506,2775.987952,6867.86747,564.8795181,246.6506024,1183.759036,4776.939759,1273.951807,376.686747,1289.722892,3676.855422,592.9277108,145.5662651,1374.771084,3248.722892,1221.289157,1692.662651,3430.012048,605.7951807,907,83,12.39307693,8.767722591,0.706743985,0.965116279,0.628787879,-0.67329218
+4312,18052.18644,827.7711864,489.2881356,1069.381356,16511.5678,658.3389831,687.940678,1514.90678,9311.135593,502.6101695,475.4915254,1734.347458,11890.00847,1216.305085,1186.644068,954.1016949,4472.966102,1214.898305,292.9237288,2272.90678,9022.533898,388.5677966,95.88983051,573.2288136,10942.72881,510.9152542,119.4745763,972.1949153,8974.720339,1339.864407,490.220339,2836.610169,7696.576271,600.8220339,257.6864407,1935.466102,5340.40678,863.3474576,399.2881356,1320.838983,3834.711864,629.3898305,156.2118644,2489.118644,3603.423729,1327.322034,2078.144068,3178.59322,769.0254237,908.6355932,118,15.2281597,10.25779562,0.739089678,0.951612903,0.524444444,0.780898766
+4313,31683.20161,1025.919355,595.3306452,1088.858871,26313.19758,623.0080645,468.2016129,1497.572581,12870.81452,504.5685484,1013.169355,1750.399194,16111.45161,1164.544355,5804.520161,2777.899194,6091.903226,1228.633065,282.4758065,2392.25,13293.5,347.75,359.7862903,1136.862903,15957.49194,461.7862903,239.2701613,3256.58871,12951.50806,1913.314516,347.0604839,2816.241935,11526.17742,559.3266129,271.3145161,1065.870968,6235.108871,1056.620968,398.3306452,1297.040323,4197.737903,654.0685484,155.4153226,2235.298387,3992.475806,1217.75,232.375,3199.870968,301.0725806,912.3266129,248,30.05275557,11.1706184,0.92835278,0.846416382,0.476923077,-1.023941329
+4314,33057.50224,906.1704036,587.4932735,1113.878924,25851.84305,702.6412556,766.9775785,1662.394619,13526.74888,561.2466368,2177.269058,1816.515695,16593.90135,1267.363229,5120.38565,5348.29148,6137.470852,1293.609865,307.9237668,2453.668161,13860.45291,390.2914798,412.2197309,1284.632287,16545.36771,777.5964126,140.264574,4468.569507,12848.87892,2080.408072,482.7040359,2827,11629.23318,627.6098655,301.2107623,1958.668161,6773.278027,1770.618834,432.6995516,1313.349776,4754.022422,682.8071749,170.8878924,4962.58296,4319.668161,1325.847534,970.9775785,3232.300448,320.8475336,910.6636771,223,20.24252114,15.07069532,0.66761484,0.85440613,0.655882353,1.521386915
+4315,20719.24242,932.8989899,846.3333333,1157.555556,19503.75758,745.4949495,822.5555556,1665.666667,10641.57576,639.1010101,510.3939394,1748.020202,13043.71717,1312.939394,1534.010101,1464.323232,4790.747475,1386.454545,324.4545455,2391.555556,10442.60606,2713.383838,604.979798,471.1717172,12810.41414,496.8383838,128.1515152,1428.222222,9982.393939,1500.454545,437.1313131,2818.020202,8733.484848,1343.030303,288.3333333,1993.383838,6098.464646,849.6868687,451.1717172,1385.010101,4394.808081,718.0606061,172.010101,2210.666667,4012.525253,1397.989899,362.0909091,3357.808081,516.2424242,909.3333333,99,14.79817597,9.230654848,0.781608132,0.970588235,0.642857143,0.438113394
+4316,13994.25,1084.944444,508,1024.347222,13473.93056,743.0833333,738,1402.472222,6730.180556,576.625,1699.277778,1723.652778,8483.861111,1228.166667,1877.555556,3772.930556,3062.180556,1156.5,262.1388889,2450.222222,6188.875,361.125,113.6805556,1228.680556,7692.152778,1382.513889,115.3888889,1125.555556,5715.861111,1537.416667,518.1805556,2786.583333,5118.680556,609.8333333,238.6111111,1465.986111,3711.555556,1791.361111,369.7361111,1322.986111,2862.333333,569.375,151.875,2786.388889,2520.805556,1183.777778,937.0972222,3296.958333,675.8333333,906.5555556,72,12.50194955,8.38561514,0.7416884,0.808988764,0.467532468,-1.333706855
+4317,29624.13433,801.9651741,462.6865672,1025.845771,26044.08955,643.6368159,597.5621891,1452.114428,14875.43284,522.1940299,1018.616915,1707.164179,19039.82587,1178.383085,2507.995025,2526.895522,6900.800995,1340.179104,284.6467662,2309.726368,13650.16915,361.1144279,182.6169154,949.4726368,17763.35323,412.3681592,112.7910448,2000.537313,13632.57711,1697.004975,496.8308458,2796.378109,11782.23881,571.8258706,260.3482587,1310.164179,8427.820896,1046.985075,380.6865672,1297.273632,5811.049751,601.7761194,150.159204,3138.880597,5511.900498,1252.915423,185.5024876,3235.920398,706.960199,911.9502488,201,21.41202499,12.50224011,0.811833695,0.862660944,0.591176471,0.687322921
+4318,34412.69312,841.6296296,568.3386243,1092,26922.32804,678.2328042,676.8201058,1683.195767,12269.49206,517.8412698,2032.31746,1787.190476,17563.00529,1178.899471,5105.126984,4388.867725,6651.550265,1198.021164,289.8518519,2353.84127,13503.31217,392,295.8994709,2025.597884,17072.17989,863.3174603,235.0952381,2488.851852,12575.79894,2685.021164,382.8148148,2807.978836,10505.84127,632.6243386,262.0793651,999.2222222,5954.78836,1638.275132,382.8253968,1290.492063,3288.116402,634.7407407,154.005291,2563.195767,3545.074074,1180.333333,1405.941799,3223.142857,960.6984127,910.6772487,189,19.47519033,13.82839898,0.704149185,0.851351351,0.63,-0.092538344
+4319,13706.21818,685.6181818,433.7,1048.836364,11654.46364,575.6181818,521.4090909,1513.581818,4906.445455,445.2818182,355.9090909,1697.518182,7286.3,1047.281818,1202.336364,702.9272727,2856.954545,1065.354545,249,2220.218182,6028.227273,340.9636364,116.2272727,502.3090909,7391.436364,406.1818182,108.7363636,1146.045455,5700.845455,1275.554545,328.7727273,2831.045455,4726.890909,593.3909091,230.8181818,905.1545455,2519.227273,658.9727273,351.6545455,1281.872727,1416.545455,586.9818182,138.3909091,1796.172727,1595.109091,1103.1,3765.818182,3108.590909,1005.363636,908.0818182,110,14.20011972,9.984859853,0.711038364,0.956521739,0.705128205,-0.594753577
+4320,26791.35955,976.247191,740.3033708,1138.426966,23763.89888,785.8426966,847.7303371,1711.314607,13904.23596,618.1797753,486.3932584,1789.955056,16912.33708,1405.752809,888.8988764,1284.988764,5922.719101,1473.022472,341.9662921,2372.752809,13614.1573,544.4157303,153.8764045,468.2359551,16382.53933,510.6404494,134.2247191,1162.426966,13495.42697,1573.280899,445.3820225,2846.460674,11898.8764,842.0337079,315.2808989,1854.629213,8036.932584,1096.41573,468.5617978,1340.089888,5820.033708,649.5280899,177.3820225,1390.179775,5444.651685,1508.853933,249.7078652,3326.123596,507.4719101,909.741573,89,13.11926891,9.151362029,0.716534923,0.946808511,0.684615385,-0.194353615
+4321,31830.41935,981.3806452,515.9096774,1053.529032,28193.16774,723.6516129,802.0064516,1495.916129,16283.98065,574.3806452,1278.741935,1733.232258,19512.90323,1300.709677,2047.006452,2867.548387,7115.645161,1277.774194,301.1419355,2363.741935,15415.61935,450.0387097,126.5806452,1474.606452,19555.58065,957.2580645,116.5935484,1478.877419,14832.2,1671.025806,457.4064516,2797.296774,13017.6129,619.2,281.8903226,1180.567742,9049.567742,1287.612903,422.3096774,1327.296774,6702.993548,603.2967742,156.9806452,1619.470968,6101.858065,1371.941935,2373.374194,3303.774194,589.283871,909.3290323,155,18.56696681,10.96215329,0.807102285,0.890804598,0.679824561,1.564580198
+4322,26313.43871,1094.696774,575.1935484,1066.754839,23888.62581,751.8322581,712.1870968,1524.025806,13559.38065,580.2645161,733.0709677,1727.270968,16467.11613,1348.367742,1246.135484,3096.916129,6211.63871,1251.019355,285.2709677,2281.774194,13070.30323,419.3096774,142.4903226,908.3677419,16521.97419,537.116129,117.2322581,1737.36129,12495.54194,1589.354839,565.9419355,2787.63871,11127.34839,794.4967742,266.1935484,1659.741935,7800.625806,1055.329032,397.0645161,1316.141935,5766.4,598.6064516,155.3870968,2135.812903,5162.870968,1337.354839,1020.825806,3407.277419,615.8064516,911.2322581,155,18.03805495,12.64828053,0.712964824,0.82010582,0.543859649,-0.300519039
+4323,38492.50667,977.2333333,610.5,1121.613333,34455.97333,781.4133333,630.5666667,1672.5,19149.14667,608.6,634.2333333,1756.8,23254.11333,1403.566667,3237.846667,3441.453333,8527.573333,1607.54,340.8066667,2333.406667,18657.14667,435.3666667,295.1133333,556.0666667,23061.38,559.34,136.3066667,2245.093333,17876.06667,1660.473333,540.48,2825.793333,15956.76667,638.2866667,325.2666667,1676.193333,10472.18667,996.6466667,470.1933333,1325.32,7510.3,686.7533333,185.7,4050.766667,6762.62,1460.26,245.4133333,3437.826667,431.3,909.8733333,150,17.25250659,11.41523713,0.749806888,0.909090909,0.641025641,-1.444326596
+4324,25527.46591,1033.579545,791.4090909,1167.170455,22911.22727,783.2159091,902.0795455,1746.443182,12964.81818,610.7272727,462.2159091,1774.715909,15572.92045,1365.079545,949.1477273,736.7613636,5631.636364,1460.909091,333.1477273,2338.704545,12148.63636,447.25,154.9545455,451.5340909,14653.06818,476.7045455,126.7045455,787.5795455,11733.71591,1493.079545,401.7840909,2836.431818,10342.56818,1625.420455,304.7727273,1562.397727,7003.965909,975.2272727,448.4090909,1323.909091,5062.420455,623.8181818,168.0909091,749.3522727,4521.193182,1412.25,260.5227273,3314.386364,491.4090909,910.7954545,88,12.79006147,9.262531671,0.689592527,0.926315789,0.523809524,0.480479057
+4325,33542.55556,962.5833333,523.9953704,1078.791667,28781.14352,731.9490741,778.8657407,1589.462963,16909.83333,580.6296296,1389.550926,1797.712963,19926.14352,1314.796296,2280.578704,4000.106481,7339.990741,1336,309.337963,2345.759259,15590.77778,432.2407407,131.9166667,938.0694444,19736.46759,1317.032407,122.9768519,1858.194444,14836.2963,1655.212963,515.8240741,2795.564815,12890.18981,681.2592593,277.712963,1597.5,9060.680556,1546.060185,408.1527778,1322.953704,6608.907407,614.6990741,160.9444444,3324.347222,6043.62963,1385.273148,777.662037,3304.87037,632.5972222,912.5462963,216,20.11199158,14.06558869,0.714766383,0.935064935,0.66873065,0.509264472
+4326,15297.58333,804.9791667,467.4583333,1039.895833,16630.16667,649.2916667,492.2916667,1441.0625,7780.375,510.7291667,656.5,1673.208333,10918.75,1202.166667,3309.395833,4242.458333,4280.625,1166.833333,274.6666667,2287.979167,7928.791667,379.3958333,123.1041667,689.2083333,9809.375,414.7916667,127.6041667,3004.645833,7175.541667,1409.3125,619.1666667,2769.604167,6449,630.8333333,237.875,1844.791667,4658.208333,908.6666667,374.6666667,1287.645833,3541.020833,576.8125,149.8958333,3225.625,3014.270833,1275.125,701.7916667,3247.583333,695.4375,909.8958333,48,11.06065121,6.252403567,0.824896703,0.888888889,0.623376623,-0.35721766
+4327,30285.18293,854.5853659,531.6890244,1074.695122,24198.59756,679.0487805,703.6036585,1552.835366,12317.14024,506.2317073,1716.219512,1826.786585,16244.64634,1154.585366,4055.268293,3173.128049,6096.5,1176.609756,280.5304878,2373.762195,12611.9878,366.5426829,363.3597561,1592.676829,16090.37195,537.9878049,453.2621951,1256.329268,12179.88415,2267.079268,585.5853659,2802.02439,10330.78049,577.597561,253.195122,906.1707317,6661.121951,1422.512195,383.1707317,1302.22561,3987.47561,629.4329268,151.6829268,3048.579268,4034,1172.012195,443.5670732,3212.506098,894.652439,912.7256098,164,22.2311573,10.22689817,0.887905729,0.849740933,0.479532164,0.819043086
+4328,25199.26531,1043.302041,618.4857143,1099.028571,22984.41633,721.6857143,563.8653061,1717.530612,10475.77551,579.0285714,1252.938776,1767.253061,14360.53061,1280.044898,4951.485714,2965.861224,5399.359184,1290.293878,311.5877551,2386.387755,11465.98367,415.8285714,546.8408163,1329.84898,13532.8449,462.2244898,123.4285714,3459.942857,9994.130612,1915.363265,349.8244898,2808.510204,8724.044898,788.9428571,271.477551,1117.897959,4090.17551,1022.179592,389.4571429,1287.326531,2862.395918,672.8408163,156.1306122,2591.253061,2844.738776,1193.473469,614.0734694,3315.404082,269.0653061,913.7836735,245,21.1024005,15.1437421,0.69642328,0.949612403,0.716374269,-0.895661261
+4329,29814.32911,889.7974684,641.6835443,1101.088608,27568.86076,727.8481013,789.443038,1689.594937,15187.68354,566.443038,1133.962025,1797.35443,18719.35443,1281.392405,4201.316456,4760.886076,6866.227848,1335.810127,315.3670886,2511.886076,15788.8481,414.3164557,378.8481013,769.7468354,18849.92405,508.3291139,134.6329114,4321.620253,14541.21519,1760.936709,540.5063291,2830.101266,13182.41772,612.8860759,303.6582278,1805.379747,8103.582278,1348.367089,448.1392405,1322.037975,5724.873418,676.443038,170.2025316,4193.075949,5141.455696,1400.924051,358.5949367,3291.594937,337.1265823,909.3417722,79,11.82870672,8.722555771,0.675450096,0.887640449,0.658333333,-1.342726313
+4330,18111.525,843.2,409.85,1044.575,17518.95,683.975,517.7,1454.35,9035.3,543.525,415.225,1674.075,11288.875,1274.5,844.675,965.7,4445.3,1292.2,306,2254.05,9451.275,395.575,129.675,441.375,10917.575,422.275,125.2,949.7,8668.05,1400.8,521.275,2826.675,8063.45,850.45,264.6,1468.975,5370.525,807.275,408.475,1335.25,3945.275,610.95,173.925,2841.275,3477.125,1412.425,8487.35,3091.975,383.65,908.4,40,8.825010511,6.196707955,0.71200371,0.930232558,0.634920635,0.617634504
+4331,21201.96154,808.7564103,414.0833333,1038.807692,18778.28846,661.4166667,693.0576923,1465.461538,10329.55769,624.2371795,917.3461538,1671.423077,13304.91667,1218.878205,1490.224359,1473.871795,5012.480769,1254.076923,289.0961538,2282.282051,10080.66026,375.7628205,213.5320513,946.6987179,12476.94872,450.0705128,174.3910256,809.8910256,9898.384615,1466.916667,479.1282051,2810.147436,8568.512821,630.1602564,259.6923077,1318.205128,5985.980769,1108.634615,386.9871795,1311.666667,4268.166667,623.9487179,156.6666667,2030.660256,4044.064103,1368.083333,5212.314103,3131.641026,755.4871795,912.3397436,156,16.71531067,13.16484146,0.616197348,0.876404494,0.573529412,-0.948765282
+4332,35923.16788,877.5328467,533.3357664,1089.788321,32836.16058,775.2554745,848.7080292,1651.591241,17956.08029,537.7883212,883.2846715,1842.992701,22699.21898,1257.547445,3700.153285,3382.708029,8293.766423,1299.328467,309.9854015,2419.131387,17173.24088,501.2992701,152.9124088,1219.452555,22307.9854,477.7007299,503.7372263,3420.649635,17127.34307,1822.357664,629.810219,2809.014599,14787.70073,681.7007299,277.1021898,1418.985401,9781.357664,1056.510949,412.1386861,1298.708029,6476.817518,633.4087591,162.8613139,3512.036496,6145.649635,1309.29927,194.6277372,3457.540146,813.8029197,910.9051095,137,16.4036067,11.71666578,0.699866416,0.867088608,0.619909502,-1.508999099
+4333,28648.04314,924.3882353,549.745098,1087.235294,26474.33333,729.2,772.6823529,1623.164706,14153.6902,549.827451,1190.258824,1840.286275,18041.98039,1240.282353,4403.568627,3451.858824,6585.72549,1262.533333,292.572549,2459.427451,13872.74118,722.0705882,326.7019608,1305.329412,17741.85098,583.1686275,133.4666667,2987.007843,13399.3451,2048.4,626.1372549,2802.062745,11617.72157,645.0196078,274.8235294,1230.34902,7687.992157,1476.360784,397.8627451,1307.490196,4965.333333,646.0352941,156.4784314,2036.917647,4863.039216,1247.027451,188.9411765,3409.643137,829.3568627,915.0941176,255,22.05813136,15.0245774,0.732157336,0.934065934,0.639097744,0.613233511
+4334,43294.26389,911.4444444,533.9930556,1134.388889,39534.09722,755.6736111,732.9722222,1738.083333,21332.70833,588.8194444,1119.236111,1770.041667,26150.61806,1339.152778,1944.125,4779.409722,9737.826389,1423.527778,337.5972222,2650.368056,21701.59028,430.1666667,324.1736111,706.5208333,26490.75694,748.4861111,134.3958333,2655.097222,20502.65278,1708.854167,626.4652778,2825.375,18552.9375,630.8472222,318.3611111,2106.5,11575.59722,1389.083333,463.9027778,1336.770833,8013.888889,712.2638889,180.4791667,4587.020833,7435.6875,1471.236111,423.8125,3258.944444,356.3958333,913.2777778,144,15.06009178,12.87577013,0.518694585,0.9,0.6,-1.237387358
+4335,41673.15714,1017.542857,559.7571429,1129.285714,36256.52857,752.9428571,916.2,1613.7,21815.38571,595.3142857,1484.657143,1807.4,25850.92857,1357.157143,3042.6,3444.371429,9301.7,1372.871429,326.1714286,2612.014286,20343.82857,450.5857143,121.4142857,1123.085714,25259.62857,617.2571429,133.4142857,1912.242857,19908.04286,2026.642857,514.1142857,2804.057143,17355.75714,702.5285714,318.1285714,1290.585714,11758.95714,1387.214286,466.7428571,1318.514286,8596.4,634.4142857,171.9428571,1964.642857,7842.385714,1457.214286,1677.5,3294.814286,576.3428571,911.0857143,70,13.42845302,7.624659011,0.823167398,0.786516854,0.48951049,0.864563244
+4336,40559.46154,956.0769231,460.4871795,1072.679487,35032.58974,794.8846154,693.9871795,1587.089744,21046.32051,570.0128205,1775,1817.5,24698.07692,1349.666667,1464.602564,3651.153846,8557.397436,1300.910256,316.525641,2302.961538,18841.70513,443.6794872,111.7948718,1573,23776.44872,886.2179487,309.6410256,996,18259.21795,1793.948718,480,2797.051282,16083.38462,616.1282051,292.2307692,1343.012821,11536.60256,1742.448718,424.7820513,1316.141026,7731.74359,610.7435897,154.1153846,1877.217949,7244.294872,1439.410256,490.5128205,3299.576923,667.1923077,910.6282051,78,12.71465521,8.104811554,0.770501186,0.962962963,0.545454545,0.973504067
+4337,44933.07784,937.257485,505.8982036,1109.281437,39246.50898,750.0958084,832.3952096,1678.401198,23549.5988,588.6706587,1465.598802,1764.640719,28719.77844,1361.227545,2477.347305,4172.131737,10291.58084,1369.431138,334.245509,2523.221557,21682.7485,429.1317365,113.0359281,1244.766467,27792.07784,1968.916168,176.1317365,1520.035928,21452.86826,1537.832335,548.9520958,2798.730539,18853.18563,666.2035928,309.8742515,1466.155689,13482.09581,1726.299401,427.2095808,1299.856287,9242.137725,633.994012,167.6107784,2794.035928,8487.610778,1478.329341,641.0239521,3292.862275,683.7964072,913.245509,167,20.57767869,11.11872993,0.841453427,0.893048128,0.545751634,-0.786699362
+4338,26290.90909,1112.636364,513.9090909,1060.191919,22045.75758,782.0808081,752.0909091,1542.242424,12257.83838,618.7070707,1361.59596,1779.070707,15072.62626,1266.747475,2531.606061,3028.191919,5107.323232,1293.727273,288.9292929,2311.585859,10462.07071,386.6767677,418.8585859,1557.606061,13422.54545,542.0707071,127.7070707,1657.030303,10573.19192,1982.89899,461.9090909,2781.585859,8978.181818,737.1717172,269.989899,1137.090909,5974.222222,1420.848485,389.9393939,1284.424242,3888.151515,657.6969697,161.1010101,2190.727273,3434.323232,1204.626263,702.8484848,3386.191919,797.6767677,911.7575758,99,13.30908102,9.829548333,0.674188292,0.908256881,0.642857143,-1.115450261
+4339,37979.37037,854.0493827,492.691358,1106.024691,32883.34568,761.1481481,730,1786.024691,16143.98765,530.2839506,1461.567901,1817.839506,22138.7284,1245.197531,4791.839506,2765.716049,8198.950617,1271.08642,309.4567901,2408.790123,17125.74074,760.5185185,129.2839506,1683.617284,21480.48148,665.308642,157.8148148,2047.54321,16026.7037,2167.246914,382.345679,2794.493827,13352.45679,723.4691358,280.7654321,997.654321,7595.185185,1100.703704,403.5432099,1294.839506,4287.666667,598.345679,159.6049383,3207.580247,4498.024691,1223.074074,722.4197531,3300.098765,942.7283951,911.6296296,81,14.21532149,7.593461061,0.845374291,0.931034483,0.642857143,0.29578102
+4340,39768.41026,943.2692308,571.4615385,1120.858974,34694.29487,743.4230769,726.7948718,1626.217949,20389.98718,591.6282051,1648.974359,1804.846154,23996.30769,1344.564103,2664.397436,3458.987179,8576.166667,1390.141026,353.5769231,2785.153846,18911.51282,432.0384615,153.1794872,1078.576923,23465.76923,894.7564103,135.7307692,2278.474359,18276.78205,1916.307692,493,2812.5,16120.20513,635.4358974,309.1666667,1447.410256,10943.4359,1471.205128,455.3589744,1322.294872,8010.384615,644.2179487,171.525641,3022.615385,7151.807692,1409.166667,229.8333333,3310.897436,559.1410256,912,78,14.20096917,7.501378094,0.849101322,0.886363636,0.590909091,-0.947242936
+4341,24929.08333,1120.194444,554.8981481,1055.037037,22153.62963,712.25,911.6296296,1492.851852,13297.7037,558.1203704,2161.212963,1718.12963,15708.03704,1285.62037,1954.685185,3418.481481,5710.407407,1266.527778,287.9444444,2489.148148,12468.35185,411.1666667,104.1759259,1668.212963,15512.35185,2443.425926,116.462963,1253.074074,11841.25,1525.722222,465.8240741,2791.268519,10319.06481,592.5,266.5277778,1345.472222,7264.425926,2337.305556,392.5833333,1304.675926,5244.712963,592.5648148,155.0648148,2598.361111,4723.87037,1310.212963,507.8888889,3348.703704,649.6481481,913.3796296,108,14.25972586,10.10699274,0.705430704,0.947368421,0.654545455,-0.347262392
+4342,23277.20879,836.4615385,448.5274725,1069.791209,18766.42857,653.7472527,725.4615385,1524.56044,10635.30769,935.2527473,512.8901099,1727.692308,13135.40659,1227.791209,1736.483516,1294.252747,4923.010989,1411.593407,301.1868132,2307.868132,10244.10989,366.4395604,561.9340659,567.2197802,12763.91209,456.0989011,125.8901099,806.989011,10078.3956,1588.934066,548.2637363,2796.912088,8863.296703,724,262.5714286,1453.428571,6122.604396,838.0879121,391.0549451,1344.296703,4311.912088,741.7142857,159.1208791,2480.010989,4145,1331.967033,2133.736264,3192.406593,744.6593407,912.1428571,91,12.5834983,9.347959525,0.669430754,0.957894737,0.758333333,-0.342188482
+4343,22712.56044,790.6923077,639.032967,1077.769231,18863.61538,642.2637363,683.8131868,1652.824176,8224.197802,524.2857143,1708.153846,1790.912088,11978.14286,1127.054945,5935.351648,4482.978022,4677.208791,1131.692308,293.8351648,2330.241758,9402.065934,384.978022,335.5384615,1191.758242,11957.97802,477.6263736,114.0879121,5986.10989,8942.659341,2151.153846,402.4615385,2790.395604,7361.285714,728.1538462,247.1208791,942.1868132,4179.395604,1473.10989,361.978022,1294.274725,2289.351648,624.4285714,147.8791209,3874.21978,2535.32967,1148.901099,2070.241758,3200.802198,974.1318681,910.8571429,91,12.93071218,9.325296531,0.692753719,0.919191919,0.7,-1.450695549
+4344,24563.87047,871.9740933,674.3626943,1107.041451,18541.50259,583.373057,569.8341969,1516.466321,7620.352332,683.3264249,1301.751295,1711.735751,11529.08808,1032.704663,4020.005181,1934.673575,4405.38342,1074.554404,269.253886,2325.051813,8891.067358,328.5181347,537.5958549,1067.715026,11069.35233,485.761658,551.7409326,1816.989637,8335.005181,1881.948187,364.4196891,2779.979275,6804.792746,672.0207254,220.3471503,827.1709845,3573.901554,1007.046632,347.7512953,1293.61658,1974.544041,637.4715026,141.8238342,2755.196891,2158.626943,1021.42487,1249.559585,3083.963731,990.0932642,915.2797927,193,17.41527822,14.92989825,0.514838176,0.93236715,0.59752322,0.72202905
+4345,28594.14458,977.7951807,504.3614458,1056.192771,25899.41566,746.6927711,689.126506,1505.210843,14328.13253,594.2048193,1403.156627,1758.777108,16871.25904,1328.704819,1987.060241,2512.560241,6354.042169,1370.626506,320.0421687,2305.650602,13957.03012,556.873494,373.5421687,1012.903614,16852.40964,1113.512048,130.7650602,1275.891566,13211.56627,1532.433735,533.8614458,2811.855422,11930.98193,704.753012,287.7771084,1376.373494,8008.76506,1626.487952,438.1686747,1315.156627,5583.114458,674.9096386,172.7891566,2819.783133,5066.975904,1387.801205,423.0361446,3239.590361,400.8554217,916.0843373,166,19.60902728,10.97650133,0.828649535,0.927374302,0.650980392,-0.612924949
+4346,32547.26667,915.0333333,575.2666667,1096.05,28970.53333,743.3333333,848.1166667,1637.016667,17197.63333,596.4,2588.166667,1788.516667,20321.36667,1342.016667,2454.1,3354.383333,7011.766667,1395.316667,328.9333333,3345.716667,16324.9,440.7166667,211.6833333,1286.066667,19424.71667,571.1166667,134.9,1553.133333,15778.5,2002.333333,491.4,2809.95,14283.25,758.3666667,302.6333333,1330.15,9579.95,1654.283333,444.25,1342.85,6931.866667,654.3166667,173.7166667,3039.533333,6178.65,1418.283333,768.75,3252.7,549.4833333,913.2,60,10.56771247,7.793951201,0.675319928,0.923076923,0.6,-0.645846781
+4347,25126.9313,924.2366412,627.5419847,1083.580153,22662.03053,694.3435115,977.0152672,1623.366412,11637.9771,774.6793893,1941.969466,1797.70229,14779.94656,1233.48855,4834.580153,4948.389313,5394.160305,1246.206107,318.2366412,2906.763359,11565.58779,472.6870229,1212.183206,1600.427481,14697.9771,2051.427481,137.3816794,1675.450382,11274.70992,1910.335878,639.5954198,2791.938931,9806.916031,809.2519084,264.610687,1221.251908,6370.083969,1723.793893,399.7251908,1395.473282,3981.51145,950.9312977,158.778626,4456.89313,3886.244275,1279.236641,997.4580153,3337.931298,864.4580153,914.778626,131,14.21589584,11.93608162,0.543159979,0.95620438,0.671794872,-0.009664712
+4348,41788.42857,873.9428571,503.5142857,1092.114286,26502.64286,648.9571429,647.3428571,1563.528571,14133.24286,590.3571429,1660.071429,1771.728571,18145.07143,1163,3508.342857,2820.471429,6843.942857,1212.585714,303.3428571,2337.914286,14816.58571,389.8571429,460.5714286,2122.914286,19134.88571,521.1142857,140.7714286,932.6571429,14472.6,2247.357143,427.9857143,2846.5,12407.61429,614.9142857,263.8571429,899.5857143,8068,1475.4,399.9428571,1312.542857,4840.942857,678.3428571,154.6428571,1647.014286,4977.3,1200.585714,334.2857143,3247.2,884.5857143,912.7142857,70,13.43437,6.988339315,0.854054444,0.921052632,0.53030303,0.871507914
+4349,24289.89063,881.7421875,445.2265625,1060.34375,22780.99219,716.6796875,530.4609375,1475.023438,11970.80469,561.4453125,472.3203125,1705.375,14553.48438,1341.679688,967.2265625,1313.007813,5564.835938,1335.710938,323.3984375,2288.203125,12239.875,416.859375,267.921875,458.6640625,14813.20313,438.3046875,125.8203125,975.484375,11577.64063,1462.921875,468.28125,2854.132813,10602.82813,805.2734375,288.953125,1386.5,6937.664063,862.71875,433.4140625,1316.046875,4961.507813,653.6328125,173.4375,2351.929688,4500.671875,1502.734375,8555.796875,3262.640625,377.8828125,915.1953125,128,13.67936648,12.13650915,0.461360415,0.977099237,0.703296703,-1.377497227
+4350,31995.39623,1007.669811,644.9245283,1114.377358,28408.66038,689.745283,962.1698113,1605.103774,16119.26415,558.990566,1913.556604,1868.867925,19118.46226,1272.349057,3800.726415,5274.726415,7304.877358,1353.641509,314.7641509,2524.584906,15253.29245,414.3018868,174.3018868,1272.179245,18964.82075,738.0283019,125.0943396,3286.084906,14366.60377,1762.990566,670.7358491,2807.301887,12696.31132,605.0660377,290.5,1556.40566,8607.915094,1688.981132,422.2735849,1325.877358,6385.90566,632.4622642,172.3018868,3303.792453,5566.867925,1352.566038,249.9339623,3311.018868,565.5471698,916.3584906,106,17.36722674,8.725631451,0.864624056,0.848,0.471111111,-0.812820228
+4351,38063.26563,933.125,480.46875,1101.421875,34182.73438,798.515625,665.28125,1615.9375,20531.875,575.046875,2036.96875,1839.84375,24574.95313,1338.78125,1967.765625,4599.796875,9068.71875,1349.34375,325,2336.484375,19243.09375,430.703125,105.25,1563.921875,24126.875,694.84375,377.0625,1393.640625,18609.1875,2158.09375,512.546875,2828.859375,16435.07813,626.53125,292.390625,1579.96875,11755.17188,1929.4375,430.84375,1321.25,8205.84375,631.125,167.25,3071.828125,7448.75,1500.953125,288.234375,3259.921875,660.734375,914.3125,64,12.19186281,6.922216043,0.823184856,0.955223881,0.581818182,0.83853188
+4352,36815.25,833.8942308,513.9519231,1114.355769,28744.47115,673.0865385,826.4230769,1638.038462,14138.92308,497.3846154,2089.538462,1894.384615,19541.13462,1171.173077,6980.875,3336.403846,7323,1201.913462,300.9519231,2478.509615,15244.16346,473.0576923,146.2596154,1181.076923,19191.57692,1132.75,274.0865385,1711.817308,14554.89423,2034.048077,372.7692308,2817.740385,12071.74038,595.6634615,267.0673077,910.9519231,7146.278846,1329.192308,394.1057692,1302.009615,3991.634615,584.2211538,158.7403846,2698.836538,4183.971154,1154.711538,278.3365385,3224.836538,935.0192308,915.0961538,104,13.21295037,10.19967289,0.635689148,0.928571429,0.727272727,0.430157098
+4353,20620.63953,857.5232558,746.3953488,1118.686047,18322.33721,685.9302326,622.1511628,1609.639535,10010.77907,706.5,475.627907,1789.651163,12620.09302,1230.116279,1647.581395,1781.686047,4652.197674,1451.790698,345,2364.709302,9786.511628,403.9534884,543.6162791,449.6162791,12197.36047,426.9186047,122.1395349,1548.883721,9445.488372,1490.081395,497.6860465,2812.27907,8385.732558,846.9186047,279.5232558,1797.465116,5623.348837,787.5930233,433.127907,1373.151163,4121.930233,702.9767442,163.4767442,2306.546512,3813.732558,1349.360465,456.6395349,3217.406977,472.7906977,914.8139535,86,12.01069566,9.527199337,0.608926992,0.895833333,0.597222222,0.766627644
+4354,33354.45455,933,501.0454545,1055.818182,29266.18182,718.8522727,842.9090909,1528.670455,17625.53409,558.8409091,1441.011364,1751.806818,20183.67045,1302.613636,3076.420455,3286.409091,7683.034091,1270.727273,293.75,2426.75,16016.26136,406.7954545,106.8636364,916.9318182,20015.44318,1368.409091,120.6477273,1610.522727,15397.875,1596.204545,482.7954545,2797.397727,13686.60227,695.0113636,265.5454545,1299.534091,9386.352273,1342.193182,404.6818182,1297.636364,6989.670455,607.9204545,157.5681818,2445.227273,6305.375,1351.761364,834.1818182,3324.829545,623.4204545,917.6818182,88,14.70816287,8.641535944,0.809199965,0.862745098,0.571428571,0.212716827
+4355,33280.35366,913.0853659,661.6646341,1120.890244,30481.52439,751.2804878,945.25,1715.579268,16341.5122,585.8292683,1748.158537,1792.664634,19872.37805,1310.378049,4331.70122,4959.890244,7395.182927,1376.054878,324.0731707,2623.737805,16731.84146,462.75,1000.567073,1242.079268,20064.02439,1007.719512,143.25,3196.25,15230.42073,1834.72561,474.554878,2816.841463,13922.14024,618.1707317,311.695122,1577.908537,8541.109756,1460.829268,456.7682927,1393.103659,6027.670732,824.9939024,181.0365854,5296.579268,5368.317073,1409.756098,524.695122,3263.085366,342.1280488,918.847561,164,16.93082549,13.50450067,0.603149696,0.863157895,0.575438596,-0.433999364
+4356,18133.56731,949.4615385,932.6538462,1185.826923,16723,729.9711538,792.8365385,1679.971154,9161.144231,632.5,499.7596154,1808.913462,11442.15385,1327.538462,1195.125,967.9711538,4205.673077,1439.365385,341.4134615,2380.730769,9279.182692,434.9711538,327.1153846,465.5,11520.875,497.9807692,127.8557692,993.9423077,8946.336538,1475.134615,415.2980769,2809.355769,7960.875,1360.788462,296.0576923,1634.230769,5561.432692,892.9615385,457.8173077,1349.432692,4064.086538,664.8173077,167.7596154,1417.778846,3793.913462,1407.144231,276.6057692,3284.105769,483.6153846,916.9230769,104,12.22593711,10.95741408,0.443562812,0.95412844,0.666666667,-0.031811845
+4357,25497.09211,898.8157895,661.9605263,1381.131579,23366.61842,729.7368421,723.7894737,2349.697368,12717.76316,558.1447368,781.4210526,1769.513158,15472.57895,1288.223684,1490.276316,3131.25,6111.973684,1936.184211,317.7368421,2389.039474,12996.53947,422.3947368,220.9078947,1408.710526,15871.59211,526.3421053,124.1052632,1830.552632,12196.32895,1546.171053,587.0394737,2826.710526,10974.27632,763.3815789,288.0131579,2309.855263,7446.197368,1055.315789,445.0394737,1321.171053,5315.618421,691.2631579,168.7763158,4888.881579,4737.973684,1389.5,263.4605263,3339.907895,420.2631579,917.3552632,76,13.45210684,7.821544327,0.813591872,0.873563218,0.584615385,0.061484774
+4358,19888.42446,917.1223022,656.0935252,1086.266187,17565.61151,694.2805755,553.8201439,1524.410072,10047.69065,627.4748201,471.5395683,1711.661871,12259.97842,1260.47482,1333.618705,1480.913669,4402.863309,1327.194245,309.4964029,2327.52518,9570.359712,396.6546763,341.4100719,445.0863309,11860.02878,438.2661871,122.0503597,1385.971223,9399.848921,1465.856115,456.8992806,2843.76259,8366.194245,662.6330935,274.647482,1799.985612,5636.352518,825.4604317,416.8345324,1337.705036,3994.633094,653.6978417,163.6115108,1986.640288,3692.467626,1338.122302,1286.309353,3203.115108,459.0647482,918.2230216,139,14.53418711,12.47193593,0.513465365,0.932885906,0.661904762,-1.112373837
+4359,36768.48,984.576,515.352,1080.672,31698.176,749.104,711.888,1593.592,18842.088,581.368,949.696,1790.792,22007.84,1321.392,1675.072,3650.128,7957.024,1304.704,302.72,2390.336,17182.84,404.384,185.184,1277.928,21570.52,493.328,137.936,1769.768,16632.856,1729.32,520.648,2802.168,14667.84,737.16,287.608,1427.2,10019.776,1008.728,421.384,1315.472,7273.688,634.304,159.656,2469.688,6594.76,1370.704,1216.2,3301.768,592.784,918.808,125,17.89569313,10.05941586,0.827059906,0.838926174,0.490196078,-1.078150978
+4360,34266.95238,935.3333333,510.8571429,1083.68254,30799.69048,747.5793651,544.6428571,1546.706349,16542.12698,574.8095238,712.7142857,1710.15873,20371.49206,1382.746032,2422.015873,3000.460317,7477.603175,1377.055556,333.6190476,2311.039683,17002.56349,434.7619048,400.8095238,514.2063492,20991.96032,554.3809524,134.1507937,1693.880952,16248.84921,1630.857143,595.0634921,2809.928571,14950.23016,656.4444444,314.6904762,1931.063492,9460.293651,1218.785714,455.4365079,1325.873016,6549.777778,698.2460317,174.984127,3161.325397,6130.650794,1500.563492,1508.849206,3181.857143,366.9285714,920.5555556,126,15.95346289,10.3351983,0.761781396,0.90647482,0.65625,-0.114486499
+4361,25564.62295,975.3606557,518.2131148,1089.360656,22557.94262,740.6229508,538.4098361,1500.590164,12773.12295,600.4754098,452.942623,1686.327869,15448.33607,1363.409836,1602.04918,3004.040984,5653.565574,1416.418033,332.6229508,2285.114754,12938.54918,418.0655738,804.0491803,568.704918,15854.68033,458.2622951,130.5819672,1361.163934,12724.65574,1544.614754,741.1557377,2815.606557,11448.58197,609.7540984,289.9590164,1932.52459,7731.770492,934.5655738,445.704918,1318.762295,5389.237705,800.3278689,171.8852459,2877.5,5096.860656,1433.360656,226.4590164,3140.868852,412.2622951,920.4590164,122,15.2936369,10.54855908,0.724061745,0.924242424,0.677777778,0.158030965
+4362,38044.42623,891.8688525,506.6393443,1106.344262,33261.32787,768.6229508,1156.721311,1655.114754,20081.22951,566.3114754,2214.57377,1893.622951,24014.01639,1299.377049,2021.704918,4585.57377,8916.590164,1324.819672,311,2476.819672,18410.29508,456.3442623,105.6721311,1909.344262,23266.60656,1333.590164,126.0655738,1535.081967,18028.22951,2032.131148,467.6393443,2809.852459,15920,619.1147541,287.2131148,1548.934426,11299.90164,2600.213115,431.2622951,1342.065574,7923.065574,614.295082,165.6065574,3040.016393,7367.114754,1652.704918,358.7213115,3337.016393,672.0327869,918.6557377,61,10.71768815,7.897166427,0.676072751,0.938461538,0.564814815,-0.425906121
+4363,28760.33641,945.2764977,864.9585253,1166.092166,23455.85714,707.6129032,879.3133641,1798.552995,12146.21659,588.6359447,1000.612903,1782.654378,15403.16129,1253.050691,2324.230415,1922.414747,5643.557604,1284.414747,297.6820276,2378.179724,11963.47465,2103.967742,458.5852535,912.8617512,15211.78341,551.3041475,178.6589862,1171.741935,11426,1912.24424,447.0092166,2832.976959,9764.202765,1126.465438,274.3870968,1032.023041,6203.046083,1103.580645,404.4193548,1338.24424,3797.285714,683.6082949,155.2626728,2738.9447,3778.211982,1230.898618,416.0645161,3353.976959,879.9631336,921.8986175,217,19.8158345,14.73808056,0.668454867,0.871485944,0.638235294,1.396152058
+4364,24185.02817,1185.929577,595.0140845,1058.521127,21810.33803,754.5070423,604.8591549,1478.746479,12795.09859,618.5211268,523.5774648,1688.112676,14801.70423,1339.408451,1544.112676,2000.112676,5151.309859,1285.760563,283.2535211,2280.633803,11222.08451,368.2394366,131.7605634,695.8591549,14786.43662,463.0140845,114.3661972,1794.788732,11274.6338,1525.15493,508.3943662,2768.507042,9935.971831,820.1408451,267.971831,1347.957746,6783.464789,847.7887324,396.1126761,1302.746479,5079.042254,581.4647887,149.915493,1315.746479,4614.084507,1258.549296,1133.478873,3377.816901,608.5774648,919.028169,71,12.57756363,7.312375296,0.813630381,0.959459459,0.58677686,0.676274081
+4365,18340.58537,1261.268293,550.6341463,1034,18264.65854,777.7560976,613.8292683,1396,8818.707317,627.2926829,881.8536585,1743.97561,11753.36585,1283.97561,2954.780488,1796.097561,4257.658537,1145.756098,266.097561,2279.731707,7776.682927,350.2926829,97.29268293,693.8780488,9926.634146,634,151.0731707,1669.219512,7179.195122,1528.609756,434.6829268,2757.414634,6248.02439,742.902439,236.5853659,1194.390244,4450.97561,1047.731707,357.2926829,1291.463415,3435.97561,553.4634146,145.9512195,1642.512195,2850.780488,1136.707317,946.3170732,3349.634146,689.804878,918.8292683,41,9.349524699,6.618422815,0.706324004,0.82,0.585714286,0.041516241
+4366,35352.6478,966.0062893,509.6918239,1085.522013,30885.96855,727.3773585,787.5660377,1658.075472,16400.41509,584.9496855,1546.490566,1814.345912,20737.91824,1271.830189,5086.974843,3000.320755,7495.27673,1269.09434,309.5345912,2560.981132,16171.79245,426.6981132,234.3144654,1415.044025,20124.02516,703.8553459,124.918239,1690.861635,15419.68553,2027.90566,428.8616352,2853.106918,13366.72956,608.3396226,277.3584906,1015.553459,8614.113208,1497.396226,410.4402516,1322.188679,5317.352201,640.6855346,159.4339623,2056.691824,5212.962264,1247.345912,220.6163522,3379.654088,854.0377358,922.5534591,159,15.77287398,13.40152106,0.527336937,0.929824561,0.55017301,-0.385046387
+4367,27162.47143,869.1357143,810.0607143,1129.507143,21247.18214,595.5178571,790.0214286,1561.664286,8870.982143,562.3821429,1031.064286,1696.082143,13423.96786,1078.846429,3518.696429,1791.107143,5151.446429,1153.528571,263.5214286,2356.639286,10293.76786,353.4571429,348.6607143,1184.642857,12861.73214,448.9714286,288.9821429,1744.714286,9686.264286,2100.021429,348.325,2785.625,7930.257143,600.8714286,234.8928571,804.8321429,4102.578571,959.4285714,362.5035714,1296.203571,2249.771429,602.5392857,142.0071429,1515.132143,2462.746429,1064.310714,384.4107143,3126.653571,980.2285714,925.3178571,280,24.60474699,15.03081519,0.791714816,0.89456869,0.56,0.600401213
+4368,36712.66129,955.9677419,610.1935484,1095.354839,32666.51613,769.3709677,703.8387097,1668.548387,19007.24194,588.0483871,800.6129032,1743.725806,22805.17742,1363.419355,1973.274194,2284.596774,8362.096774,1703.822581,337.2903226,2331.854839,18804.32258,438.8870968,306.3870968,1263.5,23249.53226,575.2903226,133.8064516,1535.983871,18292.51613,1626.290323,496.6290323,2810.854839,16404.04839,711.016129,319.3225806,1545.419355,10928.3871,1202.387097,467.6935484,1325.435484,7595.370968,727.8548387,186.2096774,3801.209677,7052.983871,1490.822581,1068.241935,3281.467742,427.1774194,920.5806452,62,11.57577506,6.98201762,0.797621975,0.925373134,0.626262626,-0.507940966
+4369,26326.80741,890.5703704,543.5111111,1082.348148,23991.26667,726.762963,671.0888889,1533.644444,13122.14815,622.3481481,794.4444444,1727.325926,15968.18519,1301.274074,1807.903704,2694.733333,5990.977778,1676.740741,324.5185185,2325.148148,12838.11852,401.237037,702.1259259,607.0888889,16098.63704,587.1185185,124.5703704,1431.37037,12146.39259,1552.859259,525.1259259,2811.518519,10873.33333,650.5851852,291.1185185,1607.933333,7190.140741,1038.896296,439.9481481,1350.251852,5083.459259,792.1777778,174.3333333,4307.555556,4636.62963,1397.918519,283.8518519,3186.377778,438.6518519,921.1925926,135,14.58736548,11.94656554,0.573841145,0.9375,0.642857143,0.977538206
+4370,26790.51163,896.9767442,827.627907,1137.604651,24703.88372,725.4418605,932.0930233,1678.418605,13521.39535,594.0930233,718.2790698,1783.081395,16583.63953,1305.046512,1770.767442,1941.790698,6157.581395,1380.883721,324.4767442,2363.755814,13663.5814,542.8953488,448.255814,681.9186047,16440.02326,798.9767442,130.755814,1674.604651,12731.32558,1526.976744,478.4186047,2807.918605,11096.94186,956.7209302,308.8604651,1755.593023,7495.872093,916.4534884,451.4186047,1366.186047,5342.069767,703.5,169.9186047,2307.395349,4933.988372,1393.627907,278.9418605,3332.639535,523.4302326,919.9883721,86,11.60779916,10.15083349,0.48505454,0.945054945,0.601398601,0.176350277
+4371,37859.35,915.3833333,482.2,1099.016667,32553.76667,735.1666667,912.35,1606.8,19180.41667,561.7333333,1436.383333,1764.2,23336.7,1334.866667,3058.65,2652.716667,8372.4,1345.033333,307.4,2331.316667,17114.1,495.3666667,430.15,1084.65,22096.65,495.25,456.1833333,1613.333333,17244.85,1965.316667,571.7666667,2813.033333,15092.31667,627.9666667,286.95,1358.116667,10549.23333,1495.216667,431.0166667,1314.216667,7210.733333,699.6,155.8833333,1910.35,6712.85,1395.983333,275.5166667,3346.2,697.4166667,918.2333333,60,10.94649242,7.447063054,0.732919841,0.923076923,0.625,-1.402616959
+4372,24866.0566,826.7641509,501.1792453,1071.660377,22118.41509,679.4811321,787.8301887,1551.009434,12843.19811,640.1886792,1156.066038,1756.311321,15355.84906,1240.103774,2833.339623,3843.471698,5755.339623,1306.981132,292.6886792,2593.679245,11761.04717,370.0471698,418.3962264,977.5566038,14918.28302,1466.132075,123,1577.811321,11468.34906,1595.198113,566.1981132,2790.754717,9981.150943,728.3584906,265.0849057,1407.688679,6916.59434,1513.716981,393.8867925,1342.95283,4830.622642,670.7924528,160.0754717,3933.877358,4474.933962,1314.066038,904.2264151,3179.150943,726.009434,920.1603774,106,12.17299934,11.29741314,0.372402181,0.938053097,0.679487179,-0.343376676
+4373,40391.77381,919.452381,525.1666667,1097,36020.70238,735.3095238,729.5238095,1669.547619,19973.97619,556.5238095,787.9047619,1757.285714,25145.55952,1278.880952,2915.02381,3786.952381,9191.119048,1442.190476,320.547619,2349.464286,18932.63095,530.4642857,122.8928571,773.452381,24462.44048,756.9404762,132.0595238,2841.97619,19013.42857,1599,542.9285714,2782.369048,16406.53571,863.1309524,295.4047619,1334.595238,10762.14286,1320.488095,433.0833333,1304.857143,6920.5,622.1904762,166.6666667,2870.178571,6604.452381,1384.761905,174.1785714,3345.559524,808.3214286,919.6071429,84,12.2935894,9.185001815,0.664669494,0.923076923,0.646153846,-1.203828365
+4374,30047.08392,927.048951,771,1131.538462,26383.12587,754.8601399,890.2097902,1702.195804,15236.97902,629.8601399,1024.93007,1785.41958,18300.33566,1349.545455,1882.118881,2633.643357,6566.769231,1396.251748,339.3286713,2567.965035,15165.43357,1354.370629,656.2447552,633.5594406,17996.85315,753.4475524,131.027972,1288.713287,14149.67832,1528.888112,564.7762238,2814.272727,12526.97203,808.965035,308.2727273,1486.923077,8372.867133,1171.93007,457.3496503,1389.916084,5959.657343,775.5104895,174.979021,3027.692308,5510.020979,1444.034965,586.4475524,3332.426573,532.6293706,923.3356643,143,18.4841009,10.91936501,0.806859315,0.807909605,0.6875,-0.2458078
+4375,36902.00901,1072.378378,607.1891892,1104.567568,32080.66667,727.5315315,1000.153153,1604.171171,18787.03604,569.0720721,1547.72973,1842.522523,22513.89189,1328.720721,3863.765766,3940.198198,8057.459459,1336.936937,308.8918919,3317.045045,17378.05405,707.6216216,107.6216216,1046.630631,21841.68468,529.3783784,134.963964,1866.108108,16970.0991,2226.27027,520.3513514,2805.315315,14767.92793,755.2972973,295.1081081,1267.243243,9853.153153,1500.855856,439.3963964,1331.603604,7258.918919,620.3513514,166.8018018,2158.306306,6350.594595,1369.981982,1050.495495,3345.432432,575.1711712,920.4504505,111,15.42110252,9.310774963,0.797159755,0.940677966,0.74,-1.350498622
+4376,33534.16176,925.8382353,529.7647059,1085.911765,29447.5,716.9411765,970.0441176,1607.794118,17090.13235,568.1176471,2712.882353,1819.823529,20388,1280.823529,4288.897059,6185.941176,7448.308824,1262.470588,304.1470588,2449.632353,15484.95588,409.8676471,113.75,1421.264706,19553.83824,1637.970588,136.9558824,1872.911765,14957.91176,2063.308824,455.9705882,2785.676471,12886.16176,597.9558824,277.6911765,1459.647059,9188.323529,2614.073529,410.3823529,1319.176471,6528.102941,609.4558824,163.1617647,3337.117647,5988.441176,1341.720588,330.1764706,3249.926471,654.4264706,920.8235294,68,11.6026762,8.005451121,0.723841857,0.971428571,0.686868687,-1.084358891
+4377,27050.83158,789.3368421,464.6736842,1050.926316,23894.93684,632.0947368,788.5263158,1473.757895,13690.81053,586.5789474,1311.684211,1757.947368,17075.78947,1205.168421,2149.694737,2054.442105,6391.557895,1262.2,288.4210526,2365.221053,12744.91579,370.6210526,298.1157895,1454.421053,16406.47368,504.7684211,128.4210526,1066.726316,12701.31579,1690.631579,462.6631579,2799.031579,11107.17895,882.8631579,261.4,1477.978947,7612.978947,1298.389474,389.1052632,1312.4,5379,661.6315789,151.8421053,1866.031579,5105.242105,1307.263158,1005.231579,3189.915789,735.9789474,921.9789474,95,13.82474235,9.150162514,0.749619897,0.887850467,0.562130178,-0.632478611
+4378,27376.3894,880.9953917,532.8456221,1066.458525,24493.59217,729.6935484,931.7534562,1562.970046,13641.05991,547.3317972,1827.463134,1847.912442,16799.7235,1234.633641,3455.317972,3973.341014,6346.076037,1275.820276,298.59447,2600.089862,12777.74885,400.375576,693.1728111,1822.364055,16073.87097,1021.599078,316.140553,1425.329493,12881.49309,2125.603687,694.09447,2803.177419,10965.28341,646.40553,265.5737327,1216.930876,7304.721198,1345.640553,403.0506912,1337.202765,4955.953917,775.4078341,157.7442396,4333.253456,4624.506912,1308.182028,724.6059908,3243.361751,782.3133641,931.6843318,434,31.21491273,18.26111542,0.811024246,0.951754386,0.723333333,0.368355696
+4379,27127.52222,1089.233333,499.1777778,1067.477778,23239.68889,774.4444444,927.8666667,1538.622222,12458.48889,606.6555556,1607.311111,1797.455556,15297,1271.988889,3138.344444,4386.155556,5451.122222,1252.888889,284.5666667,2521.2,11040.77778,386.4111111,147.0111111,1700.366667,14117.36667,1312.844444,121.4111111,1253.166667,10912.96667,1762.766667,421.0444444,2799.833333,9347.722222,581.2333333,257.9888889,1080.233333,6136.111111,2212.244444,392.6555556,1295.811111,4151.311111,586.4888889,155.2888889,1949.466667,3924.677778,1182.422222,235.3888889,3431.722222,797.8888889,921.5777778,90,12.10129708,10.25117117,0.531412129,0.9,0.681818182,-0.765905177
+4380,19271.08491,821.5283019,640.8301887,1070.943396,18208.83962,672.5471698,719.5188679,1610.009434,8891.820755,535.4811321,1297.245283,1814.566038,11327.25472,1230.669811,4732.650943,5122.962264,4321.264151,1247.566038,307.2169811,2405.273585,9402.018868,373.6886792,2917.632075,1073,11715.37736,468.8396226,158.0283019,3219.707547,8695.518868,2018.566038,658.6981132,2802.066038,7987.698113,774.6226415,299.7830189,4042.113208,4755.59434,1285.915094,404.745283,1369.037736,3315.924528,1286.981132,157.9245283,5129.707547,3091.245283,1283.09434,720.6886792,3234.301887,326.3679245,921.3584906,106,13.68907416,10.2465057,0.663115521,0.972477064,0.642424242,-1.330922914
+4381,20611.56364,929.8909091,898.8727273,1168.781818,18641.69091,752.9818182,817.5090909,1704.727273,10577.98182,594.5090909,483.6363636,1753.636364,12943.87273,1328.963636,1116.854545,1604.272727,4816.690909,1428.563636,341.8,2390.018182,10495.49091,457.0727273,224.3090909,451.0909091,13048.63636,453.4,133.3090909,1497.690909,10189.49091,1522.345455,481.6545455,2812.872727,9165.872727,659.1090909,322.6727273,1734.127273,6233.672727,846.4,459.7272727,1398.6,4522.909091,639.3818182,178.0181818,1433.781818,4252.381818,1474.036364,541.4727273,3270.345455,468.8,921.9454545,55,9.514098095,7.712667711,0.585521695,0.964912281,0.611111111,0.401859098
+4382,30269.63158,1129.936842,536.2421053,1043.863158,25745.69474,785.7473684,744.8842105,1499.842105,15643.78947,633.2315789,1362.052632,1752.042105,17848.92632,1356.231579,2223.978947,2216.863158,6742.547368,1412.505263,287.7052632,2386.052632,13954.10526,378.2210526,110.5368421,1775.094737,17866.86316,451.0842105,134.2631579,1301.852632,13578.29474,2028.968421,440.4210526,2795.684211,11922.21053,648.5684211,265.5578947,1178.084211,8005.547368,1138.884211,407.0736842,1310.578947,6100.536842,590.9789474,154.7894737,1619.905263,5292.168421,1299.968421,1134.463158,3470.189474,601.2947368,923.7789474,95,12.18212064,10.61443814,0.490727963,0.95,0.56547619,1.489428986
+4383,30860.25991,920.3303965,481.030837,1074.422907,27622.03084,780.3348018,886.3259912,1534.259912,15505.68722,563.3259912,1417.07489,1761.502203,19204.84141,1286.334802,2328.145374,3385.643172,6900.929515,1298.251101,296.0176211,3100.462555,14455.23348,382.4185022,222.4757709,1587.700441,17975,1242.585903,464.0837004,1237.731278,14415.71806,1687.991189,458.9118943,2792.792952,12265.08811,647.7973568,267.5947137,1239.414097,8258.237885,1339.599119,400.0220264,1301.352423,5532.973568,623.6696035,158.1806167,3821.85022,5261.022026,1319.770925,1704.651982,3292.54185,766.2070485,927.9162996,227,21.93813335,15.22921923,0.719792402,0.807829181,0.606951872,-0.22930331
+4384,26386.35514,868.364486,446.1682243,1061.682243,23700.64486,697.2990654,538.953271,1517.616822,13210.86916,560.5140187,441.271028,1706.953271,15979.91589,1278.130841,685.7757009,1073.794393,6172.392523,1330.056075,319.8224299,2277.53271,13231.91589,678.0093458,141.046729,444.5046729,16242.35514,449.1028037,125.1869159,1091.616822,12754.61682,1476.813084,661.2429907,2820.476636,11572.23364,993.9252336,296.8504673,1489.962617,7595.915888,868.0093458,439.6635514,1312.317757,5325.345794,627.046729,168.1214953,1643.130841,4864.186916,1539.130841,13631.41121,3217.878505,387.5981308,924.046729,107,12.88736955,10.74285516,0.552375141,0.938596491,0.636904762,-0.376979275
+4385,22425.62903,964.1209677,1089.991935,1170.314516,20449.39516,731.3548387,1422.951613,1769,11598.47581,588.2741935,745.2580645,1837.435484,14205.58065,1318.991935,1143.637097,1556.532258,5172.169355,1412.782258,349.9919355,2505.830645,11494.44355,608.3870968,326.9516129,659.4274194,14093.74194,562.233871,126.6774194,1041.290323,11162.33871,1487.919355,444.6612903,2823.104839,9745.879032,2189.83871,301.2177419,1780.169355,6746.596774,1103.298387,459.7258065,1377.943548,4734.298387,667.7741935,167.6774194,1445.201613,4383.935484,1410.83871,194.9435484,3346.354839,508.483871,924.0080645,124,13.77456177,11.67012121,0.531237914,0.946564885,0.738095238,-0.35256575
+4386,27490.07317,892.0487805,672.8292683,1130.146341,24956.70732,705.9512195,716.4878049,1725.731707,13445.95122,519.4878049,740.4878049,1769.146341,17145.21951,1192.121951,1866.02439,2666.195122,6772.95122,1245.487805,307.804878,2384.609756,13253.46341,9968.487805,171,756.7073171,16819.09756,504.6829268,150.9756098,1807.487805,12909.26829,1614.780488,702.7317073,2803.195122,11260.58537,2510.268293,265.6097561,1202.829268,7285.853659,1356.463415,401.5609756,1304.95122,4814.853659,605.4390244,162.7317073,2046.146341,4602.170732,1263.243902,150.9756098,3308.439024,818.7317073,920.7317073,41,8.307053758,6.589474512,0.608911118,0.891304348,0.650793651,1.297332826
+4387,37739.47788,853.079646,526.8761062,1101.362832,16940.22124,549.7433628,694.9292035,1439.814159,8093.690265,425.5309735,1172.017699,1742.230088,11265.21239,1022.070796,4665.39823,2094.362832,4327.035398,1046.221239,237.7345133,2356.946903,8933.495575,317.5486726,111.6637168,1935.743363,11151.53097,612.079646,323.1504425,2703.60177,8314.469027,1996.256637,373.9911504,2785.318584,6896.628319,686.9823009,224.9026549,915.6460177,4053.19469,912.8761062,344.4867257,1272.150442,2191.168142,537.9557522,138.0176991,2808.672566,2379.442478,1015.884956,839.4513274,3097.858407,947.5840708,924.4070796,113,13.3355525,11.0012204,0.565199544,0.933884298,0.672619048,0.483468399
+4388,34894.44554,875.4257426,697.4752475,1147.920792,18009.29703,588.3415842,550.7920792,1575.272277,8014.331683,440.9851485,1276.079208,1749.747525,11819.74257,1071.183168,3634.381188,2963.277228,4566.356436,1103.193069,256.3762376,2297.722772,9269.079208,360.3514851,128.7772277,1218.282178,11614.08911,567.5742574,250.4207921,3228.613861,8558.950495,2131.019802,389.3019802,2788.836634,7120,697.7227723,237.8861386,898.1138614,4009.89604,1074.049505,360.5445545,1275.826733,2200.727723,548.5346535,143.6287129,1449.841584,2393.074257,1074.30198,706.5990099,3148.00495,961.3267327,926.490099,202,19.38364824,13.64726027,0.710140036,0.922374429,0.698961938,-0.880861049
+4389,38852.24186,1041.223256,654.3767442,1162.172093,27901.20465,715.3581395,579.5488372,1730.939535,12267.90698,573.3488372,1163.227907,1795.139535,16820.01395,1269.344186,6895.539535,4099.846512,6337.437209,1320.530233,315.3348837,2411.511628,13119.87442,357.2372093,330.6465116,872.6418605,15871.47442,721.8511628,120.9255814,4492.130233,11574.86047,1872.251163,333.2651163,2806.795349,9898.581395,591.0930233,275.8418605,1090.055814,4460.934884,1174.04186,393.6790698,1303.390698,3065.730233,620.3674419,151.5953488,2942.213953,2977.274419,1145.506977,510.3348837,3346.693023,271.6046512,927.2372093,215,21.88692102,13.33987566,0.792793188,0.911016949,0.568783069,-1.212451551
+4390,34286.34043,841.4893617,460.8297872,1085.531915,31294.80851,692.8510638,945.2978723,1563.106383,16778.74468,563.4680851,951.1276596,1726.617021,21018.46809,1272.638298,2366.87234,3172.489362,7688.595745,1339.404255,305.893617,2332.702128,17605.70213,593.0425532,430.2340426,758.4893617,21484.93617,1147.680851,128.9148936,1344.404255,16777.70213,1522.319149,429.1702128,2821.382979,15200.3617,628.8510638,300.2553191,1503.510638,9349.723404,1075.617021,440.212766,1313.382979,6491.042553,693.106383,167.7234043,2911.765957,6046.574468,1386.957447,642.1276596,3166.553191,352.3191489,922.5744681,47,8.860946382,7.496048059,0.533238864,0.810344828,0.580246914,-0.132955298
+4391,30094.60377,883.1069182,584.163522,1106.125786,26872.96855,713.6540881,881.5283019,1620.075472,15383.01887,556.9748428,1334.993711,1789.72956,17981.91195,1283.924528,3896.572327,4432.377358,6868.968553,1359.509434,317.0377358,2459.377358,14470,413.427673,180.3396226,1057.220126,17808.74214,744.8679245,133.6540881,3469.974843,13568.86792,1704.748428,523.2264151,2802.792453,12074.51572,825.7358491,297.2578616,1676.371069,8115.446541,1237.591195,442.4968553,1319.238994,5967.421384,635.5974843,166.0943396,3875.811321,5234.830189,1382.698113,773.3710692,3354.861635,557.2955975,925.0314465,159,19.38014262,11.55800152,0.802699483,0.85026738,0.611538462,1.252647465
+4392,34084.09091,853.3030303,514.6363636,1089.560606,29663.77273,711.6818182,745.2121212,1601.969697,17761.5303,524.530303,1202,1770.954545,21073.16667,1240.348485,2190.969697,3651.454545,7865.030303,1278.272727,286.0757576,2347.075758,16244.78788,400.5757576,104.5454545,980.5151515,20472,617.2424242,123.7121212,2050.939394,15878.95455,1779.363636,506.2272727,2775.772727,13834.78788,607.5,274.6969697,1795.681818,9763.80303,1310.727273,410.0606061,1294.333333,6851.984848,620.5,155.9393939,3834.136364,6385.909091,1383.924242,204.8939394,3283.560606,664.5909091,923.3787879,66,10.93552631,8.063290384,0.675512892,0.88,0.611111111,1.34445126
+4393,23862.35043,782.7606838,504.974359,1038.401709,21955.34188,630.0512821,535.3504274,1490.042735,11944.70085,628.2393162,931.4188034,1759.119658,15490.34188,1159.376068,2359.17094,2832.239316,5774.65812,1485.846154,261.2735043,2303.504274,11181.08547,348.4358974,416.1709402,1044.871795,14648.88889,692.6495726,120.042735,1987.794872,11109.60684,1547.102564,503.4444444,2794.119658,9672.521368,632.9487179,245.2820513,1502.615385,6852.316239,1129.487179,377.1623932,1335.102564,4825.521368,659.5726496,151.2649573,4089.965812,4474.91453,1245.82906,215.9230769,3192.094017,702.8376068,925.017094,117,15.49528993,10.99569314,0.70458944,0.860294118,0.529411765,1.475777369
+4394,14283.46429,850.6428571,613.7857143,1056.678571,15512.82143,736.6785714,846.6785714,1475.035714,7462.964286,515.9285714,1548.75,1734.964286,8874.607143,1230.642857,1315,4264.642857,3657.071429,1229,308.0714286,2300.035714,8150,406.9642857,228.7142857,1006.285714,8811.214286,888.9642857,124.2857143,1370.642857,6483.928571,1884.75,634.8214286,2782.035714,6417.285714,899.6428571,268.4642857,2184.25,4125.607143,1414.785714,434.25,1279.142857,2968.678571,617.0714286,159.25,4407.321429,2486.785714,1357.821429,1618.821429,3153.892857,358.4642857,923.6071429,28,7.235299911,5.238926758,0.68971733,0.875,0.666666667,-0.524605349
+4395,27434.57843,928.3235294,696.1568627,1113.5,24037.57843,728.7352941,851.9411765,1617.333333,13715.93137,588.7843137,1347.509804,1793.019608,16112.32353,1306.294118,3567.745098,2352.411765,5938.921569,1365.401961,332.6176471,2756.245098,13015.95098,432.8235294,284.6568627,595.7058824,16171.67647,556.0588235,142.4803922,1121.509804,12378.60784,1828.147059,421.1470588,2792.901961,10866.64706,765.0980392,295.6078431,1173.117647,7301.539216,1133.411765,432.9411765,1337.705882,5308.872549,657.4019608,166.3529412,2436.303922,4833.264706,1382.872549,1491.245098,3318.117647,542.7647059,924.9607843,102,14.19925884,9.446445633,0.746596287,0.918918919,0.713286713,-1.19815156
+4396,24130.45238,807.3809524,658.9166667,1078.130952,14957.46429,574.3452381,555.5238095,1496.571429,7631.869048,465.7619048,570.5952381,1723.345238,10208.94048,1085.72619,3968.619048,1922.857143,3858.154762,1116.321429,260.5119048,2351.357143,7978.416667,374.9880952,865.7261905,682.1547619,10056.38095,438.1071429,119.2380952,965.547619,7663.238095,1813.77381,789.1904762,2796.345238,6525.964286,582.4880952,244.6785714,903.3452381,4180,1010.833333,370.6309524,1379.345238,2494.607143,741.9761905,148.8333333,5011.619048,2612.095238,1124.107143,489.8452381,3134.166667,894.25,925.2142857,84,10.88060302,10.18269649,0.352378067,0.954545455,0.694214876,-1.070093736
+4397,38264.54167,923.8916667,570.7666667,1120.341667,30807.99167,720.2666667,779.8083333,1753.516667,15725.275,541.3916667,2472.933333,1827.883333,19715.9,1251.333333,5916.808333,4003.65,7299.25,1306.75,315.0583333,2525.433333,15963.19167,404.8333333,1447.466667,2181.283333,19579.56667,436.5083333,893.925,3116.158333,15129.06667,2186.525,425.3916667,2826.983333,13636.55,626.9166667,305.2583333,1247.1,7330.066667,1204.241667,428.9083333,1345.891667,4982.483333,1034.6,168.675,3299.091667,4698.691667,1291.908333,664.925,3268.675,315.8583333,926.675,120,13.70359317,11.34021265,0.561413088,0.975609756,0.615384615,1.156838839
+4398,34790.95833,977.0555556,831.1388889,1162.25,29869.29167,784.8611111,763.3472222,1772.569444,16670.625,767.6805556,499.25,1743.152778,20717.68056,1405.361111,1536.472222,1270.611111,7629.027778,1524.736111,392.0555556,2337.152778,16196.30556,494.5694444,404.3055556,463.2361111,20564.625,472.875,141.4861111,1332.888889,16073.52778,1584.430556,486.8888889,2814.236111,13977.05556,913.5972222,329.0833333,1759.680556,9461.791667,867.0555556,486.7777778,1385.25,6645.652778,712.0138889,179.6527778,1663.805556,6270.083333,1486.277778,338.7361111,3278.097222,476.8611111,925.5555556,72,12.026041,7.910238219,0.75322834,0.923076923,0.553846154,-1.060136471
+4399,27932.01149,882.1494253,589.045977,1104.218391,25043.86207,732.2988506,987.9885057,1619.632184,14438.33333,596.2758621,1675.068966,1767.45977,17693.05747,1298.908046,1940.931034,3037.942529,6353.229885,1372.563218,306.0344828,2337.954023,14170.13793,448.7011494,866.1034483,1570.965517,17053.71264,1399.298851,128.4712644,1221.241379,14028.52874,1494.402299,516.8965517,2826.551724,12386.49425,912.8275862,303,1574.551724,8364.655172,1349,452.4942529,1383.471264,5785.298851,786.8275862,168.4022989,3282.781609,5358.333333,1398.034483,401.6896552,3263.954023,518.1724138,927.7241379,87,11.70256847,10.04932102,0.51243199,0.956043956,0.608391608,0.130017208
+4400,25173.568,994.224,510.312,1060.336,20358.512,716.448,598.384,1489.944,12197.088,571.52,758.92,1733.048,14171.936,1299.808,1561.392,2005.048,5421.952,1267.488,286.768,2333.288,11235.192,400.472,107.56,845.104,13766.552,470.688,129.632,1574.216,10717.176,1662.944,469.048,2820.008,9422.616,1781.4,270.608,1365.024,6524.664,974.528,416.104,1308.648,4798.944,589.952,155.168,1520.448,4219.384,1339.864,2757.096,3302.8,585.696,929.848,125,16.06967737,10.9052808,0.734485158,0.868055556,0.534188034,-0.110960924
+4401,30958.68182,940.6590909,720.3181818,1097.568182,26342.46591,733.8068182,1011.647727,1617.375,15888.19318,576.4772727,1589.102273,1794.375,19081.11364,1309.022727,2679.613636,2700.784091,7124.647727,1276.488636,301.8068182,2330.170455,14487.76136,395.7840909,102.8863636,1059.034091,18116.80682,682.0340909,122.6363636,1024.261364,14190.26136,1976.727273,437.625,2809.772727,12441.14773,785.5681818,268,1295.511364,8671,1993.852273,412.6590909,1327.568182,6143.477273,601.5795455,158.3863636,1454.056818,5590.840909,1384.102273,1365.727273,3318.829545,678.2159091,926.4886364,88,11.16641357,10.04623862,0.436542676,0.977777778,0.727272727,1.045273198
+4402,36037.35,856.4,477.325,1103.7625,31969.7125,743.675,751.0875,1648.0375,18056.6375,546.9,712.65,1725.6625,21797.4125,1294.85,1824.025,3459.375,7990.425,1324.025,318.9875,2443.475,16870.2,582.4625,176.8625,734.475,21019.7875,596.7125,129.35,1755.6875,16458.1625,1493.6,449.6,2787.0875,14164.325,855.6625,275.975,1360.3125,9479.3,953.15,421.8,1296.7625,6268.875,629.775,164.9,2661.4125,5963.5625,1392.9125,966.475,3222.3625,756.0375,926.55,80,11.76188609,8.842823959,0.659368133,0.963855422,0.683760684,-0.200341912
+4403,40230.01515,934.6060606,505.6818182,1097,34971.90909,737.1969697,982.530303,1684.69697,19089.0303,555.6666667,1297.121212,1836.833333,23928.39394,1288.409091,4071.424242,2292.227273,8584.863636,1278.227273,318.4393939,2517.909091,18187.22727,11142.75758,334,793.8030303,22950.95455,914.1666667,123.6818182,2010.484848,17520.45455,2024.651515,487.3181818,2819.484848,15058.69697,658.0909091,277.1818182,1044.621212,9722.166667,1207.484848,410.7424242,1317.818182,5925.151515,689.7727273,156.7272727,3081.060606,5895.287879,1305.106061,233.5909091,3350.030303,839.7727273,925.4242424,66,11.51006834,7.421920344,0.764334602,0.970588235,0.6,-0.933958516
+4404,17418.14407,814.3644068,613.9152542,1060.025424,16237.94915,654.9661017,610.4322034,1493.550847,8349.991525,526.1525424,791.2881356,1754.135593,10181.77119,1207.152542,2797.186441,1881.686441,3880.677966,1239.711864,302.2627119,2312.338983,8808.474576,431,1085.288136,751.279661,10559.08475,580.6525424,126.2118644,1169.525424,8123.661017,1677.398305,993.4067797,2805.652542,7589.889831,639.5423729,271.059322,1399.652542,4593.898305,1164.610169,413.6694915,1325.694915,3217.652542,801.559322,165.4152542,3179.177966,2909.855932,1310.245763,1868.118644,3187.042373,333.940678,929.0677966,118,13.18725211,11.61823925,0.473078118,0.975206612,0.648351648,-0.157724206
+4405,31760.69466,877.9083969,489.0229008,1067.580153,28294.15267,692.0687023,590.4503817,1587.068702,16417.9542,556.4351145,686.4732824,1723.099237,20233.38168,1259.625954,2531.366412,2947.282443,7453.381679,1286.78626,289.3664122,2299.022901,14971.9084,377.6717557,182.6183206,691.0229008,19159.71756,673.5114504,119.5496183,2363.068702,14775.25191,1384.053435,480.8625954,2782.038168,12858.05344,657.9389313,273.7099237,1609.091603,8946.007634,954.5496183,395.3358779,1283.839695,6298.969466,620.9389313,157.8549618,2937.175573,5736.687023,1327.610687,476.1679389,3228.320611,692.3969466,928.9236641,131,21.64282704,8.162266399,0.92615832,0.891156463,0.467857143,1.073096651
+4406,30871.925,1003.875,526.975,1078.5125,27767.7375,781.7,541.3625,1544.225,15842.975,690.2375,1165.4625,1765.3125,18297.4625,1397.775,1410.9625,1780.375,6370.8625,1568.6,330.775,2289.15,14687.9375,415.85,448,1343.475,17881.05,515.5,131.3375,926.375,14275.8875,1642.4,428.975,2826.65,12809.4875,924.7125,298.8,1291.125,8647.8125,1468.2,458.7625,1359.6625,5845.425,709.1375,179.4625,2705.6875,5393.15,1488.925,4024.275,3191.9625,430.775,928.725,80,11.72017905,9.06738127,0.633606447,0.930232558,0.559440559,-1.46871998
+4407,23917.75182,966.1970803,707.4087591,1146.839416,21244.31387,759.6423358,624.9270073,1651.153285,12157.0219,609.4963504,473.9854015,1750.29927,14804.19708,1397.576642,1243.715328,1377.992701,5386.182482,1459.437956,340.4671533,2337.233577,12078.9562,455.1751825,316.0364964,467.1167883,15061.72263,476.4014599,131.0437956,1149.868613,11898.86131,1531.817518,427.6788321,2846.29927,10846.67883,673.4963504,302.9416058,1864.671533,7092.386861,893.649635,461.0072993,1324.627737,5003.781022,684.5839416,176.7810219,1043.978102,4796.890511,1497.737226,633.4306569,3237.956204,452.2262774,929.6569343,137,14.41545317,12.55424907,0.491481049,0.901315789,0.698979592,-0.435393614
+4408,33992.56303,848.2521008,479.6554622,1071.02521,30113.7479,686.1008403,745.3445378,1509.151261,17313.13445,552.7815126,1477.840336,1735.487395,21217.36134,1309.714286,2589.159664,2880.487395,7869.773109,1356.773109,298.3109244,2315.915966,16307.60504,388.302521,383.1176471,1535.193277,20654.79832,460.6134454,293.1848739,1038.042017,16179.4958,1959.218487,463.3277311,2794.705882,14008.73109,769.2352941,280.8823529,1216.394958,9546.773109,1200.806723,413.1008403,1283.109244,6493.731092,683.6470588,161.6386555,1384.857143,6223.243697,1370.697479,982.7731092,3252,744.9663866,928.0420168,119,15.56469087,10.70835486,0.725719972,0.85,0.636363636,1.449294958
+4409,19340.70423,1131.323944,643.3098592,1067.295775,18274.56338,767.971831,791.7887324,1500.535211,8733.422535,579.7887324,1186.352113,1749.985915,11635.74648,1225,3666.15493,2844.915493,4347.225352,1179.070423,264.1267606,2279,8125.633803,1553.830986,145.7605634,750.5070423,10634.73239,424.5774648,258.1830986,3050.267606,7645.492958,1691.887324,484.2676056,2765.380282,6605.070423,1153.929577,230.6478873,1169.478873,4418.014085,984.6619718,366.8309859,1278.126761,3041.647887,567.5070423,148.6478873,2920.309859,2763.450704,1094.239437,159.3380282,3386.633803,814.4225352,927.8169014,71,11.74473167,8.904381998,0.652068938,0.806818182,0.537878788,0.170390765
+4410,41450.22034,911.2033898,558.4067797,1093.881356,37160.05085,775.6779661,804.8135593,1703.779661,20582.64407,557.3728814,1107.169492,1801.728814,26235.23729,1296.915254,3221.525424,3686.389831,9545.830508,1342.559322,317.779661,2335.40678,20096,2204.59322,116.4067797,1046.79661,25698.88136,502.7627119,254.1694915,2595.338983,19574.11864,2102.322034,607.1694915,2806.525424,16912.37288,1307,295.4067797,1169.050847,11075.66102,1359.711864,439.5084746,1333.79661,6951.525424,615.2711864,161.9661017,1925.728814,6848.084746,1356.033898,189.7966102,3293.847458,825.1186441,926.6440678,59,11.15056448,6.853612733,0.788805671,0.921875,0.670454545,1.537500389
+4411,31848.0303,814.9090909,541.0050505,1089.106061,18995.5303,564.4494949,695.3787879,1480.510101,8856.782828,566.9090909,1892.474747,1784.363636,12304.5202,1052.989899,5881.893939,3032.671717,4731.161616,1092.373737,251.0656566,2397.368687,9404.055556,333.9292929,546.3131313,1325.323232,11720.0303,574.7272727,150.7373737,1307.924242,8886.636364,2555.328283,536.6515152,2845.424242,7328.111111,628.1868687,225.2575758,825.8535354,4346,1407.454545,342.5858586,1314.944444,2424.358586,663.3383838,143.8333333,1922.363636,2477.525253,1027.20202,261.8838384,3072.454545,918.6161616,932.2323232,198,19.174781,13.5503479,0.707537802,0.942857143,0.613003096,0.585043309
+4412,36485.17647,843.4248366,582.9509804,1107.065359,19544.32026,551.3398693,517.3006536,1473.330065,8992.591503,435.3986928,1146.77451,1700.254902,12568.19608,1013.614379,3531.702614,1873.70915,4810.392157,1039.607843,245.2320261,2286.545752,9645.79085,328.6928105,240.6764706,1774.392157,11948.25817,381.130719,107.620915,1321.19281,9025.058824,1721.794118,544.8986928,2827.630719,7334.960784,630.8398693,222.6405229,772.9869281,4165.228758,1196.179739,344.869281,1282.643791,2259.405229,645.2385621,137.3954248,1385.303922,2362.594771,998.8660131,276.5947712,3099.607843,937.9901961,933.8627451,306,22.40721099,18.11057757,0.58884259,0.924471299,0.607142857,1.243864679
+4413,28442.95714,931.8714286,577.0714286,1094.471429,25526.82857,730.7,611.8428571,1518.7,14103.17143,576.3857143,858.5714286,1702.757143,17349.45714,1385.971429,1963.885714,2202.214286,6148.285714,1355.085714,346.0285714,2335,14715.42857,434.9428571,493.6142857,669.8285714,18160.45714,954.0857143,131.6142857,1415.2,14199.77143,1578.571429,471.3142857,2821.571429,12997.68571,711.5285714,312.0857143,1461.071429,7990.671429,1064.214286,474.5714286,1321.914286,5496.528571,737.6285714,187.1428571,3434.014286,5163.442857,1519.114286,5341.014286,3165.542857,346.5428571,930.1428571,70,10.31802141,9.297293083,0.433666921,0.864197531,0.53030303,-0.192251967
+4414,27418.83333,997.9901961,512.245098,1089.705882,24925.14706,752.1960784,567.9411765,1518.323529,13481.02941,603.8627451,406.6862745,1705.078431,16690.65686,1392.078431,1248.441176,2286.470588,6162.27451,1334.098039,325.4411765,2284.843137,13788.64706,429.7156863,195.4215686,444.7843137,17060.02941,455.7647059,129.6862745,1649.392157,13076.31373,1461.607843,633.3921569,2825.009804,12236.44118,649.2647059,305.1078431,1800.607843,7643.127451,841.0196078,449.4803922,1316.313725,5341.519608,640.8235294,174.7647059,2357.166667,4973.931373,1531.568627,11002.7451,3203.27451,376.9509804,930.1078431,102,12.87032378,10.22553711,0.607257558,0.944444444,0.708333333,-0.861370627
+4415,22930.40476,928.5119048,991.6904762,1163.208333,20813.52976,722.827381,811.8690476,1693.714286,11851.57738,559.2857143,506.7440476,1795.220238,14111.77976,1292.488095,1007.755952,1489.738095,5191.708333,1389.392857,315.3511905,2403.392857,11607.52976,454.1011905,183.7916667,454.375,13945.1369,483.0535714,127.3511905,1097.964286,11224.34524,1439.339286,481.4583333,2830.666667,10113.41071,788.1964286,294.5178571,2097.827381,6737.261905,915.6904762,447.7142857,1432.64881,4701.839286,625.1309524,167.0059524,1312.559524,4394.708333,1408.017857,928.0357143,3322.904762,464.625,932.7202381,168,16.32501953,13.60990687,0.55224185,0.943820225,0.65625,-0.869888575
+4416,35220.43629,919.5019305,562.7027027,1089.467181,31033.22008,714.3243243,876.5212355,1611.169884,18164.46332,563.3745174,1262.687259,1805.861004,21296.27027,1285.702703,3210.756757,4244.007722,7836.625483,1285.814672,291.5366795,2402.362934,16287.78764,413.7915058,102.6872587,1088.65251,20664.22394,644.5096525,153.03861,2617.312741,15656.98456,1886.525097,604.4015444,2788.34749,13500.19691,605.4864865,274.2664093,1643.355212,9162.772201,1422.633205,410.8918919,1298.274131,6711.455598,609.7606178,153.7606178,3042.328185,5964.679537,1337.648649,205.1930502,3314.181467,622.3745174,932.6911197,259,23.02709043,14.5450222,0.775255082,0.931654676,0.674479167,-1.513869581
+4417,28289.97115,998.6538462,565.8461538,1068.548077,22939.77885,738.4134615,1114.846154,1511.817308,12966.13462,547.4038462,1856.855769,1746.596154,15142.63462,1222.269231,3633.067308,4453.673077,5758.951923,1221.711538,276.8076923,2335.182692,11650.54808,378.5480769,111.0865385,968.8076923,14358.125,800.5673077,113.5384615,1807.326923,11109.44231,1541.211538,484.4230769,2777.442308,9676.471154,573.3076923,258.75,1336.769231,6692.788462,1408.259615,378.6057692,1317.086538,4866.259615,584.4519231,152.0384615,1984.326923,4377.961538,1248.240385,428.375,3402.028846,655.1057692,929.6730769,104,13.46195714,10.42750261,0.632463225,0.912280702,0.619047619,1.409711325
+4418,32763.16484,964.8351648,584.0989011,1116.538462,29478.87912,759.1208791,639.967033,1656.263736,16592.58242,583.7032967,453.7912088,1729.054945,19726.56044,1381.274725,780.2417582,910.4285714,7240.56044,1431.318681,338.032967,2306.142857,15771.58242,1102.714286,141.978022,459.5494505,19242.71429,510.2527473,132.5824176,901.3406593,15277.41758,1494.285714,489.3186813,2823.571429,13733.56044,958.6373626,309.1428571,1704.351648,8936.615385,1020.912088,458.0659341,1329.857143,6097.175824,629.1208791,169.4175824,2092.901099,5414.263736,1454.417582,3038.10989,3263.417582,395.9230769,929.6373626,91,15.92692195,7.533244554,0.881068815,0.968085106,0.7109375,-1.303258764
+4419,32383.42308,996.7615385,514.4461538,1054.653846,28245.76154,773.1384615,864.9769231,1542.269231,16478.38462,608.4307692,1691.192308,1859.115385,19290.09231,1331.330769,2807.153846,3040.546154,7051.092308,1321.2,313.3538462,2359.146154,15010.26923,409.9769231,104.4,1978.584615,18729.71538,465.8923077,168.1384615,966.0384615,14279.26923,2450.223077,431.8923077,2791.823077,12539.73077,644.9923077,283.8615385,1090.507692,8378.8,1467.869231,428.5769231,1313.115385,6035.546154,597.0692308,163.5153846,1239.930769,5377.407692,1312.669231,357.5153846,3446.346154,574.1307692,932.0846154,130,15.67481471,10.72472426,0.729293467,0.955882353,0.619047619,0.66107616
+4420,22842.08871,952.8790323,653.7258065,1120.524194,20285.31452,746.1129032,545.5806452,1644.870968,11276.6371,993.7016129,731.733871,1768.072581,13925.6371,1437.354839,2830.096774,2222.717742,5135.290323,1390.879032,406.1290323,2332.008065,10311.66129,410.4032258,530.8467742,1121.08871,13478.98387,550.0564516,135.0806452,1128.41129,10314.70161,2148.556452,455.766129,2804.806452,9135.774194,1102.33871,278.4274194,1161.25,6275.467742,1357.282258,430.5,1365.782258,4369.209677,739.5645161,168.266129,2556.846774,4132.854839,1461.903226,1118.975806,3199.540323,720.9596774,931.7580645,124,13.09285398,12.49006535,0.299932309,0.939393939,0.794871795,1.010733725
+4421,34785.56863,870.4117647,561.4705882,1095.088235,30688.38235,714.2843137,870.3235294,1627.882353,17133.57843,546.9607843,1347.196078,1780.254902,21899.43137,1272.529412,3998.45098,5100.813725,8365.686275,1316.166667,316.1470588,2531.745098,16639.07843,545.3333333,457.6176471,1020.784314,21428.88235,1732.745098,148.1862745,2581.45098,16694.0098,1601.313725,741.3921569,2801.480392,14509.39216,626.1764706,290.6862745,1406.656863,9507.382353,1639.647059,405.4901961,1332.568627,6184.245098,695.7647059,166.6470588,5392.862745,5861.803922,1337.215686,284.9313725,3284.911765,805.5294118,930.9019608,102,12.48581645,10.60223316,0.528164361,0.944444444,0.713286713,-1.417995326
+4422,37006.34513,901.6283186,534.420354,1089.960177,32611.9469,691.2256637,621.9115044,1652.823009,17471.65487,532.9911504,1065.088496,1783.415929,22610.82743,1254.743363,3483.473451,3781.792035,8097.836283,1314.486726,300.7743363,2418.477876,16976.31858,696.1238938,215.6946903,848.4778761,21382.55752,477.6283186,162.3185841,2955.982301,16489.96903,1893.836283,551.0353982,2807.929204,14179.03097,623.3495575,280.6061947,1308.893805,9015.513274,1230.579646,410.7035398,1305.792035,5711.300885,639.7389381,158.7566372,3347.734513,5585.469027,1307.061947,858.9247788,3272.769912,830.3362832,939.0707965,226,26.45231709,12.07555268,0.889722056,0.821818182,0.620879121,-0.196672967
+4423,31162.68338,1036.598945,531.9973615,1071.509235,23945.12929,624.7308707,541.2137203,1495.46438,12409.63852,492.1002639,1209.728232,1736.783641,16175.33773,1139.920844,4906.6781,2648.823219,6053.377309,1215.134565,272.6754617,2415.881266,12339.58575,502.8548813,128.3667546,958.2823219,15589.84169,435.525066,286.8496042,2188.562005,11897.43799,2124.683377,425.2084433,2792.870712,10184.92084,561.1503958,251.4010554,974.5145119,6529.55409,1119.287599,374.4722955,1280.751979,4076.369393,582.3166227,150.5329815,2237.506596,3968.585752,1175.274406,587.8575198,3227.915567,845.3139842,939.591029,379,25.82117327,19.435851,0.65835242,0.885514019,0.633779264,-0.57261406
+4424,39084.36364,959.1818182,529.6363636,1115.981818,32659,737.2909091,704.7818182,1702.309091,17592.49091,577.2727273,2103.472727,1766.836364,22248.32727,1309.454545,4401.818182,3688.381818,7557.945455,1290.163636,323.5636364,2803.690909,16600.23636,412.0909091,205.5454545,1192.163636,20995.90909,503.2181818,127.1090909,1630.8,15851.30909,2510.690909,435.6545455,2817.127273,13497.90909,593.4545455,270.6363636,1013.072727,8619,2039.690909,411.7636364,1318.8,5186.527273,629.2545455,155.2363636,2004.345455,5169.618182,1242.745455,219.0727273,3404.381818,860.5090909,930.3272727,55,10.75189208,7.000646263,0.758984829,0.859375,0.55,-0.582503821
+4425,22154.29358,892.853211,461.266055,1061.513761,20785.68807,705.2568807,584.0183486,1455.366972,10516.53211,567.559633,919.0917431,1725.651376,12996.17431,1320.697248,1518.477064,1908.495413,4954.486239,1304.605505,315.9174312,2378.431193,10784.10092,393.8715596,597.8256881,517.8073394,12956.91743,489.4311927,124.3944954,966.4770642,9826.036697,1649.908257,488.8807339,2824.587156,9201.229358,860.2385321,286.3119266,1345.12844,5693.972477,1262.954128,420.1743119,1352.642202,3872.550459,702.2385321,178.8899083,2211.53211,3563.733945,1451.990826,10224.34862,3144.706422,357.8990826,931.733945,109,14.32841928,10.52419524,0.678610856,0.819548872,0.605555556,-1.505516418
+4426,17982.21687,962.9277108,929.1927711,1137.927711,17165.46988,744.6746988,765.060241,1680.746988,9488.638554,706.9277108,532.1445783,1803.903614,11362.38554,1346.216867,2105.120482,1313.084337,4389.518072,1475.072289,353.1204819,2391.879518,9769.662651,1846.349398,1148.614458,468.9638554,11727.15663,487.060241,134.8433735,1136.349398,8915.759036,1640.759036,445.6144578,2822.783133,8096.975904,1726.096386,307.0361446,1721.843373,5653.46988,848.9638554,473.4698795,1447.192771,4066.53012,881.5662651,178.8554217,3865.204819,3693.385542,1457.361446,398.8433735,3282.963855,478.5180723,933.5301205,83,13.88971249,8.150437988,0.80973427,0.892473118,0.628787879,-0.80677668
+4427,32443.59829,1132.435897,767.1196581,1180.931624,28961.76923,899.7521368,617.0769231,1826.726496,16804.62393,772.0598291,463.5811966,1752.205128,20826.92308,1666.957265,1086.153846,1148.042735,7252.102564,1650.401709,406.3418803,2353.068376,17888.23932,2825.333333,778.8888889,473.6324786,21018.57265,555.1794872,150.8547009,1333.521368,16542.65812,1775.222222,445.3162393,2823.196581,14511.46154,4022.08547,364.6666667,1544.136752,9869.376068,1008.068376,525.7948718,1408.094017,6982.418803,852.1623932,201.982906,3084.282051,6548,1704.692308,399.1282051,3415.136752,488.7521368,932.8974359,117,13.66157183,11.19088051,0.573578943,0.959016393,0.75,-0.287185318
+4428,32906.80226,963.7740113,692.519774,1101.090395,28688.57062,709.7457627,1078.19209,1651.242938,16717.63277,564.8813559,2253.785311,1791.011299,19812.75141,1275.022599,3264.141243,3928.050847,7270.033898,1262.20339,290.079096,2409.99435,15155.53672,415.1129944,185.2316384,1254.525424,18975.77966,1378.711864,136.1299435,1361.124294,14675.9209,1880.033898,459.5141243,2790.531073,12667.40678,649.8248588,273.1864407,1297.039548,8749.384181,1508.80791,401.3728814,1318.254237,6174.847458,614.6214689,157.0056497,2252.169492,5629.39548,1343.779661,1414.355932,3330.548023,664.7627119,935.2485876,177,20.87654637,11.03758177,0.848804233,0.917098446,0.578431373,-0.842373994
+4429,33953.72165,886.0618557,550.9587629,1105.701031,29892.87629,716.1752577,730.5051546,1640.793814,17352.5567,1003.71134,1404.298969,1792.505155,21169.06186,1431.309278,3005.835052,3160.123711,7820.680412,1404.092784,330.2989691,2450.773196,16339.1134,388.4226804,419.8350515,1887.597938,20602.20619,586.6494845,335.0721649,2045.340206,16316,2193.061856,445.8453608,2821.824742,14300.46392,837.1649485,284.2989691,1391.505155,9625.762887,1364.474227,408.9896907,1335.061856,6678.103093,737.0721649,163.6701031,3674.195876,6127.371134,1369.216495,384.0206186,3297.020619,731.9896907,933.0515464,97,11.69680406,11.43183946,0.211641971,0.91509434,0.678321678,0.137701442
+4430,25236.53659,923.1341463,505.8536585,1084.146341,22477.62195,676.1097561,521.6707317,1621.878049,11475.2561,544,657.8658537,1764.487805,15192.92683,1195.073171,4110.243902,2339.487805,5547.792683,1218.658537,358.0853659,2328.792683,11552.28049,453.7195122,187.6829268,641.6219512,15135.60976,530.1829268,124.1341463,2120.743902,10949.58537,1957.243902,442.7560976,2790.341463,9209.512195,620.5853659,252.0853659,1079.609756,6047.621951,1312.353659,391.8658537,1313.195122,3634.890244,612.4268293,156.5853659,1561.280488,3673.060976,1181.621951,191.3170732,3372.621951,868.1585366,932.597561,82,11.53780219,9.62125726,0.551930752,0.88172043,0.683333333,-0.110448269
+4431,38406.45274,1094.522388,653.1492537,1154.80597,28522.11443,665.1293532,622.3283582,1710.477612,13180.72139,528.6865672,1474.905473,1777.875622,17308.29851,1214.044776,5856.154229,3713.179104,6566.562189,1273.507463,302.7711443,2452.447761,13601.0796,348,830.0547264,1527.273632,16337.51244,841.4079602,124.2487562,3350.169154,12636,1726.512438,335.119403,2813.81592,11023.10448,566.2587065,276.2089552,1113.079602,5180.552239,1327.427861,398.6169154,1295.925373,3511.353234,798.0199005,157.9253731,2517.109453,3332.38806,1178.099502,259.800995,3224.308458,291.0298507,937.9104478,201,24.74481739,11.9371988,0.875944397,0.75,0.56302521,-0.325545928
+4432,22503.67969,889.609375,905.109375,1166.804688,11518.89844,602.015625,727.0390625,1590.671875,4602.15625,458.2421875,727.0390625,1677.804688,7279.039063,1121.742188,2430.171875,1563.648438,2831.945313,1222.257813,268.1875,2338.554688,5809.601563,393.0859375,126.4609375,737.296875,7177,498.96875,130.3359375,1580.273438,5314.734375,1738.953125,346.8671875,2784.296875,4546.632813,851.8203125,234.1484375,906.9375,2387.296875,820.1875,359.1953125,1276.007813,1400.59375,533.953125,152.15625,1054.351563,1558.117188,1070.84375,685.0703125,3134.5,972.484375,935.1015625,128,14.13177327,11.78978536,0.551348528,0.984615385,0.703296703,0.705047907
+4433,30391.08046,917.1494253,567.7471264,1096.425287,27772.13793,717.6551724,723.9885057,1628.551724,14268.08046,572.7471264,2154.908046,1799.643678,18306.48276,1320.137931,3852.183908,3621.632184,6602.816092,1331.321839,325.5172414,2302.908046,14647.50575,439.8965517,1235.344828,1372.057471,18201.09195,473.5517241,145.816092,1506.931034,13735.56322,2196.632184,578.4137931,2835.91954,12500.35632,643.6781609,291.6551724,1177.666667,6974.609195,1541.241379,425.7701149,1325.103448,4689.574713,892.6321839,171.6551724,3261.804598,4323.643678,1353.574713,1371.666667,3238.908046,323.6781609,934.4482759,87,11.00617675,10.55541825,0.283253914,0.956043956,0.659090909,-1.128339435
+4434,22761.36296,963.6074074,871.4888889,1169.496296,20034.62963,750.8962963,829.9555556,1776.044444,11332.9037,608.6740741,546.8888889,1779.562963,14296.96296,1360.925926,1063.896296,1608.02963,5167.525926,1409.488889,324.4444444,2361.733333,11250.57778,482.5851852,533.9555556,513.9777778,14164.13333,513.6814815,132.8740741,1376.148148,10963.28148,1533.177778,419.8592593,2815.688889,9521.681481,874.6666667,305.5037037,1612.955556,6607.777778,1313.585185,460.6666667,1364.837037,4651.007407,700.6074074,170.7259259,1878.392593,4297.940741,1435.451852,269.5185185,3298.688889,501.0518519,936.1851852,135,16.06558775,10.72905323,0.744315416,0.971223022,0.692307692,-0.609500913
+4435,27122.34375,989.79375,664.31875,1112.83125,23332.8875,781.7875,793.7,1692.54375,13689.94375,597.66875,1605.95625,1836.9,15773.375,1345.5125,3227.325,2919.7375,5720.08125,1353.59375,319.86875,2418.04375,12369.06875,475.075,117.1625,1410.69375,15073.41875,610.20625,527.21875,1136.9625,11640.3,1997.50625,415.88125,2833.4875,10133.725,759.4,295.39375,1183.3625,6688.675,1452.1125,441.075,1324.99375,4757.875,601.7875,168.28125,3287.9625,4207.20625,1338.46875,741.35,3345.4125,546.9125,934.69375,160,18.60961119,11.09771356,0.802729647,0.930232558,0.740740741,-1.461811503
+4436,28875.74708,1061.501946,530.4980545,1066.11284,25120.65759,760.2178988,815.4513619,1535.540856,14768.59533,612.3891051,1316.863813,1743.439689,17430.26848,1335.824903,1864.568093,3329.85214,6015.789883,1264.066148,285.2996109,2362.929961,13053.96109,389.4708171,111.3657588,913.8287938,16756.01946,1395.392996,117.2568093,1481.774319,12879.87938,1568.319066,462.6848249,2791.832685,11368,637.1089494,273.6809339,1208.918288,7681.805447,1292.027237,405.8793774,1314.385214,5480.058366,583.4319066,151.463035,1687.747082,5034.719844,1295.035019,811.9883268,3351.264591,592.7315175,940.9455253,257,23.75493504,14.4581887,0.793446984,0.924460432,0.594907407,-0.498997528
+4437,47539.19565,945.7173913,509,1104.108696,40860.43478,764.4130435,693.9782609,1693.978261,23252.13043,571.5869565,874.3043478,1703.782609,29332.43478,1349.630435,2987.195652,3176.043478,10505.1087,1354.369565,320.8913043,2372.521739,22501.06522,493.1956522,119.9782609,670.6304348,28908.5,553.7608696,148.5434783,3415.391304,22286.3913,1808.913043,518.1956522,2812.956522,19215.13043,712.0434783,310.3043478,1237.543478,12634.47826,1156.391304,452.0869565,1307.5,7699,625.5869565,169.7608696,1826.5,7523.217391,1409.130435,168.5217391,3269.108696,820.1521739,933.8043478,46,8.451682822,7.218573947,0.520110448,0.958333333,0.575,-0.047420203
+4438,24595.33491,819.4716981,643.8867925,1083.537736,21981.61792,661.004717,682.5801887,1687.764151,11038.7217,564,1578.273585,1767.882075,14664.04717,1195.042453,5880.273585,4239.716981,5436.334906,1226.481132,293.6698113,2492.792453,11233.06604,2240.504717,384.4009434,803.6698113,14410.00472,952.3820755,131.0471698,4436.632075,10754.43868,1708.608491,596.4669811,2801.773585,9139.509434,658.759434,263.8207547,1306.136792,5789.853774,1586.683962,392.1556604,1329.915094,3429.896226,662.9056604,156.8773585,6542.679245,3524.509434,1214.212264,713.1226415,3285.45283,879.8396226,937.3254717,212,19.58138915,14.94298979,0.646254392,0.876033058,0.623529412,0.042971579
+4439,21641.14815,736.1759259,573.4351852,1054.75,18588.69444,599.2222222,688.9351852,1507.351852,8911.305556,543.4722222,1969.935185,1775.740741,12176.17593,1081.953704,10979.61111,3295.425926,4539.111111,1146.638889,255.4444444,2440,9552.305556,341.0462963,865,1727.953704,12240.71296,709.1111111,112.7777778,970.8703704,9036.685185,2601.972222,640.8611111,2805.527778,7598.240741,573.287037,241.8148148,833.9259259,4720.888889,1232.722222,362.1944444,1336.861111,2738.222222,754.0277778,148.7592593,4122.027778,2810.861111,1093.564815,241.4907407,3142.925926,898.7685185,934.7685185,108,12.82927317,11.11183379,0.499816707,0.964285714,0.553846154,-1.40267304
+4440,34634.93304,1023.620536,719.2723214,1139.013393,26422.74554,638.9464286,770.4241071,1615.227679,11706.98661,514.09375,1038.888393,1736.732143,15656.72768,1156.34375,6971.754464,3054.933036,5973.361607,1190.674107,278.8526786,2391.553571,12617.74554,325.9285714,364.6160714,1019.830357,14996.29911,735.7857143,112.3526786,3826.205357,11211.38393,1584.991071,290.2544643,2803.705357,9660.790179,556.7946429,254.9375,984.1696429,4368.28125,1149.241071,382.25,1281.544643,3006.607143,642.3392857,151.3258929,2231.65625,2860.482143,1098.151786,198.0267857,3175.638393,277.8928571,938.5758929,224,22.01246531,13.11612308,0.803095894,0.953191489,0.65497076,-0.86466504
+4441,41732.23377,925.4935065,542.6623377,1119.61039,36716.7013,764.4675325,781.1818182,1698.636364,22017.24675,602.974026,1918.922078,1843.25974,25502.41558,1370.714286,2456.402597,3492.883117,9173.415584,1425.272727,357.1428571,2335.051948,20195.93506,449.5454545,116.5064935,1326.441558,24983.88312,592.2987013,157.012987,1802.961039,19461.02597,2009.792208,472.1948052,2803.974026,17142.50649,642.4935065,309.4025974,1285.194805,11454.66234,1480.649351,465.3376623,1332.493506,8170.350649,636.3116883,184.5064935,2099.844156,7303.207792,1448.649351,228.7922078,3316.337662,562.9090909,934.4415584,77,11.62633953,8.895777517,0.643863936,0.905882353,0.641666667,-1.293921406
+4442,34944.10448,953.8656716,526.5522388,1087.962687,29840.70896,731.0597015,955.7238806,1600.589552,17036.25373,587.619403,1824.835821,1986.141791,20775.96269,1260.649254,3125.149254,4048.246269,7485.671642,1258.410448,290.4328358,2303.940299,15234.08209,379.1044776,128.1641791,1475.686567,19943.17164,554.7910448,122.8283582,1514.708955,14871.37313,2198.171642,476.3507463,2798.30597,12833.26119,582.5671642,268.0447761,1194.925373,8738.835821,1557.067164,398.8507463,1304.276119,6155.447761,588.4253731,149.0447761,1584.074627,5649.104478,1287.283582,441.8358209,3293.828358,643.3059701,935.2910448,134,16.5599343,10.4434014,0.776073325,0.930555556,0.71657754,1.449557892
+4443,31661.9505,1025.425743,513.9009901,1056.782178,28137.87129,755.8019802,683.4653465,1602.257426,16307.78218,588.3168317,867.6039604,1713.742574,19546.9802,1318.118812,3134.188119,2856.891089,6861.267327,1265,291.8118812,2298.960396,14649.62376,387.5247525,136.3465347,673.4059406,18316.60396,456.4752475,161.2475248,2399.326733,14433.82178,1664.069307,498.950495,2819.306931,12592.34653,694.3762376,263.970297,1385.346535,8592.376238,1009.009901,398.7128713,1303.29703,6041.128713,598.1881188,148,2256.079208,5445.039604,1302.49505,1149.831683,3335.633663,687.2475248,935.7821782,101,15.40475539,8.810637959,0.820293549,0.90990991,0.612121212,1.159402096
+4444,30400.07368,949.0210526,482.4526316,1082.663158,27089.31579,812.2736842,633.9894737,1605.168421,14366.74737,593.9368421,1108.789474,1759.515789,17690.46316,1382.557895,1498.789474,3639.010526,6233.084211,1356.094737,321.8,2365.094737,13663.37895,423.4,710.0315789,1191.726316,17044.11579,862.7578947,349.6631579,1433.494737,13249.08421,1628.410526,607.2,2809.494737,11870.52632,649.9473684,301.2421053,1958,7617.168421,1293.947368,449.5578947,1328.715789,5216.326316,789.5263158,174.7263158,3510.873684,4721.484211,1434.694737,2379.863158,3203.284211,410.5157895,937.0315789,95,12.66811399,9.622560993,0.650403288,0.95,0.730769231,-0.157778447
+4445,28540.02162,921.6972973,740.0648649,1150.713514,25563.41081,746.3567568,828.0378378,1712.367568,14442.41081,586.6540541,587.1783784,1801.178378,17296,1365.091892,1190.702703,1635.778378,6377.92973,1411.989189,337.772973,2370.740541,13939.12432,464.6540541,291.6540541,517.2486486,17258.49189,541.4918919,131.0972973,1209.151351,13402.6,1518.691892,456.7513514,2807.891892,11947.97838,999.8486486,305.5783784,1480.097297,7853.897297,996.8162162,458.6108108,1343.859459,5534.378378,669.8918919,172.4810811,1451.210811,5170.416216,1436.854054,263.4432432,3275.881081,528.3891892,937.0378378,185,19.60892035,12.25607651,0.780604281,0.934343434,0.695488722,1.331720355
+4446,36943.97143,1094.6,645.2428571,1118.021429,33420.64286,705.5642857,507.3928571,1732.6,15556.32857,550.1,1244.307143,1737.914286,20225.41429,1269.828571,4568.65,3439.692857,7573.321429,1333.371429,312.6071429,2399.928571,15774.32143,381.45,695.2857143,641.7928571,19583.17143,586.2357143,128.8571429,3376.7,14944.6,2059.778571,376.9428571,2812.692857,13204,604.5428571,284.7857143,1103.414286,6807.057143,1080.692857,412.5714286,1304.521429,4543.771429,724.35,163.3357143,1866.035714,4232.614286,1279.121429,517.4428571,3291.864286,301.4428571,939.9857143,140,15.63494366,11.44209763,0.681488827,0.992907801,0.729166667,-0.435745835
+4447,28495.08523,958.4488636,500.0113636,1072.136364,25822.23295,747.4318182,492.8579545,1503.113636,13717.67045,589.0454545,431.2386364,1691.596591,16802.23295,1350.869318,1173.636364,2560.477273,6336.659091,1329.551136,319.7102273,2299.801136,14106.01136,411.5965909,397.8181818,455.0227273,17290.23864,470.2272727,127.1875,1528.420455,13284.10795,1499.255682,690.5681818,2814.471591,12508.73864,672.1306818,299.0227273,1801.039773,7869.227273,904.5056818,443.1818182,1331.073864,5307.005682,666.6079545,176.7329545,2812.931818,4959.880682,1531.977273,11649.22727,3205.897727,375.1818182,941.3068182,176,24.61470183,10.3962171,0.906429087,0.811059908,0.421052632,-0.886784109
+4448,23795.17808,998.1917808,600.1917808,1095.547945,23163.60274,787.1232877,601.4794521,1573.849315,11778.08219,604.0273973,608.1917808,1712.150685,14321.76712,1375.424658,955.1506849,1305,5530.849315,1470.90411,332.6849315,2342.821918,12126,473.0684932,143.3013699,701.3287671,15026.63014,509.3287671,206.3150685,1016.589041,11299.08219,1593.931507,413.4109589,2825.479452,10300.24658,691.4520548,301.9041096,1476.027397,6911.438356,974.1780822,474.3972603,1321.931507,4834.383562,616.4931507,177.1232877,2832.986301,4400.452055,1495.287671,1343.808219,3273.013699,401.6438356,937.1917808,73,11.43480745,9.263106043,0.586319697,0.811111111,0.663636364,0.078269686
+4449,28641.47321,928.4732143,541.9821429,1066.821429,26129.88393,701.1785714,775.7678571,1558.294643,14337.73214,545.125,1111.455357,1778.928571,17863.90179,1534.553571,3910.741071,4093.348214,6465.928571,1424.330357,291.7767857,2328.276786,13116.83036,689.7053571,596.375,1092.508929,16533.59821,851.0357143,119.6785714,1892.303571,12976.15179,1679.25,527.8482143,2800.633929,11241.625,931.1339286,265.6964286,1281.839286,7490.669643,1923.080357,400.5803571,1305.491071,5187,732.8839286,161.6160714,3146.267857,4799.473214,1293.401786,211.2410714,3286.5625,744.5178571,938.9375,112,13.77107598,10.64377114,0.634518426,0.888888889,0.662721893,0.394453253
+4450,31743.38462,819.1384615,491.8923077,1091.353846,27866.09231,693.4153846,651.5846154,1605.615385,16375.04615,530.4615385,601.0769231,1750.753846,20211.66154,1475.646154,3812.2,3782.323077,7187.984615,1450.892308,302.8923077,2504.507692,15074.06154,384.0923077,737.2461538,804.2923077,18969.46154,520.7538462,118.9692308,2868.046154,15019.26154,1656.846154,553.8,2793.492308,13016.84615,602.2153846,273.4615385,1430.184615,8603.923077,983.2307692,398.4615385,1297.246154,5809.692308,810.9692308,159.9692308,3794.123077,5664.446154,1314.476923,227.8923077,3207.461538,754.3692308,937.6615385,65,10.99833896,7.722546446,0.712023431,0.970149254,0.656565657,1.019845528
+4451,28063.80952,1136.626984,635.1031746,1075.690476,24992.09524,753.8730159,495,1559.595238,12591.24603,616.3730159,766.0079365,1725.142857,16431.1746,1317.126984,3478.246032,2698.619048,5966.515873,1295.626984,298.5555556,2395.142857,13130.5,375.2539683,688.4126984,686.7460317,16085.80159,520.3333333,120.0714286,2812.595238,12533.98413,1678.079365,418.7301587,2811.444444,11404.5873,578.3650794,282.3730159,1271.809524,6239.904762,933.2301587,417.5555556,1319.103175,4220.039683,744.3174603,162.9761905,3042.992063,3974.730159,1266.412698,1903.936508,3299.269841,313.5634921,940.7936508,126,14.80254259,11.15600346,0.657270744,0.954545455,0.605769231,-0.247951007
+4452,26602.32353,916.7941176,497.8014706,1085.375,23594.13971,718.8970588,658.6102941,1578.573529,12469.73529,572.9632353,1786.242647,1747.786765,15582.88235,1350.580882,1726,1916.213235,5926.602941,1326.617647,319.8970588,2348.080882,13448.08088,416.0588235,223.1176471,1000.419118,16204.06618,506.4558824,127.7205882,937.3235294,12731.15441,1546.242647,439.2573529,2834.169118,11826.04412,665.6323529,296.0073529,1450.933824,6953.683824,1418.875,447.125,1325.985294,4806.948529,656.2867647,179.6029412,2764.477941,4392.514706,1597.610294,18309.16176,3235.764706,343.9117647,941.5147059,136,18.6376807,9.751772443,0.852192208,0.877419355,0.566666667,0.587418069
+4453,34533.5,953.2826087,499.6521739,1104.195652,30201.69565,767.4130435,580.9347826,1638.347826,16619.36957,588.7391304,464.2391304,1682.043478,20395.41304,1383.282609,677.326087,1296.717391,7545.652174,1429.23913,343.7173913,2297.76087,16061.58696,446.7608696,136.6086957,478.5869565,19663.73913,503.826087,134.9347826,1069.217391,15703.86957,1514.5,462.826087,2840.5,14262.73913,713.1304348,328.6521739,1636.76087,9083.73913,885.1521739,475.1956522,1327.065217,6129.347826,625,174.8695652,1670.673913,5557.804348,1482.913043,2191.065217,3188.978261,392.8478261,937.2826087,46,9.485779162,6.475864257,0.730706384,0.93877551,0.575,1.133633817
+4454,35836.42437,976.4789916,543.5378151,1102.836134,31913.63866,788.6806723,898.2394958,1638.571429,17384.20588,624.3613445,1520.189076,1766.235294,20523.9916,1388.928571,1853.827731,3313.848739,7650.306723,1415.252101,337.8445378,2500.315126,16425.76471,613.9957983,395.7857143,2317.172269,20646.86975,725.512605,138.6470588,1136.079832,15921.13445,1830.57563,507.3109244,2817.642857,14230.23529,747.8403361,308.5168067,1610.197479,9182.428571,2173.663866,457.6596639,1332.088235,6208.978992,764.907563,175.2394958,2802.844538,5751.554622,1464.617647,2581.340336,3288.647059,429.987395,941.0546218,238,18.86058538,17.00596454,0.43243138,0.878228782,0.62962963,-1.550743678
+4455,28009.424,812.456,610.352,1071.768,18537.064,570.576,831.512,1474.208,9261.608,595.824,1668.872,1724.088,12603.488,1086.608,7851.344,4047.968,4813.632,1171.52,264.504,2793.096,9866.84,379.928,611.224,1958.656,12506.64,1873.912,112.72,2507.272,9609.064,2186.56,506.712,2774.064,8173.248,566.872,232.76,999.096,5020.512,1840.224,365.128,1314.208,2883.424,698.576,144.432,4781.032,3067.976,1096.976,363.864,3190.384,891.096,942.136,125,14.7847026,11.48116618,0.630046846,0.939849624,0.641025641,0.582306094
+4456,22500.16667,943.3148148,642.4537037,1058.740741,19623.06481,664.6296296,854.5185185,1475.064815,10841.2963,608.037037,797.4166667,1716.740741,13406.16667,1220.564815,2396.861111,1922.981481,4996.259259,1192.101852,268.0462963,2993.925926,10069.0463,356.3055556,253.7592593,634.1018519,12883.38889,457.537037,112.3240741,1390.592593,9846.666667,1676.861111,507.2037037,2854.740741,8573.490741,910.462963,246.9444444,1403.777778,6082.962963,878.6388889,386.3425926,1373.675926,4197.138889,612.4537037,147.9814815,2770.712963,3857.240741,1303.277778,6361.981481,3314.314815,675.6574074,940.2777778,108,12.24456738,11.68707477,0.298306257,0.931034483,0.642857143,1.202061701
+4457,35772.84906,909.9622642,542.8301887,1078,31684.09434,722.7735849,693.3396226,1623.433962,17629.79245,555.6603774,667.6415094,1726.358491,22706.28302,1290.886792,4086.056604,3979.075472,8112.509434,1277.528302,310.0754717,2372.716981,17477.18868,431.8301887,130.2075472,699.9622642,22788.9434,799.3018868,129.3396226,3565.622642,17274.11321,1511.716981,514.245283,2782.679245,14930.62264,600.2641509,279.7924528,1400.754717,9668.90566,999.490566,416.8679245,1302.603774,6264.849057,615.9811321,165.509434,2795.735849,6005.056604,1325.698113,456.1698113,3301.377358,814.4150943,938.6603774,53,10.16488404,6.917106887,0.732756916,0.963636364,0.535353535,1.025762651
+4458,35280.15966,840.8571429,531.4285714,1093.613445,12011.51261,451.1428571,398.2184874,1210.310924,5677.806723,354.3697479,895.1092437,1623.798319,7993.142857,870.1344538,3262.436975,1430.563025,3128.462185,949.697479,197.4369748,2235.201681,6164.428571,249.6134454,95.80672269,900.6722689,7593.823529,613.8151261,342.9663866,954.4285714,5779.512605,1392.310924,363.2941176,2786.890756,4936.394958,453.2773109,194.0336134,697.3865546,2895.268908,757.7226891,314.6638655,1245.705882,1664.327731,484.9327731,130.0336134,1402.294118,1703.983193,875.302521,165.3193277,2986.647059,905.9159664,942.1344538,119,14.28299496,10.97424985,0.640037412,0.983471074,0.653846154,-0.567222618
+4459,34248.42593,885.1111111,695.7592593,1121.314815,12759.36111,550.1574074,550.2962963,1492.555556,5473.935185,437.6759259,904.9259259,1707.694444,8426.361111,1102.157407,3616.972222,2448.703704,3242.740741,1070.916667,244.25,2408.601852,6470.175926,347.4259259,101.4074074,917.5,8089.601852,924.287037,106.4259259,3168.861111,5838.12963,1400.287037,358.3425926,2775.574074,4881.037037,750.6111111,232.5740741,1024.361111,2595.435185,1175.083333,342.9351852,1285.37963,1482.694444,531.2962963,139.8981481,2668.203704,1592.37037,1018.935185,916.2685185,3086.175926,959.9444444,939.1111111,108,14.01969414,10.22421615,0.684220424,0.981818182,0.701298701,1.130018755
+4460,34342.1875,1059.8125,500.65625,1094.645833,30615.52083,803.34375,742.3020833,1593.510417,16181.08333,624.15625,922.0208333,1761.270833,20183.28125,1415.677083,1470.135417,1291.6875,7114.09375,1360.802083,328.3229167,2352.28125,16113.76042,421.9895833,185.1770833,761.875,19870.14583,472.09375,131.4895833,923.0729167,15465,1715.6875,420.7708333,2815.354167,14218.39583,897.2395833,310.78125,1399.072917,8484.572917,1210.291667,449.3541667,1314.822917,5689.09375,632.2395833,173.7604167,2540.510417,5160.260417,1661.03125,26175.34375,3245.166667,353.9583333,940.9375,96,13.10555539,9.582317397,0.682201153,0.932038835,0.615384615,0.796041324
+4461,34649.29054,974.5,499.7297297,1077.459459,32978.13514,772.1824324,584,1521.804054,17670.37838,613.1959459,685.7702703,1696.871622,21508.76351,1410.689189,1283.594595,2884.418919,7978.675676,1403.47973,342.9527027,2341.297297,17927.2027,426.5337838,416.5405405,505.4594595,21652.76351,662.5202703,138.3986486,1447.709459,17050.34459,1577.108108,576.3513514,2814.547297,15961.57432,629.5,313.9932432,1598,10072.69595,1133.047297,463.777027,1333.331081,6747.898649,700.027027,173.1351351,2551.75,6066.993243,1474.506757,1486.324324,3224.209459,385.7027027,944.7635135,148,14.79798843,13.18505551,0.453996963,0.948717949,0.660714286,-0.449565686
+4462,34638.40741,998.5407407,582.0444444,1098.288889,30342.63704,773.6888889,822.6148148,1595.192593,18335.45185,616.2666667,1233.807407,1816.740741,20975.11852,1385.407407,2138.585185,3651.355556,7454.059259,1360.881481,334.5925926,2433.851852,16257.62963,444.8888889,132.7333333,950.7703704,20724.42222,631.637037,256.437037,2290.022222,15990.7037,1987.511111,560.7111111,2812.6,14076.88889,657.4444444,306.1111111,1534.711111,9351.118519,1362.8,443.6222222,1324.022222,6587.42963,626.0222222,175.1851852,2547.37037,5806.674074,1400.644444,815.1185185,3349.118519,571.6296296,944.637037,135,16.5268797,11.26171624,0.731894301,0.84375,0.567226891,0.381806791
+4463,23275.93043,786.7826087,496.7913043,1039.373913,20998.4,632.2173913,538.2,1509.043478,11589.38261,611.7043478,574.9304348,1726.113043,15021.46957,1188.695652,2777.704348,3657.443478,5649.721739,1321.156522,305.8086957,2285.704348,11077.55652,354.6608696,447.2956522,644.1391304,14430.30435,583.6608696,115.1913043,1859.678261,10981.69565,1464.156522,614.8434783,2788.06087,9703.843478,642.9304348,257.2782609,1584.617391,6746.678261,938.1304348,383.9565217,1308.756522,4734.921739,720.9391304,149.0956522,2910.095652,4351.73913,1265.93913,528.3652174,3159.634783,698.3217391,942.2173913,115,13.80141365,10.67849801,0.633521673,0.950413223,0.68452381,-0.374432555
+4464,30514.94203,918.5724638,557.4855072,1079.26087,26708.55072,716.1956522,686.0507246,1617.188406,15018.36232,746.0942029,1575.210145,1787.847826,18616.34783,1285.34058,2393.978261,2745.268116,6799.427536,1299.34058,348.9782609,2344.811594,13892.46377,382.1086957,349.3043478,1442.181159,17761.55797,1079.057971,365.3043478,1321,13782.37681,1881.536232,453.7753623,2791.884058,12124.77536,752.9057971,276.442029,1289.637681,8265.130435,1641.543478,407.826087,1325.92029,5606.181159,680.2173913,157.3333333,2319.202899,5142.731884,1357.137681,525.0144928,3238.746377,711.1304348,943.5434783,138,17.08577096,11.52716021,0.738124679,0.867924528,0.613333333,0.685377968
+4465,30099.23158,881.4842105,518.5052632,1067.515789,26462,695.9368421,896.5473684,1542.210526,15324.87368,551.9368421,1031.926316,1817.715789,18368.22105,1275.621053,3855.926316,3557.052632,6664.947368,1353.042105,282.8526316,3412.947368,13821.90526,366.0421053,409.9263158,1481.494737,17157.84211,544.7578947,159.6210526,2213.094737,13841.91579,1899.747368,481.3368421,2782.631579,11827.23158,561.7789474,256.6105263,1155.536842,7854.8,1116.273684,394.1263158,1295.894737,5149.126316,700.0736842,153.6947368,3961.852632,4999.094737,1235.336842,286.4,3308.463158,767.1052632,940.9052632,95,11.68309449,10.48433397,0.441230966,0.979381443,0.664335664,1.252101349
+4466,33629.2963,902.3518519,562.1111111,1117.851852,27268.33333,675.2962963,497.1851852,1687.388889,14123.92593,522.3703704,698.9814815,1760.203704,18194.72222,1201.074074,5226.925926,3302.092593,7103.388889,1287.037037,303.2777778,2320.222222,14474.09259,403.8703704,133.8888889,669.2962963,18032.16667,459.7592593,127.2037037,4295.962963,13936.92593,1815.5,481.4814815,2776.537037,12036.72222,587.5185185,270.1296296,1287.092593,7546.425926,1086.203704,391.6481481,1299.722222,4589.407407,598.962963,149.7962963,2293.62963,4562.185185,1269.240741,1575.148148,3285.907407,859.2037037,940.1111111,54,10.76259293,6.647858925,0.78642804,0.915254237,0.675,-0.200650722
+4467,21625.78378,962.8716216,676.4391892,1100.074324,19408.88514,733.0405405,716.3513514,1585.486486,10989.76351,584.3513514,827.0337838,1767.351351,13077.81081,1328.22973,1911.155405,1917.013514,4784.540541,1353.256757,306.6418919,2327.128378,10511.92568,1019.222973,169.9932432,639.0810811,13157.41216,679.5878378,176.4121622,1102.263514,10256.59459,1632.331081,418.7837838,2814.108108,9259.702703,815.7972973,286.9324324,1394.006757,5974.513514,1129.682432,426.9662162,1323.567568,4075.540541,609.1891892,167.5675676,2425.141892,3854.837838,1368.195946,1808.601351,3245.695946,452.1756757,943.7567568,148,15.54013366,12.53250886,0.591287539,0.967320261,0.660714286,0.396699975
+4468,25231.98246,964.6929825,1035.885965,1191.403509,22812.02632,755.6491228,926.4736842,1789.482456,12965.0614,665.3596491,667.4122807,1844.403509,15869.99123,1392.710526,1732.45614,1765.412281,5660.859649,1437.815789,335.6929825,2526.903509,12910.68421,511.5877193,699.9210526,656.5350877,15901.39474,518.8684211,130.745614,1526.850877,12373.85088,1669.324561,429.5964912,2831.859649,10826.96491,823.1315789,306.9824561,1559.789474,7299.798246,1020.114035,468.3859649,1414.27193,5096.649123,756.5614035,175.1842105,2473.157895,4780.675439,1449.72807,368.7894737,3376.245614,509.8859649,942.9122807,114,12.45427657,11.95012261,0.281641822,0.926829268,0.626373626,-0.411560059
+4469,37408.10526,1000.565789,519.3421053,1101.184211,30628.57895,727.3157895,687.3552632,1611.039474,17446.01316,584.5394737,634.6578947,1735.842105,21705.71053,1541.078947,3421.447368,2921.184211,7540.355263,1296.552632,294.2105263,2398.828947,15630.36842,377.7105263,133.4736842,839.8947368,20339.39474,485.2894737,121.6973684,2586.355263,15907,1433.171053,461.9605263,2767.697368,13561.13158,589.0394737,275.7631579,1351.065789,9126.605263,981.7894737,394.4342105,1310.618421,6366.131579,599.8552632,159.3157895,1583.881579,5947.763158,1277.355263,176.1578947,3349.736842,734.2105263,941.7894737,76,12.64255833,8.510678406,0.739481468,0.853932584,0.584615385,-1.314981415
+4470,25888.55932,838.0677966,524.3276836,1073.067797,23240.68927,711.3615819,673.5536723,1598.248588,12497.09605,531.1242938,1278.20339,1786.576271,15896.58192,1267.485876,3615.853107,3738.757062,5938.310734,1259.214689,308.8305085,2352.129944,12195.73446,395.3107345,322.4519774,891.1073446,15866.72881,535.9265537,246.5367232,2741.971751,12041.33898,1861.858757,567.5988701,2787.412429,10447.27119,628.7514124,279.3050847,1553.79661,6785.644068,1262.813559,402.6892655,1307.723164,4432.20339,682.7175141,164.8587571,4560.836158,4207.141243,1337.107345,2301.80226,3193.045198,803.5819209,943.5988701,177,21.27417846,11.39649127,0.844410947,0.880597015,0.618881119,-1.406308775
+4471,28160.42857,829.8195489,618.112782,1107.864662,15615.64662,494.8947368,301.4210526,1356.804511,6804.56391,414.4285714,369.1203008,1634.518797,9833.556391,953.8195489,3410.932331,1684.240602,3804.300752,979.1428571,221.7293233,2208.511278,7657.834586,283.443609,276.1428571,533.1879699,9133.601504,351.8796992,98.94736842,2138.586466,6765.503759,1417.669173,372.0300752,2768.43609,5690.12782,490.4210526,215.7218045,809.8421053,3004.43609,751.0526316,322.8947368,1256.030075,1655.902256,570.9699248,130.9849624,1403.037594,1722.496241,927.7819549,210.2406015,2998.669173,951.1278195,944.7894737,133,14.78885373,12.07945544,0.576928616,0.97080292,0.59375,1.225824661
+4472,37683.88235,953.4117647,546.9705882,1071.970588,32432.89706,723.0588235,936.6176471,1629.235294,18684.97059,877.1029412,1743.764706,1778.955882,22942.47059,1447.205882,3248.102941,3976.117647,8367.441176,1383.588235,318.6176471,2565.102941,16838.01471,394.5882353,396.0294118,1548.25,22038.73529,2355.75,126.9852941,1452.897059,17092.05882,2033.441176,436.8382353,2795.867647,15141.82353,768.3235294,288.5,1195.161765,10144.07353,2342.132353,416.8823529,1365.794118,6886.411765,713.8676471,154.2941176,3277.588235,6471.073529,1374.117647,263.6029412,3280.441176,720.2352941,941.3823529,68,11.11565788,8.390095766,0.655955289,0.957746479,0.686868687,-1.508150604
+4473,22366.65,1118.25,568.725,1057.425,21233.85,751.475,654.65,1496.65,10152.7,588.275,1366.1,1783.225,13490.075,1233.125,3130.75,3674.225,4807.95,1187.025,265.475,2331.425,9228.625,407.575,116.775,1402.225,11749.825,436.1,130.625,1898.1,8539.125,1950.2,466,2786.475,7356.975,566.5,241.475,1078.425,4824.175,1278.1,373.8,1305.45,3263.15,541.45,148.325,1668.275,3030.15,1111.75,203.175,3395.075,822.125,941.525,40,8.551409268,6.181698758,0.690966738,0.930232558,0.625,-0.799148278
+4474,37862.37209,883.8139535,665.5930233,1119.244186,24651.88372,621.1511628,445.0697674,1495.767442,13081.5,553.9418605,416.3023256,1700.523256,16972.97674,1142.77907,3170.697674,1992.906977,6435.488372,1245.523256,289,2282.116279,13570.12791,388.3023256,205.4883721,469.9418605,17095.36047,413.3023256,113.2906977,2626.651163,13231.37209,1445.77907,444.4069767,2800.383721,11330.75581,569.9186047,254.5116279,1087.104651,7219.94186,875.4302326,383.3488372,1290.05814,4346.883721,601.9069767,154.1162791,1359.093023,4433.290698,1215.139535,997.627907,3136.313953,866.4186047,943.1744186,86,12.6825897,9.298717241,0.680026451,0.87755102,0.511904762,-0.866475923
+4475,42364.0122,889.9878049,512.597561,1097.743902,39100.92683,757.0121951,886.5853659,1644.073171,21333.06098,593.0243902,2256.036585,1825.207317,25884.92683,1337.792683,2592.463415,3541.414634,9697.426829,1413.939024,343.3292683,2373.695122,21529.19512,430.1829268,333.2073171,1706.304878,27120.10976,1063.987805,159.1097561,1380.731707,21066.85366,2071.02439,546.2926829,2811.158537,19073.73171,645.5121951,326.3658537,1797.731707,12411.7561,2091.902439,468.4756098,1320.902439,8301.207317,742.2682927,174.8292683,2886.743902,7776.439024,1480.573171,524.902439,3238.878049,417.7195122,944.5365854,82,10.72602189,9.850792749,0.395650098,0.987951807,0.67768595,0.38826119
+4476,23685.94017,1045.666667,752,1155.880342,21325.52991,823.8376068,631.3333333,1728.25641,12068.75214,780.5042735,551.5042735,1775.145299,14518.39316,1473.982906,1125.717949,1593.247863,5200.376068,1444.692308,362.0854701,2337.290598,11525.74359,1224.65812,1173.820513,516.9059829,13982.35043,508.4957265,137.6495726,1198.957265,11022.82051,1704.521368,429.4273504,2842.786325,9980.871795,2465.897436,326.4444444,1599.871795,6553.333333,948.1111111,476.2649573,1426.034188,4517.324786,926.1282051,188.7264957,4245.692308,4197.854701,1493.735043,348.8632479,3290.615385,477.4871795,943.9145299,117,13.61421796,11.25934605,0.562160017,0.921259843,0.75974026,-1.554151119
+4477,26646.44762,881.5904762,575.4571429,1092.790476,24018.20952,726.1714286,735.5047619,1602.647619,14182.71429,571.6857143,1617.92381,1800.819048,16233.21905,1302.866667,3566.647619,4473.52381,6117.247619,1356.371429,317.352381,2381.161905,13023.89524,454.9142857,203.7142857,1272.485714,16188.52381,1173,125.6952381,2519.714286,12336.01905,1512.828571,484.8,2807.009524,10886.61905,637.0857143,290.1904762,1613.771429,7347.742857,1909.790476,432.3809524,1344.514286,5233.92381,632.2666667,170.5619048,4291.171429,4573.228571,1366.533333,780.1714286,3287.009524,560.5428571,944.3904762,105,12.03532858,11.2629197,0.352474182,0.945945946,0.729166667,1.140883405
+4478,24983.67593,877.1296296,816.5,1148.638889,22180.38889,713.3611111,844.7592593,1669.194444,12872.84259,554.8703704,1019.62963,1788.240741,15278.5463,1281.444444,1233.62037,2900.231481,5512.055556,1413.074074,318.5925926,2456.351852,12585.81481,449.5740741,164.3796296,968.5648148,15322.68519,931.712963,136.1481481,1255.333333,12055.62963,1462.87963,430.8333333,2802.472222,10840.62963,755.6296296,297.0092593,1532.101852,7108.046296,1133.564815,444.3518519,1335.037037,4914.981481,622.9259259,164.7222222,2123.981481,4554.731481,1370.768519,254.0740741,3229.916667,521.3981481,946.4722222,108,12.74426464,10.98474631,0.507016316,0.931034483,0.642857143,0.304873116
+4479,22034.58156,811.8085106,593.177305,1106.163121,19598.24113,665.4113475,717.5602837,1598.06383,11420.73759,535.7021277,2186.12766,1803.64539,13346.56028,1208.212766,3355.219858,3328.070922,5055.425532,1290.234043,300.6808511,2402.085106,10720.09929,1773.780142,136.5106383,834.7304965,13225.24823,513.9503546,124.751773,2021.659574,10232.86525,1642.453901,481.6737589,2826.049645,8951.617021,651.4397163,265.5460993,1424.184397,6000.014184,2155.22695,413.8014184,1322.680851,4229.758865,612.9716312,157.9078014,4591.276596,3814.014184,1285.148936,364.5177305,3287.099291,548.4184397,947.1631206,141,14.46896587,12.69681294,0.47953928,0.94,0.671428571,0.227906303
+4480,30244.75936,880.7112299,529.315508,1069.823529,26809.06952,693.4331551,839.5454545,1599.540107,15287.63102,621.7647059,1481.315508,1774.010695,18452.1123,1264.358289,3451.262032,3875.224599,7006.294118,1265.326203,290.4973262,2449.347594,14007.59893,514.9037433,244.6470588,1348.625668,17825.24599,1037.572193,116.828877,2169.074866,13541.8877,1849.871658,474.8235294,2786.71123,11828.68449,625.1283422,266.2459893,1265.010695,8041.363636,1633.117647,394.8823529,1302.57754,5672.331551,653.0106952,153.6898396,2458.508021,5102.315508,1330.368984,845.8342246,3245.721925,645.5294118,946.7165775,187,21.27191362,11.37419769,0.84503882,0.954081633,0.703007519,1.158665529
+4481,27157.91176,974.7058824,555.3235294,1059.990196,24061.78431,649.3431373,462.8137255,1483.921569,13740.97059,548.4607843,435.6862745,1718,17195.02941,1225.480392,2206.303922,1936.970588,6363.068627,1289.901961,289.2745098,2323.147059,13144.71569,360.8431373,297.3333333,487.7058824,16430.2451,407.7058824,115.1862745,1751.647059,12906.18627,1513.54902,590.4607843,2803.401961,11308.48039,597.0392157,268.8529412,1187.009804,7842.254902,848.5098039,396.745098,1334.882353,5437.627451,634.4901961,151.1862745,3402.215686,4910.578431,1290.22549,969.245098,3184.813725,685.8921569,945.6078431,102,13.1271902,10.38526516,0.61165285,0.879310345,0.662337662,-1.424395049
+4482,16674.49038,896.8942308,538.7980769,1063.413462,15221.29808,690.2884615,459.1538462,1498.846154,7480.721154,576.1153846,544.1826923,1710.009615,9571.413462,1287.548077,2806.913462,1942.759615,3576.788462,1268.355769,310.2788462,2268.913462,7794.153846,1226.692308,1228.298077,476.0384615,9237.057692,429.5769231,122.9038462,1176.701923,7218.048077,1832.019231,662.3365385,2809.942308,6631.5,690.1057692,271.1730769,1064.576923,3675.442308,998.4326923,411.9903846,1321.086538,2519.057692,883.4903846,174.0288462,3428.528846,2346.653846,1402.067308,10434.18269,3121.884615,321.5384615,946.4423077,104,15.04570594,9.081458398,0.797293827,0.936936937,0.619047619,-0.864950737
+4483,38553.93233,1051.654135,540.7669173,1114.338346,35260.38346,845.8345865,699.3684211,1651.676692,19130.33835,638.7067669,763.4586466,1784.699248,23136.1203,1412.804511,2685.37594,2987.676692,8349.43609,1427.879699,345.1278195,2330.112782,18789.06767,435.6165414,304.7443609,858.7443609,22857.15789,567.5037594,276.5789474,2387.887218,18145.30827,1667.503759,461.6616541,2828.045113,16388.01504,642.5714286,317.1578947,1670.639098,10608.86466,1066.12782,461.1278195,1312.428571,7070.81203,686.887218,172.5112782,4492.007519,6255.729323,1461.729323,843.2030075,3331.278195,401.6090226,946.3909774,133,22.93708132,8.67839055,0.925660017,0.773255814,0.604545455,1.455470666
+4484,35351.17995,894.059126,540.8046272,1085.758355,31358.08997,711.81491,968.4061697,1615.452442,18467.17224,553.8046272,1633.061697,1797.269923,21393.88946,1282.730077,3598.377892,3914.167095,7995.673522,1311.141388,295.3316195,2366.856041,16251.53985,430.8843188,130.1362468,1542.290488,20676.39589,1055.043702,117.6478149,1961.115681,15817.05398,1845.899743,457.059126,2793.087404,13905.12082,839.933162,269.840617,1302.195373,9259.467866,2553.508997,399.3419023,1304.069409,6668.005141,624.840617,154.6940874,3120.118252,5913.14653,1319.437018,193.1336761,3294.267352,616.2210797,951.966581,389,28.2517293,18.76635685,0.747505912,0.894252874,0.623397436,-0.535651747
+4485,15402.37908,807.1503268,445.869281,1061.69281,14383.81699,624.7189542,573.8496732,1498.339869,7137.052288,511.4248366,479.1372549,1733.921569,9004.496732,1191.039216,1356.875817,941.5882353,3503.457516,1196.562092,278.1176471,2265.359477,7834.261438,354.6928105,249.7647059,491.4901961,9326.477124,426.0326797,117.8104575,1033.575163,7414.960784,1379.490196,348.9738562,2832.431373,6813.666667,639.5228758,261.1111111,1323.339869,3961.424837,780.6601307,399.2091503,1327.104575,2734.751634,705.7843137,161.869281,3302.111111,2574.150327,1430.882353,8914.464052,3111.235294,335.2156863,949.0196078,153,14.14901961,13.87323063,0.196477855,0.95625,0.68,-0.365105933
+4486,21668.32889,874.9288889,677.72,1099.466667,19923.49333,699.6133333,638.8533333,1559.097778,11142.46222,587.4888889,800.64,1722.155556,13256.97778,1282.884444,1024.542222,1771.564444,4938.497778,1332.555556,313.1244444,2383.951111,10730.54667,433.8088889,542.1688889,682.5866667,13373.28889,478.2977778,148.8755556,1103.6,10312.74222,1571.6,436.2488889,2808.168889,9372.106667,714.7333333,281.0933333,1547.4,6068.244444,1176.244444,435.1911111,1350.995556,4097.551111,700.8977778,168.1022222,2806.426667,3902.2,1390.977778,700.4355556,3238.377778,462.2844444,951.04,225,23.59083371,12.8672359,0.838153966,0.903614458,0.5625,-0.748729081
+4487,39311.69124,887.9953917,497.797235,1092.041475,35120.14747,733,918.9585253,1662.354839,20514.97235,564.2903226,1741.926267,1846.875576,24201.57604,1281.723502,3143.35023,3959.797235,8967.552995,1299.414747,305.0184332,2755.875576,18706.92627,411.0092166,197.1797235,1441.087558,23446.1106,547.6175115,375.7557604,1472.294931,18041,2202.861751,524.359447,2809.792627,15687.4977,599.6129032,277.2626728,1166.626728,10689.57143,1388.506912,408.5115207,1303.557604,7378.829493,651.2580645,159.7419355,2528.990783,6741.460829,1369.741935,1134.686636,3248.442396,662.5990783,950.6036866,217,20.38094327,15.17797819,0.6673835,0.818867925,0.601108033,-0.621092857
+4488,28419.31507,989.8219178,548.0273973,1046.178082,24246.20548,711.5479452,629.1780822,1487.219178,14283.86301,854.109589,1405.90411,1783.69863,17846.65753,1492.356164,2708.917808,2816.191781,6420.547945,1290.205479,305.5890411,2315.69863,13418.54795,370.7945205,325.2328767,1383.39726,16978.45205,782.4657534,118.3835616,1468.09589,13574.23288,2108.767123,422.4246575,2814.712329,11755,607.6986301,271.2876712,1168.986301,7980.424658,1491.958904,403.7534247,1340.328767,5500.767123,661.5342466,160.3013699,1938.328767,5182.657534,1273.479452,202.8630137,3420.383562,725.3561644,948.2328767,73,10.45692789,9.373627585,0.443238788,0.9125,0.675925926,-0.199674771
+4489,29737.275,1031.6125,762.4875,1093.9625,26963.925,762.2625,861.1,1615.875,15280.7375,597.95,1703.3,1776.0625,18189.3125,1373.5,3486.575,2988.2375,6468.675,1311.45,313.55,2379.5125,13398.1375,422.2375,105.625,1713.0125,16948.8625,858.0625,124.6875,1152.95,13056.0375,2146.225,439.6625,2793,11599.7875,614.3625,280.8125,1072.2875,7808.2125,1686.2,418.45,1319.9625,5421.4375,596.525,162.6625,1293.45,5065.8375,1408.225,546.9,3290.325,602.3,948.6875,80,11.76994007,8.959130017,0.648531997,0.963855422,0.606060606,-0.680999256
+4490,34212.97222,821.2777778,506.8194444,1077.666667,31021.15278,694.6527778,732.9444444,1603.138889,17636.52778,521.1111111,945.6527778,1786.861111,21477.79167,1568.930556,2728.819444,3946.027778,7709.902778,1319.055556,296.8611111,2403.138889,16240.81944,647.625,145.2083333,1236.125,20656.91667,620.8888889,130.4444444,2228.847222,16217.31944,1818.277778,571.75,2792.458333,14034.76389,790.9305556,262.4027778,1319.777778,9242.041667,1149.111111,409.4861111,1293.041667,6155.416667,622.6666667,157.7083333,3833.333333,5841.041667,1307.986111,270.7222222,3285.736111,752,946.625,72,12.60795122,7.796766387,0.785862916,0.935064935,0.553846154,-1.066017514
+4491,34644.5,863.2777778,481.4722222,1098.125,30774.97222,710.7638889,884.7361111,1614.361111,17852.375,543.8055556,1314.902778,1918.527778,21273.84722,1425.472222,3719.541667,3243.805556,7794.416667,1283.597222,300.5416667,2510.194444,16216.80556,392.4166667,125.4444444,1807.041667,20231.375,589.2222222,331.6666667,1777.694444,16240.48611,1808.305556,457.375,2787.152778,14153.05556,575.4305556,270.2222222,1151.569444,9292.694444,959.3611111,410.5416667,1303.694444,5996.375,607.0972222,155.0416667,2452.402778,5795.013889,1287.847222,528.25,3341.875,762.0416667,948.5555556,72,11.89872866,8.021414825,0.738603137,0.923076923,0.595041322,0.68561497
+4492,24751.60909,888.3636364,515.1454545,1080.181818,21544.53636,705.7181818,949.2181818,1651.790909,12349.30909,547.4454545,1287.027273,1802.181818,15091.8,1281.036364,4866.654545,3387.745455,5707.018182,1258.436364,299.6454545,2520.736364,11446.1,377.7818182,595.6090909,1785.845455,14597.71818,506.7818182,540.4636364,2366.654545,11662.57273,2342.909091,520.2636364,2788.490909,10119.75455,590.9090909,274.1363636,1148.2,6713.027273,1234.645455,399.8363636,1335.509091,4415.836364,858.7727273,162.2363636,2947.254545,4271.563636,1299.254545,604.3363636,3252.063636,773.6363636,949.5909091,110,13.15748167,10.89353505,0.560824578,0.894308943,0.650887574,-0.684354772
+4493,23255.32911,871.2151899,645.2405063,1095.037975,21290.83544,695.1265823,669.9240506,1529.43038,11311.83544,542.9493671,830.4050633,1751.139241,13689.21519,1284.64557,1401.56962,3391.936709,5293.746835,1297.088608,308.0126582,2357.316456,11289.8481,3981.417722,331.8481013,1476.898734,14287.50633,572.7468354,125.1392405,1487.316456,11010.13924,1680.746835,669.7088608,2814.56962,9955.670886,698.0632911,281.443038,1814.164557,6484.303797,1986.379747,428.3417722,1324.582278,4282.075949,698.9240506,170.7594937,3657.291139,4077.481013,1393.21519,1748.481013,3226.405063,436.8227848,950.5443038,79,14.86465924,7.258459346,0.872674093,0.918604651,0.467455621,-0.778130658
+4494,28980.17323,890.5275591,574.2362205,1107.448819,25233.80315,715.9606299,728.5748031,1635.165354,14434.27559,573.496063,998.2362205,1783.614173,17121.6378,1291.086614,2804.07874,3066.275591,6183.488189,1329.771654,322.2677165,2388.188976,13600.27559,429.7795276,391.8740157,647.0629921,17084.05512,569.9527559,138.6062992,3043.165354,12986.65354,1604.015748,455.1102362,2810.629921,11517.92913,708.1023622,345.8110236,1592.92126,7539.456693,992.1889764,441.9212598,1337,5255.992126,687.1338583,167.0944882,3765.149606,4837.433071,1361,400.7795276,3275.771654,531.6377953,950.2992126,127,17.86582704,9.433834457,0.849220782,0.927007299,0.564444444,-0.771907848
+4495,37815.17355,1020.140496,536.0743802,1081.545455,34139.84298,730.9917355,683.6033058,1676.644628,18181.42149,545.1570248,1613.892562,1805.297521,23736.03306,1305.793388,3525.413223,3540.661157,8629.247934,1331.958678,333.1652893,2367.099174,17817.39669,419.6033058,162.5619835,1856.735537,22727.13223,613.9752066,138.8842975,2262.231405,17345.21488,2222,436.7355372,2841.165289,14914.50413,606.3719008,282.8512397,1129.603306,9544.694215,1771.826446,412.5123967,1286.190083,6071.586777,640.3057851,159.2561983,1979.330579,5802.173554,1344.495868,361.1239669,3260.363636,817.4793388,950.8347107,121,13.50037208,11.73002624,0.495045792,0.909774436,0.617346939,-0.823185514
+4496,28614.24324,876.972973,796.5225225,1150.225225,17846.63063,611.5405405,487.3063063,1569.882883,9015.666667,1108.621622,558.4774775,1787.243243,11919.03604,1117.396396,4594.666667,2176.684685,4559.207207,1542.36036,469.1531532,2301.234234,9426.927928,400.5135135,598.9189189,557.2072072,12068.93694,454.8288288,113.4234234,1941.558559,9023.459459,1747.675676,458.2702703,2801.720721,7723.378378,825.7657658,241.4954955,1017.720721,4962.099099,842.8558559,370.1351351,1332.603604,2918.936937,733.7207207,143.1351351,2249.576577,2990.486486,1161.153153,411.7747748,3187.54955,872.8558559,950.2252252,111,13.86726213,10.58283608,0.646218405,0.917355372,0.569230769,-1.123112098
+4497,23674.90551,887.1574803,575.6614173,1075.661417,21130.7874,675.3464567,577.984252,1499.826772,11917.93701,720.015748,459.8188976,1750.645669,14524.25197,1230.338583,1404.07874,1623.527559,5480.574803,1334.346457,306.1259843,2317.496063,11514.08661,1808.433071,1064.370079,447.6929134,14557.50394,434.6062992,118.7086614,1601.220472,11012.34646,1547.181102,431.5433071,2803.614173,9784.393701,957.1496063,266.4645669,1286.559055,6479.291339,871.7874016,421.7165354,1383.858268,4462.858268,873.5511811,168.2440945,5285.590551,4262.874016,1319.543307,406.1732283,3272.393701,488.0393701,950.9370079,127,13.54041333,12.28027439,0.421270644,0.976923077,0.647959184,0.195920416
+4498,29679.03478,1078.66087,719.7304348,1184.156522,27190.93043,834.4869565,549.7652174,1758.591304,15488.76522,750,597.8173913,1758.356522,18877.7913,1512.113043,1733.347826,1811.956522,6749.852174,1499.46087,365.9043478,2438.565217,14633.90435,551.1391304,1010.147826,582.4869565,18581.62609,489.0434783,145.2434783,1949.278261,14390.18261,1748.930435,439.6521739,2833.382609,12710.05217,1140.321739,336.4695652,1358.234783,8388.634783,1011.313043,497.1565217,1387.826087,5778.052174,882.026087,189.0173913,2625.052174,5416.26087,1533.417391,245.4695652,3329.982609,502.1043478,951.3043478,115,14.23666446,10.65711835,0.66305748,0.93495935,0.586734694,0.74820348
+4499,17912.43878,1134.459184,535.9489796,1040.479592,15549.65306,736.2755102,890.2244898,1422.265306,8226.653061,634.3673469,2159.234694,1746.153061,10209.17347,1443.969388,2022.928571,4108.602041,3889.622449,1173.897959,263.9693878,2406.785714,7314.295918,340.7142857,204.2346939,1816.030612,9002.642857,1782.755102,108.0612245,982.8163265,7122.602041,1697.928571,413.5102041,2779.040816,6385.979592,542.9489796,237.4387755,1176.183673,4233.27551,1463.785714,369.3265306,1301.030612,2922.27551,572.7755102,143.7244898,1987.744898,2674.061224,1135.816327,273.255102,3399.561224,734.7142857,951.7959184,98,16.42896207,8.80366112,0.844305403,0.830508475,0.544444444,-0.412357581
+4500,30220.19328,1093.478992,591.6386555,1080.142857,26366.20168,668.3109244,723.1008403,1569.277311,15091.55462,533.1512605,1074.218487,1762.218487,18088.26891,1216.705882,3697.176471,3081.084034,6710.235294,1241.184874,267.6806723,2361.722689,12864.21849,679.2016807,99.33613445,628.6302521,16711.2521,492.7394958,114.6218487,3513.87395,12655.03361,1685.369748,476.5210084,2775.058824,11026.84034,592.0672269,246.7815126,1262.722689,7276.588235,1381.403361,377.0504202,1284.386555,5152.159664,574.9579832,146.3361345,1930.89916,4542.277311,1231.739496,244.2521008,3314.672269,633.1596639,953.4201681,119,13.57979851,11.3694369,0.546848416,0.944444444,0.704142012,0.907256414
+4501,26451.58559,874.2162162,514.2072072,1056.945946,23422.74775,724.2432432,988.981982,1546.306306,13124.37838,719.5585586,1299.369369,1786.288288,16017.64865,1202.54955,3137.279279,3889.441441,6054.243243,1230.468468,281.7567568,2475.072072,11765.2973,369.6756757,863.4504505,1354.846847,14737.31532,444.1621622,252.5945946,1342.693694,11278.28829,2148.756757,528.5765766,2791.36036,9770.324324,591.8288288,250.3513514,1140,6672.441441,1192.063063,376.2702703,1363.297297,4583.243243,889.6936937,149.7747748,2970.657658,4143.171171,1247.288288,1559.738739,3210.234234,674.0540541,952.7747748,111,13.59752953,10.42762222,0.641795017,0.956896552,0.711538462,-1.002540501
+4502,32665.73973,900.6438356,559.8013699,1089.986301,29021.58219,731.8835616,969.3287671,1624.287671,16347.73973,825.869863,2206.856164,1852.171233,20273.16438,1544.821918,3541.465753,4952.623288,7187.219178,1283.356164,311.0958904,2556.410959,15248.29452,389.0136986,527.2671233,2411.431507,19408.83562,1084.575342,331.5547945,1254.328767,15242.92466,2574.164384,454.0068493,2809.828767,13289.60274,611.239726,276.1849315,1262.089041,8755.006849,1609.260274,423.8219178,1331.390411,5849.561644,759.1986301,158.8150685,2919.554795,5527.356164,1338.808219,461.4178082,3309.582192,744.9383562,955.8972603,146,19.87478813,10.39211176,0.852406842,0.802197802,0.521428571,0.348245107
+4503,45043.70833,898.9583333,494,1103.041667,39822.375,757,800.7916667,1758.125,22172.77083,584.2916667,1613.625,1802.166667,27559.5625,1349.75,3546.9375,4279.666667,10012.4375,1386.166667,325.625,2375.625,21220.95833,423.6875,167.7708333,1136.708333,27086.875,501.8333333,438.0625,2915.125,21208.22917,2130.416667,455.3541667,2821.041667,18172.8125,633.8125,299.0625,1231.25,11799.16667,1227.4375,438.75,1319.8125,7249.479167,653.3541667,164.6041667,2261,7044.25,1426.4375,574.25,3287.020833,807.3125,951.5625,48,8.957561934,7.197482258,0.595292512,0.923076923,0.666666667,0.399434426
+4504,34053.09649,889.3245614,563.3333333,1153.385965,12191.04386,484.3421053,394.5526316,1347.280702,5758.131579,467.8157895,1106.684211,1691.780702,7991.54386,946.0175439,5894.210526,2328.763158,3141.122807,1044.131579,218.8333333,2349.368421,6284.578947,283.8157895,438.2894737,946.3245614,7835.368421,390.9385965,160.1754386,1581.184211,5964.824561,1959.105263,513.245614,2770.473684,5079.394737,494.4824561,209.8508772,838.0614035,3030.552632,963.1754386,328.1929825,1299.903509,1753.561404,588.5,140.1052632,2606.368421,1849.710526,966.9122807,325.9385965,3020.140351,897.0350877,952.877193,114,13.94302034,10.5097092,0.657148306,0.957983193,0.74025974,1.279625828
+4505,24810.48333,917.6916667,660.8916667,1104.2,23303.16667,732.8166667,747.8416667,1608.35,12305.05833,581.8583333,923.25,1764.475,15026.74167,1324.558333,1571.375,2177.341667,5865.133333,1394.725,324.8833333,2338.516667,12806.14167,467.4583333,255.4416667,1065.141667,15651.71667,561.425,139.4166667,1283.45,12058.70833,1708.95,454.9916667,2843.733333,11200.64167,1055.291667,299.4416667,1691.658333,7407.8,1411.366667,448.0583333,1326.608333,4958.508333,675.3,169.8,1968.733333,4643.683333,1461.525,1625.45,3197.883333,421.6666667,953.6833333,120,18.88895056,8.599921965,0.890343968,0.857142857,0.666666667,-1.520900238
+4506,31340.73034,1050.438202,619.4157303,1098.988764,28263.46067,800.6853933,775.011236,1592.52809,16364.60674,632.1573034,1074.47191,1790.191011,19093.08989,1346.842697,3042.516854,3100.404494,6815.213483,1378.88764,324.7752809,2321.898876,15717.78652,449.0561798,144.2359551,923.6741573,19772.20225,495.5505618,259.6741573,2936.865169,15097.1573,1803.606742,539.988764,2823.41573,13364.59551,644.8764045,307.3483146,1498.022472,8779.853933,1192.797753,445.2696629,1319.404494,6204.146067,624.6853933,159.8202247,2126.235955,5671.741573,1352.58427,290.3820225,3377.910112,534.741573,957.8089888,89,18.3836078,6.978914979,0.925139609,0.839622642,0.402714932,-0.641497161
+4507,26431.76543,818.6296296,550.7407407,1086.45679,23741.09877,676.345679,1075.82716,1523.950617,14194.45679,544.6419753,2030.111111,1762.185185,16282.2963,1225.209877,2799.592593,3598.62963,6072.407407,1331.703704,307.3950617,2413.530864,12907.97531,526.7654321,192.9259259,2063.197531,16425.35802,478.4938272,124.9876543,2060.283951,12478.06173,1507.049383,471.2962963,2788.62963,11023.76543,864.8395062,276.0864198,1431.469136,7371.444444,1743.753086,429.8518519,1320.814815,5143.345679,665.9753086,164.8271605,4293.876543,4544.580247,1313.209877,1219.580247,3259.851852,557.7901235,954.9259259,81,11.16740012,9.528531306,0.521509839,0.931034483,0.623076923,0.214682335
+4508,33627.61644,839.7945205,479.369863,1073.712329,30368.87671,692.4794521,1053.876712,1628.917808,16828.94521,570.4383562,1846.520548,1828.438356,20879.87671,1472.479452,3054.09589,5446.684932,7815.506849,1285.09589,297.3972603,2938.109589,15717.19178,389.9041096,225.9863014,2382.082192,19886.56164,2060.767123,150.7260274,1731.561644,15530.19178,1877.589041,468.0821918,2776.068493,13566.49315,586.9041096,264.6986301,1338.643836,8894.671233,1427.342466,402.2054795,1304.69863,5919.260274,649.2739726,159.0821918,4534.123288,5564.178082,1339.068493,414.7534247,3209.356164,754.9041096,954.9315068,73,12.45319115,8.208579737,0.752007349,0.9125,0.51048951,-0.722341679
+4509,30676.47701,1011.051724,624.9827586,1107.626437,28026.10345,770.6321839,629.6494253,1623.856322,14281.18966,611.4482759,800.8850575,1745.321839,17815.05747,1398.034483,1945.637931,2838.011494,6751.390805,1400.908046,337.6149425,2333.37931,14905.84483,548.8275862,225.4942529,801.2413793,18370.45977,923.8908046,131.5517241,1494.862069,14182.92529,1567.264368,584.183908,2812.448276,13114.67241,632.5114943,302.1206897,1679.942529,7913.011494,1042.522989,456.5632184,1322.873563,5280.609195,648.4022989,174.5402299,3764.298851,4956.385057,1461.517241,877.8505747,3291.62069,376.1609195,956.5862069,174,17.05134146,13.6282802,0.600999048,0.910994764,0.639705882,-0.913443256
+4510,29882.11905,1136.869048,627,1108.428571,26946.79762,814.1547619,735.202381,1637.392857,14261.14286,709.3214286,1310.404762,1767.452381,17290.61905,1413.714286,3053.72619,3206.119048,6486.130952,1429.285714,326.5357143,2323.321429,13910.03571,427.5357143,530.1785714,1352.809524,16461.05952,523.1071429,134.3928571,1948.309524,12925.80952,2114.97619,452.0714286,2895.238095,11737.34524,624.0357143,296.9761905,1566.404762,7364.702381,1397.392857,438.6904762,1342.47619,4990.285714,697.1666667,166.047619,3203.47619,4295.440476,1371.488095,403.8214286,3367.047619,399.1071429,955.2261905,84,11.93631064,9.569213121,0.597740902,0.893617021,0.636363636,0.187581408
+4511,31362.0119,942.7142857,557.6666667,1090.666667,27812.16667,712.4047619,694.6666667,1573.833333,16536.46429,565.7380952,565.6785714,1738.559524,19177.67857,1294.321429,2204.321429,3899.511905,6948.5,1305.797619,303.5,2309.214286,15304.15476,418.7380952,475.2380952,592.202381,18954.80952,654.1428571,117.7857143,2121.297619,14697.17857,1480.904762,600.4404762,2810.97619,13140.25,618.75,282.702381,1459.964286,8847.928571,1104.464286,428.3571429,1306.130952,6329.619048,776.6666667,158.797619,1675.297619,5590.47619,1382.440476,678.047619,3237.071429,591.6428571,955.3095238,84,12.87680425,8.582647329,0.745487166,0.933333333,0.583333333,-0.766101209
+4512,26485.6478,976.4150943,791.6477987,1151.289308,23537.8239,751.4591195,807.163522,1765.886792,13023.71698,713.5974843,795.8553459,1778.169811,16257.44654,1364.251572,2099.377358,2305,5827.672956,1344.528302,348.1509434,2381.396226,12057.06918,438.1257862,284.9119497,802.4150943,15494.10692,677.3647799,120.5283019,1651.987421,11847.47799,1688.402516,448.7610063,2799.54717,10364.98742,782.5031447,289.8993711,1721.930818,7001.459119,1051.251572,421.1509434,1338.025157,4830.194969,654.8050314,164.8867925,2236.295597,4320.012579,1398.283019,502.7106918,3289.679245,711.2641509,955.6415094,159,17.22235619,12.41591297,0.693019987,0.913793103,0.668067227,-1.380493639
+4513,22353.66667,800.975,441.7,1067.433333,20457.975,645.55,528.1416667,1574.425,10675.2,499.825,1088.025,1794.291667,13546.41667,1177.183333,3250.441667,3013.191667,5244.4,1258.8,377.3416667,2301.683333,10282.175,368.4583333,180.4166667,936.3166667,13337.15,1024.625,124.525,1349.75,10225.9,1955.966667,434.8083333,2795.008333,8882.125,584.2416667,252.775,1073.316667,5893.775,1432.216667,391.6583333,1300.733333,3766.658333,628.4166667,150.4,1898.725,3575.725,1266.191667,980.225,3196.783333,792.875,956.7333333,120,16.79655252,9.610135921,0.820149479,0.845070423,0.571428571,0.548125233
+4514,35909.68852,864.5409836,495.2459016,1085.163934,31535.40984,737.8032787,1020.901639,1617.213115,17559.21311,536.1639344,2694.098361,1846.819672,21756.19672,1285.983607,3784.032787,4699.42623,8058.590164,1308.95082,304.7377049,2467.245902,16862.47541,405.5737705,133.3934426,1185.786885,21421.7541,714,144.0491803,1594.491803,17096.08197,2420.918033,434.2786885,2815.639344,14833.09836,620.0819672,286.4098361,1064.508197,9488.622951,1587.393443,425.5081967,1301.967213,5956.327869,621.5737705,160.2459016,2636.016393,5773.327869,1367.606557,1380.901639,3188.491803,800.8032787,954.6229508,61,12.12388585,7.235126425,0.802415099,0.835616438,0.462121212,0.734469796
+4515,17445.5445,810.7748691,490.2251309,1067.633508,15932.59686,630.9424084,652.486911,1513.591623,7596.659686,509.9424084,865.6230366,1742.596859,10104.2356,1207.314136,1465.790576,1522.068063,3818.86911,1204.905759,288.8324607,2287.193717,8503.633508,360.0837696,183.3507853,633.3246073,10282.31937,409.6492147,120.6387435,990.1884817,8095.089005,1492.141361,314.8062827,2865.382199,7284.989529,631.8429319,267.565445,1231.65445,3969.570681,1042.900524,400.8010471,1312.659686,2732.832461,777.973822,159.1675393,2737.256545,2608.858639,1461.513089,7697.879581,3124.031414,325.1413613,959.3664921,191,17.2817493,14.54162083,0.540344639,0.945544554,0.660899654,-0.539710026
+4516,37776.38983,1096.118644,733.7966102,1115.033898,35912.86441,844.9661017,796.4237288,1689.237288,19253.74576,656.8474576,1431.474576,1790.966102,23124.45763,1461.016949,3260.627119,2873.610169,8489.355932,1429.508475,343.3389831,2357.932203,19490.05085,474.9661017,382.3559322,974.8644068,23850.79661,576.9322034,216.559322,2509.084746,18633.79661,2081.627119,437.3389831,2813.932203,16959.45763,716.8474576,316.1864407,1326.118644,10757.0339,1272.067797,472.3728814,1321.20339,7425.847458,715.8135593,172.5084746,2577.40678,6701.677966,1502.169492,1100.847458,3324.457627,407.5423729,954.7627119,59,9.089673336,8.878124919,0.214488516,0.907692308,0.655555556,1.528422337
+4517,23813.64045,823.5730337,584.2247191,1072.696629,21805.94382,664.9438202,813.1460674,1497.820225,12079.50562,533.1460674,1719.58427,1802.898876,14312.22472,1181.314607,2396.348315,4427.191011,5482.662921,1305.179775,292.6067416,2625.370787,11826.80899,420.4606742,1113.629213,1118.52809,14748.26966,978.5955056,121.8314607,1678.393258,11684.57303,1881.123596,472.7865169,2779.752809,10413.8764,650.1910112,277.2808989,1558.52809,6656.393258,1756.168539,413.2022472,1385.05618,4413.719101,845.1797753,162.7977528,5384.11236,4169.52809,1303.325843,711.4831461,3278.314607,442.8764045,956.6853933,89,11.21341903,10.48400342,0.35477544,0.946808511,0.618055556,-0.382139179
+4518,26511.14151,1031.660377,691.9528302,1102.735849,24000.91509,743.5471698,676.5283019,1629.462264,13613.85849,692.1698113,473.6132075,1725.528302,16372.03774,1362.622642,3493.40566,1471.04717,5967.820755,1378.584906,329.6509434,2330.320755,13351.61321,525.6886792,669.3962264,458.0849057,16712.12264,470.9622642,133.7735849,1171.132075,12681.27358,1645.462264,440.0660377,2830.103774,11493.03774,971.9339623,304.6698113,1390.339623,7468.415094,900.5849057,456.2735849,1370.254717,5167.726415,766.7735849,172.2735849,3147.113208,4878.075472,1450.5,457.0943396,3242.933962,479.0943396,956.0566038,106,15.98376739,8.653990676,0.840749882,0.938053097,0.602272727,1.012722223
+4519,23004.94949,865.8888889,671.979798,1105.979798,21107.61616,697.8484848,999.3333333,1627.959596,11800.21212,591.3030303,2269.434343,1824.464646,14118.9899,1281.969697,1850.808081,3012.464646,5308.020202,1389.909091,315.7070707,2766.59596,11532.42424,757.4747475,336.9494949,1174.555556,14404.84848,503.6868687,124.8585859,1079.848485,11101.52525,2170.838384,414.2222222,2819.343434,9714.737374,915.040404,284.5454545,1454.969697,6411.060606,1205.454545,451.2626263,1334.989899,4457.080808,675.1313131,170.3232323,2645.424242,4190.888889,1400.505051,482.2323232,3252.787879,512.4848485,956.0909091,99,14.09820461,9.264555838,0.753764733,0.942857143,0.585798817,-0.719767214
+4520,39376.15385,896.0769231,534.4423077,1113.211538,34234.25,714.1538462,696.3269231,1617.75,20155.67308,575.4230769,886.25,1819.923077,23093.63462,1278.192308,2757.134615,2702.538462,8575.576923,1379.307692,323.6346154,2308.923077,18488.57692,471.1538462,163.5961538,1028.769231,23831.26923,424.6730769,133.4807692,2797.596154,18125.98077,1715.384615,576.25,2806.211538,15688.40385,618.4807692,308.8076923,1340.634615,10356.5,1183.326923,456.2884615,1305.307692,7111.923077,635.4038462,164.4423077,2002.903846,6655.211538,1367.788462,171.8461538,3247.884615,543.0769231,955.8653846,52,8.63027316,7.916579522,0.398188828,0.945454545,0.65,0.014031403
+4521,30041.88785,944.0280374,573.271028,1090.242991,26807.13084,716.2242991,1026.317757,1544.700935,16043.52336,592.364486,2299.401869,1781.373832,18435.93458,1305.981308,2666.71028,3580.542056,6639.747664,1302.327103,299.8785047,2898.934579,14257.91589,528.7009346,147.1588785,1301.616822,18200.5514,1037.420561,124.317757,1626.336449,14082.1215,2087.28972,495.8878505,2816.560748,12488.27103,710.9906542,285.0186916,1237.439252,8161.962617,1334.757009,421.9813084,1327.495327,5759.53271,617.8411215,162.1775701,2244.906542,5111.841121,1334.28972,1060.149533,3359.252336,569.7196262,956.1028037,107,14.38839189,9.636168346,0.742615306,0.930434783,0.685897436,1.056292264
+4522,14332.81429,863.1,516.4714286,1081.457143,13450.18571,659.1428571,697.3,1505.828571,7590.014286,682.5428571,470.1714286,1749.785714,9208.885714,1207.328571,1107.9,1021.028571,3479.157143,1340.814286,365.9285714,2492.385714,7799.114286,385.0142857,720.9428571,481.9571429,9218.571429,411.6714286,118.1,898.6714286,7508.742857,1572.842857,358.3714286,2810.314286,6876.985714,1045.771429,257.1,1217.171429,4595.071429,805.0857143,402.4714286,1358.885714,3162.457143,754.7571429,156.9428571,2527.585714,2908.314286,1289.842857,444.8142857,3211.657143,496.6285714,958.1428571,70,11.01174695,8.477304671,0.638234582,0.95890411,0.53030303,0.564927978
+4523,35920.86111,886.5277778,445.0833333,1093.041667,30897.58333,720.6666667,994.0277778,1652.222222,17840.13889,548.3888889,1309.208333,1813.652778,21218.25,1303.611111,3362.458333,4035.708333,7751.513889,1310.458333,312.7083333,2273.458333,16408.36111,406.6666667,283.0833333,1687.277778,20562.25,1199.041667,153.0277778,1088.319444,16488.65278,1876.152778,443.0138889,2803.069444,14327.18056,575.8611111,287.2638889,1024.097222,9077.555556,1815.652778,418.6527778,1303.236111,5750.541667,678.0833333,162.75,1926.555556,5611.472222,1371.875,762.4861111,3234.138889,783.3888889,956.8194444,72,11.7808668,8.072094424,0.728367386,0.947368421,0.654545455,0.828396029
+4524,22484.3937,1037.850394,616.8267717,1083.472441,18618.19685,650.8582677,417.6850394,1541.716535,9664.692913,522.1574803,604.3937008,1760.307087,12050.24409,1180.811024,4956.220472,2032.110236,4454.456693,1180.527559,274.8031496,2319.740157,8771.992126,362.0314961,797.5275591,627.2283465,10716.43307,804,110.2677165,2346.330709,8460.409449,1703.23622,581.3937008,2789.897638,7170.88189,583.2440945,239.0629921,1143.19685,4609.251969,988.1181102,364.1102362,1360.968504,2816.173228,765.2204724,147.7322835,3459.377953,2782.472441,1149.858268,516.976378,3298,827.8425197,958.1732283,127,15.28154317,10.99423026,0.694549387,0.940740741,0.604761905,0.952118571
+4525,25330.11189,842.6293706,613.8531469,1088.356643,21410.17483,693.5034965,509.4055944,1700.601399,10560.91608,728,1699.020979,1780.902098,14177.40559,1211.307692,5953.041958,2707.034965,5296.258741,1483.258741,292.3916084,2332.923077,11178.86014,383.1468531,886.6853147,1585.293706,14014.17483,489.034965,134.0769231,1025.951049,10590.13986,2672.447552,698.3986014,2796.937063,8996.398601,767.5174825,278.5174825,929.5804196,5412.160839,1389.573427,396.006993,1357.902098,3118.58042,825.3006993,151.6433566,2798.020979,3263.811189,1258.566434,1844.34965,3207.58042,889.9160839,959.7972028,143,19.00002823,10.35139151,0.838559991,0.87195122,0.647058824,1.162626891
+4526,22264.84259,905.462963,694.6851852,1129.083333,20325.72222,735.0185185,758.0277778,1623.888889,11760.56481,571.7962963,615.9166667,1748.185185,14025.10185,1350.574074,778.9537037,999.5185185,5112.296296,1379.435185,321.1203704,2351.805556,11582.97222,3192.009259,140.9074074,507.5462963,14482.77778,510.3240741,132.537037,957.6388889,11270.18519,1513.722222,391.3796296,2812.203704,10121.17593,1068.194444,302.8703704,1423.083333,6685.12037,873.3703704,449.8148148,1329.824074,4603.574074,630.0092593,169.6111111,1470.814815,4345.888889,1431.87037,391.0833333,3175.009259,519.1203704,961.4444444,108,15.01430875,9.664390136,0.765295879,0.947368421,0.593406593,-0.631950059
+4527,29695.08955,867.1940299,536.7164179,1077.462687,26824.35821,668.238806,944.3731343,1556.880597,15436.74627,563.0447761,1663.208955,1783.343284,18210.92537,1214.283582,2736.328358,4359.074627,6925.074627,1268.567164,290.1940299,2369.850746,14026.79104,417.1940299,680.7164179,1574.373134,17580.31343,920.4328358,116.1641791,1891.164179,13500.02985,1746.283582,595.7164179,2833.61194,12115.56716,689.5522388,270.641791,1472.716418,8140.298507,1950.134328,402.1044776,1313.119403,5744.119403,970.8955224,155.8955224,2121.791045,5161.776119,1307.313433,329.0447761,3275.597015,598.0447761,958.9701493,67,16.29509673,6.388391554,0.919946555,0.752808989,0.398809524,-0.922565389
+4528,32312.20952,1001.952381,573.1238095,1088.104762,28036.15238,744.2190476,922.6571429,1636.628571,15894.28571,589.1714286,1733.2,1848.457143,18245.18095,1315.142857,4175.67619,3745.771429,6746.628571,1272.190476,284.9619048,2394.028571,13647.3619,392.1238095,105.647619,1601.085714,17372.00952,698.9333333,116.1809524,1857.895238,13093.41905,2176.533333,482.4095238,2830.752381,11455.33333,627.047619,257.8761905,1089.390476,7695.847619,1386.27619,392.0095238,1299.571429,5284.057143,587.1619048,152.0095238,1830.609524,4703.666667,1257.819048,376.4380952,3383.761905,648.0857143,959.2666667,105,12.54583212,10.99844604,0.48110798,0.905172414,0.673076923,0.968690507
+4529,33498.14754,928.1311475,560.7704918,1104.491803,29542.47541,731.9344262,729.2295082,1661.885246,16790.34426,701.8852459,2820.836066,1810.327869,20668.36066,1492.983607,1815.377049,5150.803279,7234.360656,1318.557377,298.9016393,2363.622951,14975.21311,400.8360656,354.8196721,2273.737705,18938.42623,1877.344262,120.9672131,1132.57377,14859.65574,2193.229508,491.6557377,2788.918033,12830.09836,666.2131148,279.442623,1475.393443,8624.114754,2352.278689,424.6393443,1313.245902,5724.360656,705.1147541,163.0327869,2943.360656,5348.377049,1371.47541,357.3934426,3248,726.4918033,957.4098361,61,11.36070777,7.698193804,0.735416195,0.871428571,0.616161616,0.748713052
+4530,37697.01316,1019.421053,509.9868421,1095.513158,32935.59211,729.3684211,676.2236842,1666.828947,19352.96053,570.9210526,1023.039474,1771.381579,23219.84211,1524.855263,3529.973684,3239.25,8513.986842,1311.618421,310.8684211,2363.552632,17945.75,397.2763158,290.6315789,1189.263158,22384.39474,590.8552632,503.8552632,1925.289474,18094.26316,2168.697368,428.7105263,2836.460526,15699.05263,602.7631579,294.6052632,1086.144737,10205.06579,1138.460526,415.2368421,1332.394737,6491.065789,777.9078947,162.5263158,2482.078947,6240.197368,1390.671053,285.6842105,3221.855263,764.9473684,958.5263158,76,11.04462787,8.983186277,0.581769844,0.938271605,0.633333333,1.200877822
+4531,23853.78261,894.8478261,988.0869565,1202.76087,15321.54348,658.4565217,736.0108696,1755.673913,7537.086957,641.8913043,821.5217391,1818,10265.6087,1198.282609,2761.782609,1807.652174,3921.554348,1281.521739,292.8695652,2396.532609,8304.706522,394.423913,302.6630435,795.1195652,10597.02174,637.9782609,114.1956522,894.0978261,7983.195652,1965.923913,382,2792.380435,6832.663043,776.8478261,259.5869565,937.2826087,4400.108696,1085.771739,389.9673913,1316.152174,2624.51087,653.6630435,155.6521739,1629.869565,2720.815217,1250.73913,1209.630435,3209.086957,876.9565217,959.4456522,92,11.41507967,10.52786031,0.386530675,0.978723404,0.696969697,-0.243744923
+4532,33869.08621,1086.442529,621.3045977,1102.166667,14939.44828,553.0517241,452.8563218,1406.54023,7817.551724,449.4770115,1153.83908,1689.471264,9956.511494,1094.293103,3342.729885,2033.298851,3831.436782,1126.931034,242.862069,2284.114943,7835.385057,326.5287356,129.1781609,1302.436782,9616.706897,1227.706897,108.1149425,3298.471264,7390.195402,1495.701149,373.0862069,2783.086207,6387.586207,1103.913793,243.3505747,999.6609195,4013.977011,1154.804598,364.6091954,1293.109195,2436.396552,568.7356322,147.4770115,1491.109195,2473.465517,1142.965517,1459.747126,3242.436782,849.1321839,961.7701149,174,16.7195543,13.31744634,0.60461321,0.956043956,0.682352941,1.213306632
+4533,29464.22388,815,530.7761194,1065.238806,26712.91045,696.7164179,825.7014925,1535.074627,15869.16418,579.5970149,1599.402985,1846.074627,18246.80597,1262.134328,2665.865672,3235.089552,6876.80597,1351.820896,309.3134328,2348.19403,14453.31343,591.8507463,265.8656716,1583.746269,18749.35821,463.6268657,134.2089552,1830.791045,14113.80597,1871.671642,552.3283582,2804.283582,12324.50746,818.4179104,269.2686567,1235.686567,8279.761194,1427.880597,418.8358209,1331.447761,5686.268657,639.6119403,158.6567164,3890.701493,5161.477612,1325.567164,272.761194,3242.298507,550.8208955,960.4328358,67,10.890184,8.345914105,0.642399011,0.917808219,0.515384615,1.186749039
+4534,39009.70149,986.9552239,569.1791045,1073.910448,34815.50746,752.5671642,850.4925373,1653.343284,20240.13433,601.4626866,1426.149254,1744.985075,23256.55224,1341.358209,4413.910448,3741.61194,8668.820896,1336.820896,305.7761194,2302.522388,17455.64179,404.1940299,106.9701493,1226.164179,22465.08955,564.880597,121.0298507,4569.865672,17173.1791,2171.313433,507.5373134,2811.701493,15129.02985,607.8059701,282.5074627,1431.567164,9862.567164,1307.880597,405.9104478,1296.716418,6959.41791,592.8059701,149.1343284,2159.761194,6310.208955,1340.597015,174.7164179,3354.850746,623.7014925,960.7014925,67,10.99451527,8.146089351,0.671589974,0.930555556,0.62037037,-0.164906614
+4535,25048.32075,866.5408805,490.8113208,1070.861635,22627.27044,688.8490566,831.6100629,1550.861635,12810.96226,636.5157233,1769.314465,1837.106918,15191.47799,1215.295597,2893.471698,3688.389937,5796.050314,1222.389937,280.8993711,2502.201258,11826.86164,370.8805031,239.8679245,1565.886792,14890.49057,652.9811321,176.9874214,1736.540881,11482.2327,1958.540881,476.6289308,2797.471698,10012.67925,666.0691824,266.1069182,1338.918239,6798.962264,1596.150943,388.8301887,1318.157233,4560.842767,613.7044025,152.0440252,2931.716981,4243.163522,1250.90566,749.9622642,3266.295597,683.5283019,962.4842767,159,18.2377521,11.27792207,0.785876608,0.940828402,0.597744361,-1.146651524
+4536,27458.39326,1083.94382,543.9662921,1080.707865,25166.08989,739.4606742,684.6516854,1607.955056,14151.05618,560.0674157,1590.730337,1795.269663,17187.40449,1280.752809,4153.213483,2930.640449,6512.393258,1367.719101,305.247191,2308.213483,13516.23596,396.258427,399.6516854,1808.41573,16952.22472,638.1011236,145.5280899,1148.730337,13476.58427,2446.191011,433.3483146,2794.741573,11872.58427,604.0449438,288.2022472,951.5617978,7651.853933,2012.044944,424.8651685,1321.629213,5080.078652,864.0674157,164.0898876,2389.359551,4820.516854,1380.494382,233.3370787,3174.382022,776.3595506,962.0674157,89,11.53014354,10.07466704,0.486343501,0.967391304,0.570512821,0.524773382
+4537,36814.05556,1012.54321,539.2901235,1088.148148,31791.01235,667.5617284,674.5061728,1580.246914,17106.82716,524.8271605,1498.777778,1753.919753,22183.53086,1231.512346,4132.216049,3764.685185,8071.907407,1281.919753,290.3641975,2328.530864,16554.66049,376.2098765,138.9506173,1760.574074,21196.80864,592.7654321,119.3580247,1768.203704,16581.87037,2250.722222,435.6790123,2787.271605,14019.51235,610.5432099,271.191358,1037.740741,9089.179012,1301.364198,405.1851852,1288.123457,5649,606.0740741,152.154321,1838.759259,5502.969136,1300.395062,596.654321,3229.246914,812.3765432,964.0432099,162,19.37535057,12.81110926,0.750203879,0.861702128,0.54,-0.407675882
+4538,29131.3615,960.6338028,533.5023474,1090.774648,26605.46479,759.5915493,686.6713615,1582.356808,13053.74178,600.3849765,1421.877934,1766.234742,16917.95775,1380.685446,2517.276995,3677.746479,6392.478873,1369.85446,340.6760563,2504.544601,13969.723,429.3051643,420.5305164,1469.779343,17072.65728,709.8403756,142.8685446,2012.586854,13304.46948,1781.971831,456.2676056,2812.478873,12119.09859,625.0328638,289.1784038,1432.784038,7003.093897,1051.873239,444.5915493,1320.173709,4659.107981,694.8309859,174.1267606,3479.586854,4278.323944,1403.225352,1118.577465,3171.859155,363.084507,966.3521127,213,20.34850043,13.47960269,0.749117493,0.946666667,0.760714286,-0.176719161
+4539,38110.7957,989.1290323,538.6021505,1117.086022,33988.30108,795.655914,648.2150538,1698.860215,17645.15054,608.3010753,1224.88172,1748.27957,21616.6129,1429.215054,2339.107527,4083.774194,7858.129032,1413.451613,342.6774194,2357.462366,17253.19355,438.5913978,250.9784946,987.6774194,21463.7957,652.9784946,204.7311828,2780.602151,16559.21505,1727.698925,496.2473118,2831.043011,14975.52688,664.4301075,325.1612903,1931.075269,9184.010753,1141.483871,468.4193548,1327.290323,5867.806452,654.1935484,181.9892473,4106.053763,5442.075269,1488.322581,956.688172,3229.419355,389.4623656,961.172043,93,13.28377944,9.169363088,0.723554134,0.958762887,0.65034965,-1.199881738
+4540,26786.34513,1086.849558,609.1238938,1096.061947,23138,753.3982301,576.1504425,1514.097345,12965.69027,623.5132743,587.3274336,1757.380531,15016.25664,1314.99115,2377.026549,2312.345133,5489.265487,1362.725664,312.0088496,2310.415929,12378.9115,417.2389381,877.380531,571.0884956,14933.04425,435.2123894,124.7345133,2317.566372,11934.74336,1635.566372,460.5929204,2806.504425,10726.02655,699.5044248,274.2123894,1336.681416,6834.920354,970.7256637,422.0619469,1356.707965,4548.256637,788.3097345,165.0619469,3121.787611,4100.247788,1293.362832,1993.017699,3265.982301,433.7522124,962.1238938,113,14.51047444,9.971930422,0.72644661,0.974137931,0.627777778,1.092922027
+4541,26327.91111,1130.388889,912.3444444,1160.888889,23896.34444,734.9777778,814.6555556,1712.966667,13339.85556,570.6888889,519.2,1774.633333,16198.92222,1280.033333,965.3333333,1028.422222,5794.766667,1377.077778,315.6333333,2401.7,13062.61111,437.0111111,145.0333333,453.2666667,16398.76667,486.4222222,129.8555556,906.7444444,12440.63333,1498.633333,389.1333333,2841.122222,11335.64444,787.7888889,308.1333333,1646.511111,7187.777778,896.5555556,455.2666667,1361.855556,4911.488889,613.3333333,170.3777778,1456.233333,4589.077778,1419.866667,780.1222222,3333.133333,472.9666667,963.1222222,90,11.41543454,10.64622821,0.360867772,0.9,0.576923077,1.361885079
+4542,24557.48544,918.407767,763.3592233,1082.048544,23509.67961,724.1941748,687.9902913,1574.38835,12627.14563,1445.76699,810.6116505,1733.048544,15088,1350.262136,2261.466019,2307.009709,5799.640777,1761.184466,374.5048544,2363.660194,12650.04854,435.3495146,911.3106796,627.8543689,15488.25243,727.6407767,130.0291262,1702.407767,12018.3301,1791.854369,427.9902913,2828.436893,11006.74757,742.1359223,292.0582524,1583.601942,7170.058252,1112.543689,438.0873786,1437.223301,4802.873786,809.4271845,168.1262136,3331.543689,4479.873786,1438.349515,820.223301,3249.398058,419.0582524,962.2718447,103,13.70793039,9.721442482,0.70502362,0.944954128,0.735714286,1.568519578
+4543,37454.01534,942.4785276,538.2668712,1094.662577,33794.46012,746.6319018,752.7760736,1618.046012,19862.54294,585.5276074,1411.392638,1799.07362,23540.02147,1313.720859,1860.217791,3746.46319,8326.386503,1337.779141,310.7177914,2459.812883,17813.18712,449.3343558,136.5705521,1173.092025,22853.07362,1069.383436,186.904908,1821.141104,17691.3681,1791.5,487.2760736,2810.91411,15812.48773,639.4018405,299.1564417,1406.257669,10296.95399,1450.990798,441.7546012,1323.941718,7083.312883,633.7822086,164.7055215,2932.53681,6317.730061,1382.125767,502.0153374,3296.08589,573.1319018,970.3159509,326,28.13496739,17.66687841,0.778267288,0.835897436,0.464387464,0.714470818
+4544,35677.46617,1033.954887,624.7293233,1131.661654,31894.8797,825.1428571,957.1578947,1803.466165,17745.50376,664.1954887,1952.488722,1781.18797,21625.61654,1494.62406,1891.12782,3373.804511,7711.796992,1375.93985,331.7819549,2353.721805,14967.99248,443.8270677,271.3233083,1715.789474,18885.30075,1630.729323,126.2406015,931.1278195,14826.6015,1711.300752,468.7443609,2808.353383,13022.06767,704.6015038,293.1879699,1669.030075,8571.315789,1826.601504,425.1879699,1334.969925,5637.428571,667.037594,160.3082707,2280.684211,5118.43609,1403.195489,973.6390977,3261.075188,718.3233083,964.5263158,133,16.29169487,10.63379506,0.757605582,0.93006993,0.59375,-1.083921487
+4545,33433.38938,911.2831858,576.5575221,1108.20354,30128.15044,733.5309735,855.9469027,1680.106195,16919.95575,1000.982301,2105.964602,1758.911504,21412.0177,1549.132743,2521.336283,4242.265487,7261.522124,1318.415929,323.7345133,2478.415929,16174.0177,513.5752212,703.7699115,1805.415929,20463.0354,2382.716814,139.8938053,1220.575221,15923.77876,1703.663717,529.7787611,2795.39823,13927.35398,660.7787611,292.1769912,1601.699115,8999.814159,1497,426.460177,1357.433628,6023.309735,857.0176991,160.1415929,3225.247788,5605.99115,1416.955752,2324.539823,3324.716814,737.2389381,963.5840708,113,13.74268728,10.86793438,0.612054208,0.941666667,0.620879121,-1.177784158
+4546,32550.15702,916.9173554,692.4545455,1147.933884,10342.50413,427.5454545,245.3966942,1206.115702,4505.900826,351.0082645,326.9586777,1596.14876,6350.578512,848.6198347,2313.661157,1275.859504,2376.867769,890.7933884,190.9090909,2233.123967,4870.876033,245.661157,103.9752066,482.6033058,5898.016529,323.1487603,90.95867769,1765.719008,4299.057851,1236.553719,341.4049587,2760.68595,3536.033058,444.1570248,183.0661157,667.3884298,1846.578512,605.9752066,303.892562,1259.471074,1062.46281,475.0413223,126.9256198,720.1983471,1067.768595,843.785124,121.6528926,2910.413223,927.3801653,964.3553719,121,13.52805472,11.59213986,0.515488849,0.96031746,0.775641026,-0.378745816
+4547,27264.37584,887.7651007,730.6375839,1113.946309,11502.49664,451.5704698,369.4563758,1267.510067,5003.483221,365.6241611,632.1744966,1624.657718,7224.677852,884.0469799,3133.234899,1526.604027,2804.006711,912.8993289,202.9060403,2242.463087,5656.704698,257.8926174,100.0738255,677.6174497,6806.040268,314.7651007,125.8187919,1577.067114,5049.167785,1493.241611,333.1610738,2801.261745,4104.865772,455.2080537,200.4765101,696.4026846,2093.328859,677.6912752,316.0738255,1256.832215,1191.409396,488.6442953,126.4362416,695.6241611,1248.738255,868.3825503,118.966443,2931.577181,939.0738255,964.9798658,149,14.97000024,13.09208612,0.484926631,0.973856209,0.716346154,0.0004513
+4548,34233.60417,1073.354167,586.4375,1063.9375,29889.17708,747.9895833,681.2708333,1625.479167,16914.98958,601.2395833,1014.125,1724.510417,19623.04167,1300.541667,4021.1875,3366.510417,7242.135417,1263.697917,287.15625,2286.989583,13560.85417,389.2395833,103.0520833,994.5625,17255.125,1043.3125,128.59375,3768.375,13046.67708,1729.260417,526.7291667,2780.989583,11548.33333,579.71875,250.9166667,1269.447917,7466.197917,1093.635417,381.5729167,1307.447917,5268.9375,589.625,148.0833333,2586.875,4730.958333,1251.322917,198.5833333,3458.197917,631.7916667,965.0208333,96,11.87972138,10.52793891,0.463281978,0.923076923,0.671328671,0.12463011
+4549,36844.04717,870.0471698,493.3301887,1100.141509,33298.5283,712.2075472,1198.867925,1648.858491,18774.86792,569.9622642,2089.622642,1805.433962,22580.40566,1316.773585,3074.037736,3642.54717,8492.320755,1320.660377,309.9245283,2723.066038,17418.66038,404.3773585,116.5660377,1269.830189,22352.67925,1174.433962,132.7169811,1295.132075,16921.96226,1847.962264,484.5,2789.764151,14786.9717,623.1981132,288.8113208,1219.811321,10074.43396,1809.349057,410,1317.396226,6999.04717,613.0188679,157,2144.066038,6360.292453,1377.962264,282.6132075,3269.103774,659.1981132,964.4811321,106,12.45111852,11.08611781,0.455235169,0.938053097,0.679487179,1.398777514
+4550,25284.92913,852.0551181,554.6614173,1068.503937,22988.48031,680.2125984,595.9212598,1535.409449,12660.14961,656.2204724,1309.228346,1749.566929,16003,1541.952756,1479.84252,3199.110236,5880.748031,1262.228346,299.3307087,2390.543307,12487.98425,397.4094488,349.2992126,956.3464567,15648.13386,1031.84252,147.0708661,1106.913386,12381.80315,1674.259843,442.7716535,2801.566929,10895.15748,614.9370079,268.3543307,1454.307087,7059.76378,1326.393701,409.3700787,1316.606299,4805.566929,707.0787402,163.8267717,3153.811024,4519.850394,1400.086614,3470.708661,3215.275591,756.4015748,966.0708661,127,15.2480717,11.5418245,0.653488247,0.907142857,0.533613445,-0.063120549
+4551,16862.30108,808.2043011,450.2365591,1088.021505,15384.17204,625.9892473,518.3870968,1493.397849,7465.505376,506.0537634,602.0752688,1722.978495,9804.827957,1199.935484,1069.010753,1024.107527,3807.129032,1190.322581,302.311828,2271.516129,8408.021505,355.4623656,145.8817204,672.6451613,10257.50538,422.5483871,119.688172,930.8064516,7973.924731,1404.376344,321.9462366,2844.548387,7220.150538,608.5483871,288.2043011,1216.505376,3950.27957,889.6021505,413.7096774,1301.946237,2710.129032,869.5268817,165.8494624,1790.333333,2578.311828,1550.096774,4532.88172,3161.505376,334.2365591,966.7311828,93,12.66615374,9.907681067,0.623006043,0.948979592,0.603896104,-0.025114203
+4552,24136.11927,875.9816514,479.7155963,1054.192661,21990.08257,706.0825688,627.2568807,1490.385321,10748.29358,546.7889908,1097.816514,1714.311927,14115.66055,1319.091743,1725.550459,2084.53211,5463.880734,1307.963303,318.6972477,2250.247706,12152.06422,371.8990826,226.9174312,715.9082569,15000.02752,423.3394495,327.146789,927.9816514,11721.84404,1655.330275,358.3302752,2813.926606,10655.85321,603.9633028,285.6788991,1116.697248,5936.211009,1001.045872,423.2110092,1304.201835,4139.477064,627.9724771,169.2752294,2468.06422,3912.678899,1527.834862,18086.95413,3141.93578,345.1100917,964.2844037,109,13.97413127,10.0533789,0.694567204,0.956140351,0.778571429,-1.520205272
+4553,20882.58252,948.776699,667.8737864,1129.815534,18802.47573,738.9126214,858.592233,1663.563107,10362.92233,674.8058252,593.3883495,1778.699029,12619.31068,1310.68932,941.2038835,1268.203883,4641.407767,1387.368932,331.9514563,2353.757282,9811.970874,429.0679612,596.1165049,578.7961165,12196.8835,570.2038835,124.2330097,942.0291262,9542.07767,1502.990291,379.9514563,2803.757282,8376.106796,757.2038835,284.6796117,1520.592233,5458.436893,950.5242718,434.9708738,1354.067961,3638.728155,717.4854369,165.8349515,2757.92233,3443.252427,1359.271845,336.3786408,3252.038835,505.0194175,965.6213592,103,12.95685448,10.40885488,0.595510718,0.953703704,0.66025641,0.919721713
+4554,31738.5,922.2555556,600.3777778,1071.388889,27283.24444,711.4555556,778.6777778,1615.3,16021.5,567.6111111,865.3555556,1750.922222,17958.53333,1341.155556,3336.055556,2392.955556,6809.733333,1258.644444,280.7888889,2330.911111,13871.92222,1308.477778,249.0777778,654.0777778,17290.1,596.0666667,122,2222.044444,13131.07778,1647.2,597.9333333,2793.177778,11594.66667,1724.477778,265.7222222,1340.211111,7851.444444,1198.144444,396.2666667,1320.333333,5592.455556,677.2,152.6,2514.7,4755.677778,1254.511111,175.9777778,3426.455556,602.4222222,964.2222222,90,13.57936627,8.54026465,0.777474214,0.967741935,0.642857143,-1.22186156
+4555,22214.58163,931.6938776,686.744898,1089.836735,20047.92857,714.5306122,905.755102,1625.867347,11024.29592,618.3163265,1923.428571,1808.173469,13788.91837,1275.530612,4082.285714,4384.040816,5118.969388,1217.081633,285.3979592,2767.408163,10294.10204,394.744898,236.5204082,1990.55102,13513.73469,1858.826531,117.3673469,1653.061224,10340.81633,1729.061224,444.6836735,2808.959184,9055.510204,700.4387755,263.4897959,1732.897959,6124.673469,1686.295918,392.2755102,1341.377551,4141.571429,642.9081633,157.8469388,3682.704082,3883.346939,1302.5,967.4489796,3273.591837,702.8571429,965.6020408,98,12.15531546,10.58686492,0.491343515,0.951456311,0.636363636,0.126901515
+4556,33119.53731,858.6791045,499.2537313,1066.276119,30062.02985,700.9104478,766.3208955,1624.335821,16228.3806,533.7089552,1635.865672,1765.858209,20301.18657,1259.19403,3626.977612,3601.597015,7444.597015,1296.455224,302.5522388,2365.932836,15655.80597,397.6716418,295.7238806,1377.940299,19828.15672,1105.552239,308.9328358,1254.156716,15739.34328,2025.619403,471.0671642,2800.358209,13371.09701,621.858209,282,1028.485075,8550.514925,1501.61194,408.8208955,1315.634328,5456.544776,644.4477612,157.7462687,3654.365672,5278.619403,1356,1758.813433,3183.902985,802.1343284,968.0447761,134,17.95873507,9.726041658,0.840651012,0.930555556,0.71657754,-0.259140508
+4557,23445.35955,1039.539326,634.8988764,1080.685393,21180.48315,800.1235955,880.6516854,1592.539326,11705.32584,625.5168539,1932.044944,1820.505618,13014.53933,1312.853933,7187.258427,4850.842697,5040.494382,1307.067416,306.9101124,2499.595506,10835.4382,434.9325843,170.6629213,2039.078652,13290.88764,1054.606742,423.752809,2803.910112,9765.044944,2009.101124,462.6179775,2802.202247,8705.101124,661.1011236,278.1011236,1383.898876,5922.426966,1529.179775,415.9662921,1327.359551,4135.932584,604.3033708,160,3402.325843,3594.067416,1259.696629,576.0561798,3376.011236,538.2921348,966.0786517,89,13.21435497,9.304195099,0.71010325,0.936842105,0.526627219,-0.723946252
+4558,43085.32039,956.5048544,566.9126214,1130.941748,38308.53398,759.7475728,691.0873786,1691.737864,19564.09709,596.184466,1473.747573,1742.776699,24701.40777,1357.359223,2467.631068,4316.747573,9225.184466,1402.796117,344.8058252,2406.009709,20433.48544,470.6699029,244.2038835,1005.407767,24981.53398,1630.553398,130.9805825,3253.601942,19714.09709,1552.524272,598.9320388,2815.92233,17763.38835,664.3009709,318.0679612,1669.495146,10397.30097,1202.184466,462.1456311,1331.15534,6695.058252,657.038835,170.1941748,3177.61165,6241.145631,1454.621359,903.7378641,3225.718447,378.7087379,967.6893204,103,13.32331203,10.1453179,0.648198788,0.919642857,0.613095238,-1.129836484
+4559,34784.71963,959.7663551,702.3457944,1138.056075,31081.85981,767.9345794,860.8598131,1716.411215,16384.2243,605.6074766,2088.214953,1779.037383,20322.74766,1391.214953,1476.074766,2616.149533,7736.934579,1501.897196,352.4579439,2553.551402,16978.37383,454.7009346,198.9252336,1078.224299,20916.52336,867.8785047,322.9813084,1561.728972,16292.20561,1768.252336,422.8130841,2854.981308,14821.56075,854.4392523,325.4953271,1663.878505,9160.64486,1325.149533,474.7570093,1343.757009,5940.728972,643.3831776,175.411215,2451.168224,5567.579439,1478.084112,526.3457944,3273.663551,393.9065421,968.2336449,107,16.86052158,8.481937749,0.864248597,0.938596491,0.548717949,-0.929611695
+4560,24510.72941,874.8294118,638.6882353,1104.476471,22956.21765,701.7176471,781.1235294,1601.270588,12167.05882,546.0470588,1082.047059,1764.417647,14768.04706,1231.429412,2175.729412,2964.829412,5506.935294,1351.041176,317.0117647,2322.058824,12062.21765,383.8823529,692.9352941,1043.152941,14915.92941,508.9352941,144.3882353,2323.505882,11677.82353,1785.6,512.7823529,2821.158824,10534.20588,685.7294118,283.9941176,1586.835294,6495.441176,1086.270588,429.8529412,1354.241176,4352.011765,768.9529412,169.6176471,3050.452941,4148.776471,1346.194118,635.8235294,3204.694118,453.0470588,969.4,170,19.77713719,11.66034003,0.807704987,0.862944162,0.588235294,-0.702925124
+4561,25851.57692,889.9038462,713.0865385,1126.990385,23674.83654,717.7403846,740.7307692,1682.817308,13230.39423,566.5096154,506.1346154,1763.038462,15604.32692,1277.442308,817.6730769,1142.673077,5919.278846,1391.298077,321.5288462,2353.913462,12644.44231,564.8365385,250.0480769,455.6923077,15949.51923,475.9615385,125.2692308,965.8653846,12032,1428.298077,390.9038462,2824.846154,10816.43269,842.4615385,292.3461538,1644.096154,7051.759615,911.1826923,437.0673077,1333.461538,4654.894231,636.6346154,169.6153846,1452.076923,4411.615385,1384.105769,352.3269231,3291.788462,483.0865385,967.9038462,104,12.75008178,10.60181269,0.555510701,0.945454545,0.666666667,-0.400779207
+4562,27806.42056,892.3364486,519.9719626,1083.457944,25033.41121,815.9345794,895.4299065,1589.934579,13856.59813,603.4953271,2199.775701,1879.626168,16985.03738,1285.813084,2724.018692,3913.345794,6450.364486,1243.523364,288.9252336,2985.757009,12871.91589,424.3457944,216.7850467,2021.878505,16513.26168,501.1028037,605.8037383,1691.794393,12620.21495,2269.308411,475.3084112,2805.990654,11199.65421,646.1028037,266.635514,1502.766355,7605.205607,1523.757009,405.7570093,1345.074766,5129.28972,632.6915888,163.2242991,3976.102804,4632.794393,1354.121495,3343.747664,3248.214953,689.9158879,969.8504673,107,19.27514608,7.609489297,0.91877463,0.849206349,0.457264957,-0.718601209
+4563,28147.05,933.725,573.3,1113.125,25241.075,827.55,798.05,1683.525,14173.35,594.475,1419.6,1861.5,16553.9,1369.675,2405.675,2242.725,6146.775,1348.175,307.4,2355.825,12900.85,1153.625,188.3,879.75,16269.05,510.125,312.95,1436.625,12249.1,1857.025,518.15,2794.425,10710.65,1238.175,282.6,1293,7186.625,1209.125,430.45,1326.65,4902.225,612.05,156.15,3053.075,4219.975,1285.5,246.025,3278.7,546.925,966.825,40,8.307496559,6.870625949,0.56214414,0.833333333,0.49382716,0.665021809
+4564,36876.07018,863.0701754,501.4561404,1054.473684,33145.63158,727.7017544,795.0350877,1646.684211,18712.54386,541.9122807,1409.666667,1817.614035,22218.05263,1265.280702,3552.964912,2819.087719,8236.192982,1347.105263,302.3157895,2293.807018,17528.15789,401.2807018,468.9649123,1632,21678.35088,791.4912281,388.3859649,924.2280702,17451.42105,2248.701754,526.8596491,2802.140351,15357.63158,591.7368421,284.4210526,973.6491228,9707.263158,1733.140351,409.4385965,1366.54386,6267.017544,711.5789474,157.4912281,3612.508772,5998.596491,1350.122807,297.7894737,3211.736842,784.0701754,966.754386,57,10.84097146,6.817767651,0.777495101,1,0.633333333,-0.831211332
+4565,27243.07143,847.3877551,527.9795918,1116.163265,23795.56122,689.6428571,741.8571429,1655.765306,13622.93878,534.1326531,901.0816327,1794.959184,15950.96939,1277.5,2661.806122,2570.244898,5684.469388,1277.571429,303.3265306,2346.632653,12112.57143,11403.07143,162.7142857,1054.683673,15627.77551,1722.122449,122.3265306,1645.265306,11511.77551,1411.714286,488.3571429,2795.306122,10061.36735,1069.510204,275.9897959,1340.755102,6751.44898,1204.816327,421.4285714,1325.336735,4643.265306,624.244898,158.7857143,4382.602041,4019.836735,1272.091837,415.1938776,3325.214286,554.1428571,970.4489796,98,15.13643601,8.54219553,0.825537985,0.867256637,0.636363636,-0.494066076
+4566,32022.43158,1137.873684,541.8736842,1089,28481.12632,660.1473684,530.6947368,1514.084211,16124.54737,522.2526316,1388.947368,1733.831579,20127.83158,1365.442105,2182.442105,2655.431579,7436.484211,1271.347368,289.6421053,2300.684211,15753.26316,382.4736842,213.4315789,1002.968421,19648.85263,654.6105263,318.9894737,899.6736842,15874.05263,1936.010526,413.2421053,2787.389474,13825.64211,585.5052632,265.1263158,1040.421053,8970,1481.957895,403.1684211,1301.136842,5929.947368,638.5894737,163.6947368,2519.757895,5694.821053,1379.357895,3137.452632,3156.831579,765.9263158,969.0842105,95,13.26239969,9.171638259,0.722326735,0.95959596,0.785123967,-0.79380187
+4567,29552.25926,800.0493827,530.617284,1055.246914,27043.87654,682.4444444,766.8395062,1535.814815,14925.08642,506.9259259,1447.753086,1799.740741,18324.25926,1199.691358,3816.962963,3187.851852,6874.938272,1273.950617,292.1111111,2319.419753,14082.79012,373.9753086,738.2716049,1618.197531,18065.17284,775.7901235,261.5802469,1051.296296,14297.67901,2366.91358,567.6666667,2783.111111,12436.79012,572.8148148,263.7160494,1009.012346,8029.17284,1334.790123,405.7777778,1385.222222,5156.802469,760.308642,153.8148148,4902.567901,5060.37037,1284.185185,396.2345679,3208.259259,791.9259259,968.9012346,81,11.66208791,9.261562049,0.607708914,0.91011236,0.669421488,-0.60102345
+4568,18688.2987,918.3636364,491.3116883,1113.922078,16956.97403,738,445.6363636,1635.233766,8218.363636,549.8051948,392.7792208,1718.168831,10696.01299,1418.220779,991.8441558,661.4025974,4053.25974,1239.636364,325.3766234,2261.584416,8679.467532,407.8571429,143.7402597,494.3506494,10770.03896,430.6883117,122.1428571,818.8051948,8313.831169,1381.155844,356.9090909,2820.909091,7149.727273,933.1298701,275.038961,955.7532468,4364.909091,784.0909091,404.5324675,1284.584416,2470.402597,627.8441558,162.0779221,1290.025974,2565.402597,1405.311688,9011.480519,3124.220779,885.2727273,967.7012987,77,14.51044492,6.884822058,0.880269769,0.916666667,0.641666667,1.566628103
+4569,41938.95745,891.4468085,485.6382979,1130,36131.34043,728.2765957,930.7234043,1653.531915,22090.44681,585.8297872,1769.574468,1763.297872,25740.59574,1314.12766,1913.319149,3456.404255,9022.085106,1407.765957,338.1489362,2435.978723,19469.85106,564.2553191,127.9361702,2196.361702,25432.17021,1431.914894,130.4893617,1424.212766,19607.68085,1536.425532,437.5957447,2807.021277,17298,731.9787234,313.3404255,1156.787234,11202.80851,1844.510638,462.3617021,1332.276596,7824.93617,635.4255319,168.1489362,2449.638298,7080.510638,1378.595745,423.0851064,3316.829787,562.6595745,969.7659574,47,9.171090678,6.801972611,0.670758942,0.94,0.746031746,0.611568653
+4570,29687.7619,925.827381,585.4821429,1075.571429,26355.5119,704.702381,802.3392857,1633.303571,15143.02381,562.7380952,1389.910714,1875.744048,17855.77976,1300.654762,4141.285714,4268.702381,6559.255952,1268.970238,287.6607143,2421.238095,13403.72619,538.3928571,112.0178571,1089.35119,17103.64286,672.1488095,122.0059524,3671.809524,13007.44643,1981.684524,489.6845238,2791.577381,11624.29762,1220.875,260.672619,1755.47619,7698.839286,1756.708333,395.8809524,1306.571429,5341.583333,611.4107143,152.577381,4779.017857,4990.880952,1324.363095,330.1607143,3303.678571,617.0535714,972.547619,168,16.87709997,13.34292614,0.612341294,0.879581152,0.581314879,-1.078778961
+4571,41966.3956,995.967033,571.8351648,1097.494505,36637.06593,771.1648352,829.2307692,1683.538462,20672.96703,607.0989011,1493.274725,1788.384615,24169.92308,1400.340659,3590.307692,3994.010989,8601.197802,1314.648352,303.7802198,2544.868132,17473.49451,418.021978,109.1868132,1279.593407,22737.05495,1452.978022,118.2857143,2118.384615,17008.48352,1773.296703,542.5824176,2782.021978,15103.08791,675.9120879,289.0989011,1293.417582,9978.802198,1523.054945,402.5824176,1301.912088,6764.010989,615.8131868,160.6923077,2675.164835,6053.483516,1334.461538,247.989011,3307.054945,646.2857143,968.8901099,91,14.10147992,9.362100633,0.747813297,0.85046729,0.551515152,1.545713877
+4572,34430.03797,896.7088608,485.5822785,1086.455696,30366.74684,743.1012658,492.6329114,1531.392405,17262.51899,626.556962,652.3164557,1705.075949,21740.72152,1417.56962,894.6455696,2428.329114,7806.670886,1320.405063,328.0506329,2292.316456,16882.58228,449.1139241,210,644.2911392,21267.17722,750.0379747,124.8607595,1467.012658,16884.37975,1460.240506,698.6329114,2785.012658,14813.22785,640.6708861,295.9873418,1718.329114,9758.810127,1022.582278,429.0253165,1315.088608,6402.240506,679.6962025,174.7594937,1913.43038,6081.632911,1610.506329,8861.696203,3209.898734,729.1139241,969.9873418,79,12.33618748,8.365883257,0.734916209,0.975308642,0.598484848,1.013776536
+4573,25918.92593,1124.918519,608.8888889,1083.103704,19159.95556,641.6,600.1111111,1472.711111,9923.140741,503.2740741,978.962963,1738.740741,13643.06667,1266.659259,4597.177778,2592.237037,4817.874074,1216.659259,293.4,2337.718519,9881.666667,368.2518519,382.2296296,888.3333333,13027.43704,1342.888889,119.7703704,1434.77037,9881.859259,1644.711111,444.7037037,2784.614815,8344.155556,772.7333333,256.9111111,989.9703704,5490.955556,1312.4,396.9555556,1312.481481,3447.348148,666.9555556,163.2962963,1813.525926,3363.577778,1333.896296,3132.859259,3240.066667,819.5777778,971.9777778,135,15.76563049,11.24373982,0.700980465,0.971223022,0.610859729,-1.147016248
+4574,17148.08571,907.4285714,1200.514286,1161.971429,12005.27143,510.9,569.7285714,1536.471429,5016.114286,449.8142857,386.6428571,1665.7,7704.557143,1017.885714,1697.214286,1356.642857,2996.328571,1142.042857,248.5285714,2309.4,6127.871429,328.7142857,518.4,478.3714286,7657.642857,465.4,101.5571429,1152.342857,5480.985714,1372.914286,329,2783.028571,4600.171429,592.1571429,214.0285714,778.9714286,2170.357143,751.5,346.4714286,1274.285714,1252.571429,625.2,139.7714286,1279.957143,1404.442857,967.7,251.9428571,3069.828571,956.7285714,968.7142857,70,9.9814382,9.124550514,0.40537185,0.95890411,0.7,1.54884996
+4575,47414.19512,972.902439,578.7682927,1138.939024,43033.52439,785.4268293,1014.95122,1750.536585,22510.7439,707.5365854,3234.731707,1897.658537,28000.4878,1406.02439,2614.060976,4452.792683,10350.79268,1499.256098,357.9878049,2945.341463,23018.04878,448.7560976,462.695122,1299.841463,28682.02439,1180.268293,315.3170732,1738.402439,22364.58537,2133.963415,465.1707317,2849.853659,20244.9878,889.5853659,339.5853659,1582.914634,12442.80488,1789.402439,487.6463415,1396.768293,7922.95122,727.195122,179.4512195,4315.231707,7455.646341,1503.792683,869.7560976,3313.707317,402.0121951,971.2682927,82,13.77397483,7.935817599,0.817346946,0.976190476,0.630769231,-1.003879036
+4576,39896.58951,976.5771605,605.1882716,1132.990741,36802.79012,785.3796296,817.0617284,1711.574074,19029.70679,687.6450617,1384.348765,1767.91358,23643.69444,1400.268519,2559.092593,4193.382716,8705.324074,1461.743827,347.6759259,2531.891975,19484.48148,435.6141975,411.2345679,1058.549383,24182.3179,641.7098765,233.3209877,2653.459877,18821.53395,1966.771605,516.3333333,2823.185185,17059.35802,807.7469136,326.4320988,1802.191358,10446.49691,1297.688272,470.6728395,1330.759259,6693.169753,722.9753086,176.058642,3272.867284,6136.694444,1503.324074,2060.104938,3263.953704,410.7808642,979.4320988,324,26.89642077,15.92225582,0.805949577,0.917847025,0.623076923,-0.428345861
+4577,32555.00926,882.962963,498.3796296,1075.972222,29718.73148,726.8240741,767.6296296,1574.407407,16966.69444,572.462963,1368.12037,1762.490741,20571.72222,1326.305556,1775.166667,3442.537037,7369.805556,1379.87037,303.2777778,2289.361111,15883.07407,427.212963,643.6203704,1150.981481,20058.77778,644.3240741,263.0555556,1231.694444,15659.51852,1847.638889,482.9722222,2808.722222,13930.24074,660.4537037,292.8333333,1312.824074,9390.111111,1276.12963,435.0555556,1316.851852,6318.546296,864.0648148,161.8796296,1977.638889,5882.935185,1404.638889,849.3240741,3212.574074,587.3888889,972.75,108,16.18104757,9.27433047,0.819443425,0.885245902,0.553846154,-0.500307446
+4578,15728.62264,777.7358491,485.6352201,1062.106918,14333.42767,623.1194969,691.1132075,1435.18239,7892.345912,510.5408805,566.3459119,1772.899371,9383.396226,1123.710692,1652.163522,1282.18239,3658.811321,1254.811321,276.8050314,2313.660377,7972.886792,344.8176101,736.2955975,610.7044025,9851.72327,480.0251572,112.8490566,1104.685535,7754.314465,1559.930818,362.3333333,2806.226415,6896.955975,748.9245283,250.2012579,1361.572327,4371.647799,791.6226415,391.754717,1344.597484,2935.427673,745.672956,157.0251572,2131.169811,2849.308176,1227.150943,620.1446541,3203.81761,439.2264151,974.4528302,159,18.9235316,10.84424227,0.81951625,0.946428571,0.668067227,-0.571495741
+4579,22469.85577,996.3365385,935.1730769,1194.788462,20525.93269,774.5192308,981.75,1749.663462,11259.30769,617.8365385,553.7307692,1789.826923,13532.25962,1364.846154,704.8942308,932.875,4808.153846,1425.605769,331.1634615,2371.538462,10626.47115,476.5769231,234.9326923,491.9711538,13098.31731,506.4038462,126.1057692,933.7884615,10063.72115,1490.240385,380.9519231,2822.451923,9012.105769,1328.923077,291.6923077,1675.057692,5973.596154,902.8076923,457.5961538,1365.980769,3927.788462,643.6923077,166.1923077,974.0480769,3618.057692,1403.932692,198.6057692,3349.432692,493.1923077,972.25,104,12.43085701,11.10255346,0.449769531,0.920353982,0.722222222,-0.274413787
+4580,28508.71831,923.084507,697.2957746,1155.577465,25310.80282,759.7323944,832.5633803,1741.661972,14646.60563,615.7323944,701.3098592,1826.774648,17625.29577,1403.690141,2310.760563,2018.732394,6336.253521,1382.873239,342.6056338,2368.309859,14224.07042,503.2676056,186.8169014,797.2535211,18553.49296,573.2535211,139.2676056,1795.619718,13477.98592,1572.309859,436.0422535,2819.15493,11827.05634,661.4647887,307.943662,1471.507042,7828.43662,931.5211268,475.6619718,1337.507042,5431.943662,631.8169014,177.4788732,2154.647887,5067.830986,1462.464789,557.5070423,3302.464789,530.8450704,971.7887324,71,11.31964066,8.338351389,0.67629939,0.946666667,0.591666667,0.857679367
+4581,39654.70103,926.6134021,507.1907216,1094.237113,34940.97423,774.0721649,672.8195876,1629.293814,20005.39691,733.8865979,1601.139175,1796.845361,23858.47938,1342.396907,2310.783505,3054.097938,8792.510309,1317.783505,314.3298969,2354.474227,18166.43814,591.3608247,293.0154639,1352.510309,23323.29897,480.1907216,253.1030928,2060.335052,18086.82474,1963.056701,450.5412371,2807.912371,15849.80928,706.7886598,288.6185567,1215.752577,10688.01546,1381.85567,419.6340206,1312.824742,7016.298969,670.4329897,166.0927835,3237.536082,6274.448454,1401.195876,1870.453608,3196.726804,676.4020619,975.5618557,194,18.27862345,14.14311677,0.633488941,0.889908257,0.638157895,0.496800357
+4582,27914.28082,953.2945205,784.8287671,1146.027397,25633.30822,767.8767123,825.9657534,1729.630137,14084.35616,592.0342466,885.2945205,1795.342466,17285.17808,1397.780822,1420.068493,2621.671233,6486.90411,1483.787671,347.1986301,2403.410959,14133.25342,491.630137,166.3013699,721.2054795,18201.74658,546.1780822,192.0205479,1590.705479,13635.37671,1691.431507,398.630137,2829.705479,12058.08219,715.2054795,313.8287671,1644.636986,7962.006849,1107.890411,469.8424658,1353.979452,5349.082192,646.3835616,177.2054795,2187.136986,5055.636986,1503.554795,204.9794521,3304.150685,516,975.5616438,146,17.1386836,11.77700623,0.726506755,0.848837209,0.591093117,0.041043911
+4583,35708.7973,956.3783784,495.7567568,1054.648649,31399.48649,723.0675676,649.3108108,1520.905405,17937.25676,620.5,821.9324324,1729.486486,21324.45946,1276.743243,2686,2217.337838,7897.054054,1275.567568,295.7027027,2325.108108,15847.94595,394.3378378,138.7702703,669.2162162,20658.25676,1745.135135,115.8378378,2394.567568,15546.41892,1445.743243,449.9459459,2788.337838,13677.48649,586.2567568,270.0945946,1138.72973,9085.108108,1096.297297,392.8243243,1301.891892,6331.783784,609.6351351,155.1486486,3503.432432,5790.351351,1309.959459,196.7837838,3337.432432,638.3918919,973.7972973,74,11.89447505,8.463037124,0.70267604,0.913580247,0.560606061,0.630779339
+4584,11140.80625,838.3625,520.43125,1078.15,9607.81875,630.84375,419.75625,1538.775,4413.58125,519.39375,349.79375,1700.1,6235.5375,1204.7375,1458.1375,754.93125,2411.7625,1149.375,271.65625,2247.06875,5092.55625,354.275,247.5625,482.225,6469.7375,482.71875,116.725,860.8375,4845.6375,1350.4125,342.31875,2816.0625,4142.4125,613.125,243.1875,1111.325,2492.20625,699.55625,376.93125,1305.61875,1463.9375,679.5,149.88125,1770.25625,1556.375,1236.875,6901.875,3142.89375,893.38125,976.7375,160,16.51893337,12.74349698,0.636292455,0.883977901,0.672268908,-0.338427148
+4585,18620.17059,884.0294118,560.0117647,1105.694118,8901.447059,609.2176471,390.7058824,1477.958824,4021.323529,686.3647059,356.1823529,1696.782353,5709.241176,1217.905882,2663.129412,1087.382353,2161.470588,1232.082353,359.8823529,2222.417647,4535.588235,348.2470588,407.1411765,473.3411765,5735.152941,386.2823529,118.1705882,1245.247059,4232.511765,1567.4,344.9294118,2775.023529,3667.152941,846.9411765,240.2411765,845.1411765,2068.776471,732.9647059,367.8,1285.964706,1234.264706,677.9882353,150.1411765,1475.811765,1387.1,1215.776471,5791.494118,3101.152941,907.5058824,975.5176471,170,16.80829025,12.91121109,0.640275426,0.960451977,0.708333333,-0.536332147
+4586,26145.07609,880.0543478,517.7391304,1107.684783,22394.51087,689.4021739,486.8369565,1624.923913,10660.19565,549.326087,610.8913043,1733.163043,14205.65217,1301.586957,2428.967391,1569.956522,5448.576087,1299.945652,324.3804348,2375.23913,11650.25,463.5217391,484.6086957,573.2934783,14296.01087,407.4782609,133.5434783,1047.956522,11005.32609,1627.01087,451.8478261,2836.445652,9805.902174,681.6195652,284.576087,1037.25,5252.369565,907.0978261,415.8695652,1311.5,3529.826087,692.8804348,163.1847826,2601.880435,3293.978261,1368.5,2855.108696,3150.945652,348.7282609,973.423913,92,14.08286403,8.610340819,0.791317439,0.929292929,0.613333333,1.343778561
+4587,17761.96552,902.4712644,886.183908,1132.988506,16519.81609,727.6091954,861.4252874,1661.08046,8787.448276,569.7241379,589.5862069,1807.091954,10652.32184,1270.091954,1519.747126,1388.62069,3836.862069,1368.666667,309.0804598,2397.54023,8698.988506,439.6666667,217.6666667,530.9770115,10434.09195,470.2183908,123.3678161,1136.816092,8177.563218,1462.057471,378.4597701,2816.103448,7552.724138,856.4712644,283.3218391,1738.563218,4840.37931,893.2413793,443.8390805,1356.114943,3207.436782,624.4022989,164.6321839,2063.218391,2950.45977,1393.873563,1697.126437,3290.298851,473.5977011,973.6436782,87,11.77279028,9.543547857,0.585538617,0.945652174,0.669230769,1.518341558
+4588,30710.27083,888.4375,484.8541667,1067.229167,26890.70833,746.6666667,632.9583333,1526.1875,15331.04167,578.9583333,1628.104167,1740.9375,19503.3125,1327.041667,1092,2307.75,7056.604167,1272.270833,317.5625,2444.041667,14454.35417,397.1875,141.3125,1622.0625,19362.16667,541.5416667,129.6666667,841.2083333,14861.33333,1805.104167,416.7291667,2819.5,12988.14583,786.8125,273,1412.9375,8681.166667,1360.6875,419.7916667,1323.083333,5895.229167,626.0833333,163.875,1643.458333,5541.125,1507.125,6532.375,3250.625,698.1041667,973.375,48,11.03704913,6.117728502,0.832323459,0.941176471,0.545454545,0.580710181
+4589,19976.32203,838.3686441,434.1186441,1055.419492,17901.80508,700.3898305,576.6864407,1499.381356,9804.978814,537.6779661,765.059322,1704.779661,12580.97881,1238.45339,811.1313559,1115.360169,4724.538136,1206.288136,284.9872881,2554.533898,9748.783898,384.8008475,125.3728814,622.7161017,12365.61441,538.6822034,115.9830508,846.7161017,9876.885593,1393.347458,476.75,2832.563559,8686.90678,975.3474576,255.5254237,2022.305085,5799.966102,865.9194915,398.690678,1314.144068,3877.84322,618.7966102,152.3601695,1291.338983,3618.576271,1417.233051,9141.940678,3221.555085,711.3983051,978.9830508,236,21.09611088,14.52540635,0.725203308,0.936507937,0.69005848,0.869890999
+4590,25086.95882,850.1470588,447.2647059,1059.970588,22307.82941,681.0588235,535.6941176,1499.547059,12279.80588,546.1,426.7647059,1692.923529,15502.74118,1298.088235,1299.958824,1541.235294,5788.464706,1233.382353,299.6235294,2264.605882,11771.11765,389.6882353,121.5352941,500.8823529,14858.13529,475.0235294,121.2235294,1282.935294,11650.65294,1340.094118,500.2117647,2799.288235,10317.07059,706.0647059,268.3588235,1447.664706,6721.382353,807.7176471,399.1764706,1294.852941,4472.747059,617.5,159.0705882,1748.182353,4227.964706,1471.364706,8099.564706,3151.864706,725.0823529,979.3588235,170,20.72181936,11.25386092,0.839672992,0.871794872,0.566666667,0.483511946
+4591,21932.21805,898.3984962,532.2180451,1089.571429,19588.85714,710.3834586,610.0676692,1565.714286,10686.43609,553.6315789,877.3157895,1758.218045,13194.5188,1472.736842,1059.736842,1774.345865,4771.112782,1270.909774,301.0150376,2351.578947,10015.78195,466.4210526,126.7518797,1096.37594,12543.12782,759.3533835,121.3909774,783.5639098,9844.218045,1480.278195,395.8195489,2787.285714,8679.842105,782.7218045,273.1503759,1188.037594,5616.007519,1953.849624,405.0902256,1296.962406,3730.947368,615.8947368,163.4962406,4019.300752,3516.819549,1413,5493.81203,3161.007519,751.3082707,976.481203,133,16.13999337,10.89202102,0.737957961,0.923611111,0.633333333,0.594741234
+4592,17323.48905,944.379562,870.8029197,1150.686131,16734.87591,745.9635036,728.6423358,1673.773723,8679.386861,570.1386861,637.9489051,1794.138686,10654.85401,1346.861314,1474.992701,1650.474453,4024.014599,1414.226277,323.4452555,2366.021898,9057.751825,440.9343066,375.0583942,548.2554745,11378.90511,540.8613139,131.0583942,1383.080292,8755.510949,1557.985401,384.4379562,2831.854015,8051.437956,971.6277372,295.0072993,1468.605839,5180.591241,983.729927,453.0364964,1365.10219,3438.817518,671.9124088,172.5766423,1688.372263,3323.547445,1445.875912,1901.635036,3259.832117,460.5255474,977.3649635,137,14.34125735,12.39189186,0.503366686,0.964788732,0.652380952,-1.028379197
+4593,28238.4878,995.8373984,661.8861789,1136.97561,26342.35772,789.1463415,786.2520325,1736.829268,14692.39837,605.8130081,486.7154472,1766.813008,17832.97561,1409.284553,740.6747967,1102.178862,6392.869919,1444.902439,349.3658537,2335.170732,14556.26829,463.9186992,171.7317073,485.9268293,18332.52846,521.8455285,134.4065041,1047.910569,14006.31707,1517.739837,384.4390244,2814.650407,12397.39024,836.1382114,316.2276423,1579.439024,8201.235772,1233.634146,477.699187,1340.04065,5423.845528,645.9349593,171.1138211,1399.707317,5015.552846,1496.756098,307.6097561,3278.056911,504.5609756,976.9430894,123,17.00543559,9.595295957,0.825604831,0.904411765,0.591346154,0.624828281
+4594,37783.94,1022.28,589.42,1120.4,33571.12,783.9,738.62,1642.28,19754.48,641.72,1199.14,1756.1,22817.98,1402.56,4785.46,3888.84,8130.64,1376.72,330.04,2360.16,17635.36,605.62,142.74,911.82,23626.3,1207.6,137.08,3035.68,17305.48,1598.86,477.04,2801.96,15147.8,721.48,306.64,1394.76,10109.64,1491.04,465.38,1329.06,6879.72,629.28,163.16,2834.34,6290.88,1415.38,348.14,3355.48,543.98,973.32,50,10.11460742,6.744621317,0.745218925,0.925925926,0.625,1.084882592
+4595,32906.04651,959.7209302,572.8837209,1083.104651,29297.67442,723.3023256,723.744186,1606.744186,16332.36047,586.3023256,1612.395349,1776.209302,19617.44186,1320.081395,2682.94186,3077.988372,7204.232558,1335.337209,324,2726.511628,14892.33721,431.8488372,128.9767442,1459.488372,19436.0814,540.1395349,121.4767442,1362.034884,14573.45349,2166.651163,505.1860465,2804.953488,12895.4186,606.5465116,266.8139535,1268.395349,8649.744186,1433.302326,413.1395349,1292.104651,5951.453488,606.6511628,159.6162791,1651.593023,5303.895349,1371.639535,240.5232558,3257.139535,650.4302326,976.244186,86,15.26599079,7.323834118,0.877406124,0.945054945,0.551282051,-0.773580319
+4596,34482.11058,1002.338073,536.3617694,1090.755134,30443.26066,759.764613,704.9810427,1582.616114,17304.05213,594.6603476,1094.690363,1742.077409,20480.40758,1351.249605,1865,3087.886256,7546.843602,1300.890995,300.28594,2345.947867,16103.35861,449.9731438,128.4154818,887.9889415,20189.65087,1026.43128,131.0884676,1913.921011,15635.36651,1590.173776,504.0315956,2794.818325,13865.77093,677.4976303,284.2037915,1633.453397,9272.486572,1285.121643,420.9352291,1320.423381,6328.483412,626.7535545,160.5165877,2810.442338,5641.494471,1384.169036,1239.398104,3286.808847,593.2306477,986.1421801,633,35.58904199,24.09694037,0.735901358,0.891549296,0.618768328,-0.910805498
+4597,31893.75472,930.4716981,512.3396226,1061.556604,28094.5,711.0943396,809.0188679,1555.462264,16162.13208,720.3584906,1955.660377,1812.207547,18955.25472,1231.273585,3203.386792,3761.849057,7141.169811,1273.45283,283.5471698,2343.933962,14281.98113,541.7075472,269.8584906,1049.160377,17858.69811,880.4433962,137.1981132,1240.90566,13695.25472,1772.367925,398.8867925,2809.735849,12096.12264,596.6981132,263.2641509,1165.367925,7970.396226,1954.820755,389.9528302,1304.820755,5522.811321,637.7735849,160.3490566,3759.188679,4796.924528,1247.311321,342.8679245,3276.584906,631.1981132,977.4245283,106,17.60722313,7.932651129,0.892759314,0.946428571,0.504761905,0.747162944
+4598,16754.77953,753.496063,447.4409449,1051.88189,14147.02362,608.2913386,368,1613.251969,6679.897638,470.9527559,357.9527559,1750.409449,9164.047244,1117.740157,1087.937008,725.6771654,3472.299213,1118.795276,270.1181102,2219.559055,7405.094488,346.8267717,117.7480315,469.1338583,9348.259843,460.519685,109.4488189,808.5984252,7022.905512,1269,349.3622047,2823.748031,6015.826772,625.488189,238.7086614,1015.637795,3619.102362,740.9055118,375.3464567,1312.19685,2125.905512,676.5984252,143.9291339,1550.346457,2152.84252,1196.96063,2209.472441,3153.889764,880.1653543,976.4330709,127,15.08610204,10.96427567,0.686870426,0.920289855,0.705555556,1.494344528
+4599,21954.07752,869.8604651,478.4341085,1112.968992,17996.36434,685.8682171,545.9302326,1700.666667,8869.976744,598.7984496,381.8062016,1745.51938,11582.29457,1255.984496,1987.023256,1100.418605,4285.054264,1263.372093,298.3255814,2273.046512,8433.542636,379.8139535,242.6434109,474.7906977,10437.96899,502.5736434,123.4263566,1165.488372,8003.511628,1359.705426,364.3488372,2831.124031,6859.751938,684.4108527,258.0310078,1073.224806,4224.054264,794.255814,404.5193798,1329.403101,2486.131783,805.2635659,154.9844961,1595.193798,2559.124031,1353.751938,5767.751938,3259.015504,853.7751938,977.9767442,129,16.26505643,10.41441972,0.768129847,0.902097902,0.632352941,1.551462345
+4600,33645.32759,944.5344828,657.8448276,1168.241379,24952.58621,676.7068966,554.7931034,1783.448276,11925.37931,542.8793103,740.1896552,1765.706897,16347.05172,1250.689655,2651.741379,2298.810345,6168.017241,1318.189655,312.7413793,2339.568966,13494.7069,1304.844828,296.2758621,547.0689655,16761.10345,464.7068966,166.5172414,1943.965517,12628.39655,1687.482759,402.0517241,2824.224138,11250.08621,677.4827586,286.0689655,1142.758621,5733.37931,915.5172414,425.8103448,1320.051724,3897.396552,638.7068966,158.4827586,4051.155172,3613.810345,1300.913793,1555.586207,3256.051724,344.4137931,979.2931034,58,13.41964055,5.925322154,0.897241051,0.892307692,0.479338843,0.881171699
+4601,32838.54128,869.1100917,587.2844037,1107.715596,29132.55046,733.2018349,861.6055046,1638.137615,16649.78899,587.293578,1357.055046,1771.926606,20073.48624,1306.211009,1537.06422,2173.009174,7405.954128,1402.669725,345.2110092,2478.495413,16318.3578,439.1376147,243.0733945,799.5045872,20912.7156,550.9449541,179.5963303,1377.495413,15812.81651,1794.431193,415.587156,2826.155963,14023.55963,702.8073394,310.9266055,1504.266055,9045.082569,1037.412844,456.0458716,1336.853211,6022.302752,639.5137615,170.5688073,2433.834862,5554.697248,1412.321101,589.8807339,3251.633028,525.4036697,982.0458716,109,14.74957965,9.938889383,0.738875275,0.879032258,0.605555556,0.498995004
+4602,39693.10965,1098.149123,625.6929825,1140.02193,35447.45175,791.8157895,789.6403509,1714.587719,20875.2193,637.5570175,1245.504386,1789.381579,24280.63596,1404.504386,1943.372807,3505.714912,8708.52193,1390.092105,332.377193,2337.20614,18733.95175,528.4035088,121.2192982,1121.631579,24163.75877,932.6008772,136.0438596,3704.600877,18473.9386,1642.008772,510.3508772,2820.307018,16249.65789,731.754386,314.4298246,1498.824561,10818.08772,1538.026316,467.4692982,1336.122807,7374.508772,634.5877193,174.6666667,1951.710526,6573.412281,1428.631579,741.9122807,3323.118421,562.7061404,981.8815789,228,22.38032952,13.55323785,0.795779064,0.908366534,0.59375,1.221908207
+4603,28623.24725,888.1483516,510.3241758,1086.692308,26030.37363,705.0989011,629.0604396,1549.884615,14329.56044,601.0714286,1158.21978,1754.120879,17659.41209,1302.318681,1684.846154,2637.428571,6564.302198,1466.478022,305.0989011,2418.126374,13660.6044,956.1043956,198.1373626,711.4615385,17852.64286,454.0714286,118.8406593,1457.230769,13576.25275,1679.901099,470.521978,2800.357143,11868.75275,653.3406593,275.4010989,1360.615385,8130.554945,1322.401099,402.7087912,1310.565934,5577.725275,642.2252747,159.0989011,2904.93956,5029.950549,1389.461538,1117.725275,3185.82967,656.5659341,982.8241758,182,21.19897073,11.31836521,0.845540635,0.923857868,0.631944444,-0.62222065
+4604,29247.10924,899.4957983,477.1176471,1075.445378,26390.84034,732.5042017,547.8907563,1501.462185,14963.38655,561.7983193,1035.579832,1681.361345,18237.94958,1357.277311,834.5462185,1561.285714,6515.134454,1265.932773,312.9747899,2500.907563,14303.47899,413.9243697,162.8235294,981.8319328,18155.88235,501.2941176,126.1848739,844.0840336,14431.94118,1667.302521,418.4117647,2839.781513,12613.97479,819.7731092,281.9327731,1350.554622,8325.109244,1312.932773,420.1344538,1300.319328,5691.352941,632.2268908,165.3193277,1467.495798,5147.857143,1507.336134,7293.420168,3195.823529,692.6722689,980.0588235,119,14.79595037,10.59308877,0.698156541,0.944444444,0.619791667,1.570425729
+4605,24017.18248,911.5474453,470.9854015,1083.379562,21616.44526,728.3576642,584.8613139,1568.445255,11952.86861,579.4525547,1233.708029,1748.868613,14600.82482,1354.781022,1500.131387,1732.416058,5236.722628,1238.905109,301.0291971,2275.773723,11238.36496,411.729927,163.4160584,1057.138686,13905.54745,1017.948905,121.3722628,791.1167883,10955.18248,1359.350365,447.9489051,2812.890511,9715.467153,837.7591241,272.810219,1378.890511,6271.10219,1565.824818,399.8686131,1317.605839,4118.277372,728.6861314,159.6277372,2248.467153,3884.992701,1863.007299,9812.50365,3212.474453,740.5620438,981.4014599,137,14.87875673,11.75466154,0.613068413,0.971631206,0.761111111,-0.40889353
+4606,17214.41333,939.5066667,1407.746667,1188.34,11601.85333,607.92,704.2266667,1731.3,4902.76,527.7933333,685.28,1707.8,7523.966667,1100.2,4488.226667,2446.813333,2798.5,1124,264.7533333,2359.68,6059.626667,372.7333333,303.6266667,1115.846667,7668.073333,465.42,109.2466667,3011.233333,5541.113333,1702.006667,323.32,2788.653333,4528.833333,704.0266667,229.22,1005.726667,2326.593333,841.7866667,364.3066667,1330.973333,1384.32,604.8,140.6866667,1959.18,1517.966667,1033.946667,430.0733333,3245.386667,935.0933333,981.4666667,150,15.4650461,12.55528548,0.583867158,0.925925926,0.669642857,0.313876173
+4607,32141.94656,911.6793893,590.3358779,1101.687023,29897.94656,752.0839695,711.8778626,1658.412214,14990.74046,705.0229008,1773.419847,1832.160305,19346.9771,1329.717557,3532.648855,3526.51145,7261.564885,1368.931298,337.9770992,2466.587786,16133.93893,431.8931298,792.2977099,1468.229008,19935.70992,734.8015267,492.4122137,2485.801527,15740.29771,2087.305344,417.6946565,2879.129771,14371.0687,923.5496183,311.5572519,1710.022901,8627.534351,1230.908397,455.2824427,1374.435115,5450.305344,807.2290076,174.6641221,5725.038168,5163.625954,1436.961832,1116.061069,3265.923664,394.3435115,980.6717557,131,14.99517857,12.11357981,0.589413292,0.873333333,0.592760181,-1.378078565
+4608,38554.12782,964.556391,576.7894737,1144.458647,34739.72932,776.8646617,778.1503759,1740.338346,19985.11278,617.3233083,1089.413534,1761.451128,23185.64662,1381.533835,2765.962406,3699.413534,8545.037594,1388.225564,347.5714286,2314.699248,18872.67669,467.4887218,129.6390977,912.6015038,24393.28571,545.3082707,135.3909774,2567.81203,18067.15789,1706,479.9022556,2816.669173,16129.74436,901.8646617,318.0676692,1685.37594,10627.96992,1137.045113,477.4736842,1336.398496,7229.616541,637.9022556,171.2180451,2330.503759,6424.518797,1452.428571,919.4887218,3316.233083,537.0526316,980.4586466,133,16.95280339,11.71420094,0.722865257,0.768786127,0.511538462,-1.553801934
+4609,38333.77027,989.472973,488.8243243,1079.972973,34099.68919,754.4324324,636.8783784,1583.864865,19325.08108,689.2567568,845.9324324,1735.405405,23316.14865,1329.297297,1881.094595,3030.945946,8515.013514,1306.864865,299.0945946,2443.27027,17833.59459,419.8648649,232.1486486,715.2837838,22868.71622,437.0945946,134.3783784,1853.391892,18004.10811,1637.743243,517.8108108,2780.202703,15632.75676,612.0810811,271.8243243,1365.202703,10407.21622,954.8783784,408.7027027,1322.648649,6970.959459,626.4324324,157.3378378,2218.797297,6313.094595,1371.932432,643.3243243,3228.621622,667.6486486,981.6351351,74,11.72959217,9.434732846,0.594151685,0.850574713,0.560606061,0.119155367
+4610,24509.74419,866.1472868,449.379845,1072.48062,21887.49612,694.1472868,689.7286822,1533.976744,11778.97674,549.8139535,1153.333333,1704.728682,14676.70543,1313.837209,1857.875969,1904.062016,5310.255814,1247.565891,301.8837209,2276.069767,11303.43411,394.4186047,150.3953488,1323.930233,14152.79845,894.5581395,123.9457364,858.8837209,11280.11628,1459.751938,389.1550388,2788.356589,9858.069767,629.6976744,275.1937984,1168.651163,6339.945736,1813.100775,406.3565891,1307.728682,4177.852713,677.5891473,162.9767442,1942.612403,3961.612403,1490.573643,7297.449612,3180.837209,764.4263566,980.620155,129,14.62901145,11.3273966,0.632805902,0.948529412,0.767857143,-1.072385461
+4611,37035.9604,1047.138614,590.1584158,1161.138614,30066.13861,767.8415842,611.1584158,1861.970297,13997.10891,597.039604,1021.059406,1823.712871,18939.75248,1362.465347,5775.069307,3139.970297,6688.90099,1360.712871,327.6633663,2579.712871,14266.11881,851.049505,773.5445545,653,17582.87129,488.3366337,214.5544554,2702.287129,13179.44554,2287.60396,550.2475248,2818.217822,11418.90099,678.1485149,290.950495,1244.475248,5960.940594,1114.60396,428.960396,1315.564356,3880.267327,739.0594059,173.7821782,4059.376238,3557.544554,1333.039604,2032.821782,3311.930693,356.4356436,981.009901,101,15.22737015,8.775526024,0.817238563,0.89380531,0.573863636,-1.097814081
+4612,23932.78218,848.9207921,438.8910891,1062.70297,21269.93069,674.5346535,715.3861386,1532.574257,11710.29703,577.8019802,1619.118812,1751.089109,14045.29703,1198.376238,1755.455446,2560.881188,5478.762376,1322.950495,282,2324.534653,10505.35644,3962.891089,315.9405941,727.2277228,13436.14851,635.980198,124.3366337,1043.168317,10006.58416,1510.663366,418.7326733,2784.366337,8978.782178,639.3168317,260.3168317,1237.722772,6112.108911,2127.356436,389.3168317,1304.851485,4106.554455,673.8217822,162.2376238,3753.287129,3710.168317,1293.445545,548.5940594,3160.831683,625.5544554,983.4059406,101,14.73858176,9.385635679,0.771023041,0.870689655,0.485576923,0.601300238
+4613,45517.61538,939.0384615,505.1923077,1112.576923,36136.93269,746.3365385,730.25,1623.182692,21109.82692,563.1826923,1277.259615,1792.115385,24461.21154,1308.653846,2651.076923,3764.548077,9139.663462,1319.365385,292.375,2329.557692,19099.46154,471.3076923,127.3461538,1519.951923,23949.75962,654.2019231,262.5288462,1714.221154,18315.82692,2211.221154,468.0192308,2804.278846,16393.17308,659.3461538,291.5865385,1410.923077,11062.45192,1474.826923,416.4807692,1297.663462,7560.163462,679.7403846,154.5769231,1892.711538,6688.740385,1373.413462,288.5288462,3264.913462,611.9134615,983.1346154,104,13.91267721,9.924171902,0.700839872,0.920353982,0.615384615,1.067161883
+4614,32587.08696,957.5565217,744.2869565,1124.008696,14413.66087,550.373913,480.9043478,1563.565217,6210.895652,437.6695652,1101.991304,1699.626087,8585.147826,999.2521739,2221.252174,1902.373913,3125.434783,1024.486957,240.2521739,2251.513043,6394.495652,1038.104348,136.5826087,1242.191304,8022.017391,736.8,105,1221.991304,5708.121739,1647.417391,317.5826087,2788.556522,4681.921739,1773.773913,220.8782609,815.9913043,2314.347826,1225.217391,343.2086957,1293.078261,1337.834783,530.3478261,133.573913,1736.982609,1438.252174,991.8782609,367.1217391,3055.573913,920.8608696,982.9826087,115,12.78275393,11.57695023,0.423984404,0.942622951,0.737179487,1.25267039
+4615,36493.87709,1058.653631,651.1787709,1153.005587,31280.84916,817.2402235,734.5810056,1885.117318,15146.29609,611.8547486,1852.346369,1834.100559,19939.02793,1412.586592,5803.335196,5714.547486,7107.061453,1375.424581,339.2793296,2587.156425,15792.51955,414.5586592,302.4748603,1181.675978,18919.72067,817.2067039,201.0055866,7667.882682,14824.68156,2595.296089,420.9050279,2833.050279,12908.61453,650.972067,311.6256983,1560.681564,7001.078212,1599.407821,444.2793296,1315.413408,4503.597765,673.4804469,174.5139665,4060.921788,4094.357542,1431.027933,6412.01676,3268.832402,371.4301676,988.2849162,179,21.42057042,11.23865836,0.851307779,0.8647343,0.608843537,0.252846224
+4616,27603.19527,913.8047337,625.8698225,1106.982249,25038.32544,749.2840237,805.9585799,1643.331361,13305.97041,590.1656805,1314.485207,1762.727811,16051.24852,1281.721893,2249.609467,3377.272189,5892.16568,1352.668639,322.6804734,2376.408284,13196.65089,413.1538462,819.8934911,1073.934911,16613.0355,1035.893491,127.3313609,1716.840237,12809.4142,1671.822485,425.1775148,2816.704142,11438.70414,699.556213,289.1656805,1385.236686,7060.934911,1392.390533,440.0828402,1361.923077,4623.905325,813.5798817,168.7337278,3147.621302,4459.325444,1389.242604,1323.763314,3231.461538,447.3550296,985.3727811,169,15.19747043,14.69424939,0.255201688,0.960227273,0.584775087,-0.19611786
+4617,29962.81132,886.7169811,561.8773585,1136.764151,27727.74528,730.1981132,741.0283019,1642.811321,15136.99057,597.6603774,1353.367925,1838.311321,18063.34906,1322.773585,1644.188679,3053.971698,6800.377358,1364.773585,330.1603774,2365.981132,14473.08491,554.5188679,202.3396226,829.7264151,18527.67925,460.4150943,130.1886792,2319.688679,14082.78302,1670,475.8113208,2806.858491,12253.09434,645.0377358,302.6886792,1641.839623,7959.481132,1500.433962,450.3396226,1335.018868,5110.273585,652.6603774,172.8018868,2812.339623,4859.415094,1418.981132,393.7075472,3248.283019,489.9811321,983.3490566,106,12.25663057,11.92939348,0.229531557,0.913793103,0.582417582,0.149011361
+4618,32410.18987,958.4683544,554.3797468,1110.873418,28354.96203,812.9367089,600.9493671,2033.417722,13549.65823,558.7974684,483.8227848,1859.708861,17460.62025,1277.443038,2260.101266,2354.556962,6321.012658,1241.64557,307.9873418,2257.64557,14021.10127,393.9620253,163.443038,564.4556962,17022.6962,510.9620253,122.9367089,2269.683544,13321.56962,1401.594937,367.1012658,2771.329114,11379.3038,617.4303797,276.4683544,1108.063291,6630.607595,1063.278481,407.0253165,1305.734177,3768.088608,1980.329114,156.2025316,1079.151899,3876,1289.291139,1028.835443,3330.607595,865.8987342,983.1518987,79,11.38897086,9.10062558,0.60123326,0.877777778,0.658333333,-0.495097128
+4619,21257.15504,1159.410853,608.751938,1106.193798,18522.27907,762.1007752,470.7209302,1661.294574,8465.984496,663.8914729,545.0077519,1717.108527,11289.65116,1354.697674,3376.170543,2150.75969,4111.302326,1456.596899,335.0155039,2260.44186,9058,386.4573643,643.6821705,493.7364341,10617.66667,447.2403101,122.0077519,2457.860465,8324.829457,1636.806202,355.2713178,2807.124031,7440.697674,618.1550388,258.2248062,1082.263566,3696.984496,838.0930233,393.6821705,1306.705426,2532.472868,716.8914729,155.5736434,1804.403101,2372.124031,1260.72093,11432.96899,3325.697674,339.6821705,986.5813953,129,15.07862773,11.02630491,0.682105399,0.984732824,0.671875,0.476935407
+4620,33330.48416,1000.579186,601.1900452,1120.597285,30028.81448,779.8190045,754.0859729,1636.217195,16013.58824,615.2895928,1632.013575,1775.443439,19060.99095,1406.158371,2015.873303,3577.515837,6884.176471,1423.529412,340.9004525,2578.036199,15486.70588,421.2850679,566.918552,988.2488688,19479.69231,1016.538462,142.2850679,1749.59276,15039.17195,1873.049774,469.8868778,2819.117647,13185.29412,676.5429864,305.7420814,1410.687783,8131.904977,1464.321267,456.4524887,1360.40724,5279.076923,745.5067873,175.1266968,4070.316742,4706.434389,1442.941176,1609.434389,3204.226244,426.3031674,986.1447964,221,20.01908669,14.31514432,0.69904795,0.928571429,0.701587302,1.552937516
+4621,18342.96988,796.6927711,485.5722892,1070.138554,16640.90964,671.8975904,505.9457831,1752.421687,7538.018072,543.2891566,369.5421687,1818.373494,10349.04819,1164.674699,1756.331325,1281.789157,3889.253012,1182.566265,288.2168675,2218.554217,8253.198795,377.4036145,212.8855422,495.253012,10406.39759,458.373494,114.4277108,877.8253012,7923.644578,1362.771084,342.4518072,2827.343373,6742.26506,648.6445783,257.2289157,1102.475904,4013.722892,1001.379518,384.9277108,1314.289157,2320.114458,2266.53012,149.4277108,1573.144578,2412.445783,1281.554217,1573.319277,3218.722892,877.3554217,987.8192771,166,16.38974195,13.58112849,0.559787954,0.869109948,0.610294118,0.787374397
+4622,28582.4898,983.2857143,780.1326531,1148.704082,25881.66327,819.622449,866.9591837,1720.061224,14639.37755,611.5510204,775.5,1766.693878,17860.65306,1424.27551,835.9081633,1186.153061,6281.173469,1446.653061,346.0306122,2351.520408,14324.09184,484.4387755,249,587.6938776,18539.40816,526.9081633,142.6734694,965.5816327,14458.28571,1645.418367,407.9387755,2813.265306,12701.61224,663.4795918,319.9387755,1814.816327,8265.642857,1060.816327,473.744898,1357.071429,5333.244898,659.2040816,178.8367347,1855.938776,4976.714286,1506.316327,919.5714286,3266.918367,499.6836735,986.3979592,98,12.19855848,10.57717136,0.498162461,0.960784314,0.628205128,-0.37243689
+4623,40237.03896,1158.805195,582.5974026,1120.753247,35786.66234,829.987013,740.7662338,1680.61039,20962.05195,690.038961,1505.636364,1829.727273,23755.48052,1435.454545,2265.883117,3449.077922,8677.428571,1411.155844,345.4285714,2391.649351,18529.42857,472.6103896,126.7922078,1732.753247,24424.68831,705.3376623,128.038961,1843.090909,18024.5974,1716,464.8961039,2810.818182,15841.5974,647.4935065,321.987013,1505.532468,10487,1323.74026,459.4025974,1323.038961,7071.922078,617.8831169,173.8701299,2036.168831,6072.948052,1364.831169,418.4155844,3293.181818,544.7792208,985.5714286,77,15.29365729,6.675866527,0.899698384,0.905882353,0.458333333,-0.910946946
+4624,33969.64948,969.8556701,590.9072165,1121.092784,31070.16495,782.2268041,799.0103093,1770.226804,14604.10309,618.556701,2259.072165,1835.948454,19288.40206,1395.020619,3127.381443,4913.649485,6950.71134,1355.546392,342.7319588,2328.556701,15570.64948,413.7113402,344.1958763,1364.268041,19117.06186,1613.298969,137.5051546,2948.113402,15033.51546,1965.917526,400.371134,2849.917526,13220.64948,740.7319588,307.9381443,1562.783505,7440.43299,2289.082474,449.6597938,1319.298969,4742.907216,691.3298969,173.0927835,3906.721649,4477.85567,1407.71134,1444.484536,3259.113402,382.6907216,985.9896907,97,11.40745037,10.9642243,0.276040819,0.950980392,0.801652893,-1.303586541
+4625,28473.82456,936.5877193,1187.052632,1203.77193,26213.5614,775.2719298,1041.45614,1777.596491,14191.84211,676.7105263,1161.210526,1861.605263,16941.84211,1325.385965,1542.780702,2155.692982,6306.482456,1463.587719,327.4912281,2448.692982,13883.02632,475.7631579,290.5,656.4385965,17380.10526,477.7280702,141.877193,1318.122807,13571.18421,1677.95614,392.7982456,2809.973684,12001.61404,645.5438596,304.0789474,1659.517544,7573.824561,1252.245614,467.5350877,1396.526316,4901.526316,675.6578947,170.5614035,2876.877193,4592.096491,1432.394737,479.9824561,3333.105263,480.4649123,987.4210526,114,14.00742364,11.08922483,0.610951926,0.926829268,0.674556213,0.587242253
+4626,16918.83019,928.7672956,529.3710692,1069.81761,14438.04403,631.327044,555.1698113,1687.006289,7019.157233,498.3773585,367.5597484,1806.27673,9215.886792,1144.591195,1838.559748,1580.377358,3558.45283,1149.886792,275.7421384,2240.716981,7104.930818,407.6415094,219.3962264,492.6352201,8863.295597,446.0062893,113.2138365,799.572327,6874.786164,1303.591195,343.7987421,2799.704403,5971.591195,692.0251572,245.3836478,1155.069182,3658.886792,1293.836478,374.5283019,1293.471698,2185.36478,3266.213836,148.4465409,937.5345912,2220.106918,2198.503145,648.1949686,3283.672956,840.9559748,989.3836478,159,20.52762709,10.4190973,0.861613692,0.883333333,0.557894737,0.389340086
+4627,40225.87037,1108.796296,599.962963,1159.611111,37519.40741,874.4814815,662,1959.277778,18284.75926,633.1111111,1167.333333,1871.148148,24142.01852,1546.222222,5434.166667,3673.388889,8650.425926,1473,365.7407407,2419.62963,20862.77778,448.8703704,212.3518519,1252.407407,24390.77778,517.3148148,161.037037,5594.074074,19901.94444,2479.666667,409.8333333,2871.351852,17660.46296,666.2222222,339.2222222,1377.5,9241.722222,1430.240741,472.5,1328.462963,6124.537037,675.037037,181.9259259,3011.37037,5542.666667,1465.148148,5779.851852,3332.222222,362.3518519,986.6481481,54,9.829844386,7.822425832,0.605581512,0.830769231,0.490909091,1.348806411
+4628,32955.73184,898.0223464,678.0391061,1121.117318,30194.19553,826.7206704,920.2905028,1691.73743,16130.93296,562.2178771,1576.486034,1847.77095,19270.97765,1299.061453,2181.134078,3219.938547,7344.273743,1379.273743,325.3854749,2389.944134,15861.11732,425.9050279,146.7206704,1429.128492,20241.48045,450.4469274,460.8994413,2104.407821,15786.26816,1924.692737,426.877095,2814.452514,13803.69832,667.4357542,300.3687151,1636.49162,8557.01676,1123.22905,454.2346369,1341.206704,5519.731844,623.4022346,172.3687151,2829.178771,5257.73743,1401.569832,677.8938547,3287.22905,467.0558659,989.0726257,179,18.03291961,13.03018141,0.691289955,0.92746114,0.745833333,-0.986761788
+4629,27051.03488,921.9186047,689.3023256,1114.546512,24932.9186,745.0581395,767.5116279,1606.848837,14093.18605,655.2093023,1061.744186,1771.930233,17098.2093,1329.372093,1185.674419,2808.093023,6046.534884,1421.069767,329.6511628,2667.44186,14484.9186,455.2209302,504.1627907,611.6511628,17815.47674,853.0465116,138.2093023,1653.790698,14207.22093,1593.325581,488.744186,2794.511628,12889.38372,725.8372093,301.3139535,1981.186047,8277.104651,1132.104651,461.8372093,1393.046512,5440.627907,709.244186,174.872093,4113.046512,5047.813953,1436.430233,212.255814,3229,511.9186047,988.0697674,86,11.91101989,9.365423853,0.617867444,0.966292135,0.651515152,-0.845395784
+4630,32577.86207,1132.212644,616.637931,1108.293103,29290.67241,827.3908046,668.3793103,1628.166667,17162.43678,716.6149425,1586.706897,1779.672414,19486.66667,1492.597701,1748.275862,2589.954023,7082.58046,1498.235632,374.8275862,2286.867816,15328.94253,474.9655172,188.8908046,1541.95977,20064.76437,1067.408046,155.4310345,1194.431034,14906.57471,1746.482759,438.2126437,2799.95977,13378.32759,704.5632184,312.1034483,1374.103448,8878.643678,1637.333333,462.6149425,1331,6013.097701,652.9597701,171.2183908,1687.787356,5113.189655,1463.373563,826.7183908,3229.413793,554.9425287,993.1264368,174,18.02559045,13.8800043,0.638023823,0.820754717,0.511764706,0.191870624
+4631,25876.89394,1043.69697,533.5909091,1111.136364,22905.68182,719.4393939,509.8181818,1749.727273,10923.56061,550.9393939,375.2575758,1793.060606,13798.0303,1230.863636,2065.136364,1624.19697,5199.166667,1211.818182,294.9090909,2255.606061,9965.80303,458.2878788,242.6060606,468.9545455,12037.15152,433.5,118.2272727,815.030303,9467.151515,1342.590909,340.4545455,2846.484848,7991.606061,820.7272727,252.3333333,995.1818182,4656.045455,1021.030303,384.1212121,1297.287879,2783.454545,2983.212121,150.6363636,630.6969697,2694.30303,1419.393939,294.6666667,3347.378788,849.4090909,987.0454545,66,10.42914275,8.473190957,0.583026338,0.929577465,0.733333333,0.158519027
+4632,15512.18824,863.0784314,465.1333333,1061.980392,14198.62353,653.4784314,714.2156863,1563.686275,7088.4,509.3372549,381.5254902,1746.423529,9279.407843,1184.882353,1256.478431,1302.568627,3424.223529,1228.670588,271.0509804,2240.466667,7068.380392,369.2431373,251.3058824,496.772549,8961.709804,422.3921569,109.5058824,895.6823529,6944.172549,1293.552941,379.0156863,2798.160784,5998.164706,703.945098,248.4509804,1160.396078,3835.4,859.0156863,381.6313725,1310.25098,2370.384314,1659.458824,147.4431373,1047.494118,2291.517647,1414.933333,4346.568627,3248.521569,805.5960784,993.9372549,255,22.11843369,14.86011529,0.740693564,0.95505618,0.639097744,-0.706807834
+4633,19998.8125,1073.5625,582.875,1066.84375,17639.47917,624.9479167,482,1519.09375,8683.354167,563.1354167,408.9479167,1761.75,11657.375,1223.010417,1927.71875,1872.947917,4543.135417,1216.239583,294,2248.875,9287.145833,419.6875,457.8020833,479.0729167,11300.16667,414.9270833,114.1041667,1354.135417,8956.354167,1312.166667,347.59375,2789.729167,7612.40625,632.59375,238.7291667,1043.479167,4712.71875,912.6041667,376.0625,1318.760417,2791.604167,1781.541667,149.4270833,974.3333333,2800.739583,1309.760417,477.7291667,3196.947917,857.6666667,990.21875,96,14.07573667,8.765285762,0.782442327,0.923076923,0.685714286,-0.021991853
+4634,14419.2891,1471.890995,713.7582938,1051.189573,13152.18957,604.1658768,400.9336493,1369.488152,6420.308057,522.2274882,402.7535545,1689.563981,8081.327014,1130.781991,1145.966825,721.8815166,3249.488152,1142.819905,259.7488152,2252.127962,7149.232227,320.1611374,115.9952607,446.9004739,7759.914692,398.1137441,108.9336493,1192.625592,6678.601896,1400.412322,300.7962085,2871.199052,6016.511848,550.1563981,240.507109,1038.407583,3003.270142,738.5545024,367.8056872,1289.440758,2005.777251,563.7393365,145.5876777,1326.848341,1949.772512,1400.094787,25946.59716,3341.630332,356.6161137,994.2274882,211,23.48486707,12.03333589,0.858754777,0.929515419,0.586111111,0.94201743
+4635,18145,909.8907563,563.4201681,1062.789916,16912.13445,763.605042,724.9327731,1561.94958,8768.890756,538.605042,1591.957983,1767.436975,10744.14286,1242.932773,2162.798319,2818.008403,4011.378151,1262.07563,341.697479,2421.436975,9281.714286,468.2689076,242.9243697,1373.655462,11296.79832,457.2689076,140.512605,1348.403361,8882.680672,2026.756303,370.2352941,2788.815126,8053,727.9243697,281.0504202,1407.058824,5034.605042,1529.588235,419.0420168,1327.705882,3284.02521,620.8991597,163.7983193,2585.705882,3121.310924,1341.705882,2449.436975,3262.193277,454.605042,994.6722689,119,15.91924448,10.1870029,0.768443629,0.9296875,0.583333333,-0.295852439
+4636,24343.05814,878.8372093,429.8604651,1056.430233,21932.0814,704.6046512,692.0465116,1527.511628,12207.96512,587.1627907,1009.116279,1726.732558,14629.30233,1257.44186,1482.593023,2491.953488,5575.5,1346.313953,298.8953488,2289.906977,11219.04651,906.7790698,367.5348837,872.9651163,14187.39535,543.8023256,120.3953488,919.4534884,10732.60465,1546.290698,408.9418605,2807.77907,9773.05814,650.755814,264.2209302,1170.674419,6656.348837,1642.418605,403.8953488,1307.895349,4484.906977,1210.023256,154.2674419,1849.569767,4047.790698,1323.290698,235.6046512,3191.05814,620.4302326,991.627907,86,12.54936636,8.930574235,0.7025489,0.966292135,0.661538462,0.376214616
+4637,18563.89147,777.5503876,424.3255814,1057.03876,16709.29457,635.2015504,482.8449612,1491.186047,9120.596899,495.3643411,559.6744186,1714.922481,11368.70543,1188.023256,772.4728682,786.1937984,4218.883721,1149.542636,272.1085271,2295.666667,8911.604651,409.7751938,101.6666667,545.0852713,11387.66667,458.9069767,113.2635659,784.5193798,8926.20155,1293.426357,391.5503876,2823.139535,7845.542636,583.9844961,249.0542636,1330.550388,5198.550388,795.7751938,373.3488372,1302.868217,3398.775194,598.4031008,150.9534884,1682.883721,3186.108527,1334.968992,3561.581395,3148.674419,691.1782946,991.0930233,129,18.33824442,9.036944513,0.870147005,0.969924812,0.632352941,-0.991914304
+4638,34855.51415,935.5283019,603.6698113,1117.721698,31312.39623,743.2641509,755.9433962,1615.985849,17250.98585,641.259434,1368.396226,1771.79717,20645.28774,1343.042453,1893.820755,3588.641509,7736.919811,1453.051887,348.0896226,2416.514151,16871.28774,441.8632075,262.9386792,979.4811321,21848.32547,1191.415094,168.0943396,1726.396226,16318.0283,1625.632075,536.3396226,2818.966981,14545.54245,773.5660377,308.2830189,1482.174528,9319.5,1233.481132,453.3537736,1338.735849,6188.075472,650.3584906,172.2877358,2334.830189,5712.495283,1430.443396,285.1132075,3232.523585,525.2924528,994.5330189,212,20.80119338,14.41042333,0.721159497,0.85483871,0.531328321,1.129784248
+4639,25210.30328,929.3606557,472.1147541,1056.131148,22437.45902,714.6065574,525.4836066,1492.393443,12480.44262,648.3688525,449.2459016,1733.360656,15168.51639,1315.254098,2446.811475,1840.614754,5667.581967,1238.229508,300.852459,2265.745902,11589.84426,389.7704918,229.1967213,511.3442623,15061.94262,423.4344262,123.1967213,2616.778689,11570.52459,1371.336066,425.5,2792.131148,10088.7377,670.0327869,269.3852459,1549.52459,6873.5,801.4344262,395.5901639,1300.631148,4573.442623,633.057377,165.057377,2597.368852,4157.803279,1430.704918,4797.836066,3186.008197,668.557377,991.8032787,122,15.30084708,10.63395828,0.719017976,0.93129771,0.677777778,1.117444965
+4640,21579.25871,741.0447761,420,1046.60199,18699.83582,607.0995025,553.1343284,1472.79602,10187.0796,487.9651741,429.2736318,1686.338308,13060.47264,1134.716418,1189.014925,1148.681592,4921.930348,1154.771144,259.8258706,2261.716418,9734.154229,362.7562189,95.15422886,529.9850746,12615.25871,508.4129353,111.840796,1231.676617,9804.621891,1266.512438,429.7711443,2813.507463,8522.651741,675.4726368,275.7263682,1670.626866,5576.716418,763.2039801,379.5323383,1300.313433,3587.40796,614.8109453,148.9004975,1385.074627,3381.084577,1254.452736,945.7512438,3149.736318,701.6616915,996.6467662,201,19.76914188,13.40454249,0.735012241,0.971014493,0.755639098,-0.247941512
+4641,27216.38,885.97,493.4,1089.92,23605.42,691.16,548.68,1721.77,12044.92,529.51,393.3,1772.36,15645.29,1233.53,1551.32,1592.3,5866.11,1213.31,296.4,2246.46,12641.86,491.92,224.35,484.42,15533.91,436.7,115.07,906.33,12222.65,1342.57,355.94,2818.23,10538.6,793.04,262.11,1095.35,6338.16,1036.27,397.64,1306.25,3787.17,3283.12,147.3,787.15,3773.77,1646.06,414.74,3249.43,832.22,992.8,100,14.15914562,9.584581121,0.736058398,0.917431193,0.591715976,0.778887041
+4642,19826.35052,776.4948454,427.0412371,1039.958763,17419.50515,666.7628866,484.1649485,1458.56701,9453.412371,500.2783505,420.6494845,1711.43299,12321.96907,1194.474227,892.8041237,1142.752577,4572.56701,1176.443299,281.4020619,2256.113402,9695.938144,391.0721649,90.93814433,528.6701031,12480.81443,570.2989691,114.4639175,901.4020619,9642.329897,1285.628866,461.9072165,2778.278351,8501.082474,686.4123711,262.443299,2315.072165,5623.804124,761.0824742,403.8453608,1313.402062,3636.041237,628.0206186,153.742268,2004.56701,3509.494845,1371.319588,5481.618557,3284.092784,714.5463918,992.1649485,97,14.70653218,8.844050003,0.798971548,0.923809524,0.76984127,1.533417374
+4643,27688.27331,940.9228296,737.7909968,1117.585209,20927.59807,638.7395498,827.5337621,1608.073955,9149.884244,492.7106109,1727.237942,1741.787781,13574.9582,1174.115756,3763.932476,3030.07717,5089.051447,1163.305466,282.562701,2423.395498,10723.23473,391.6398714,228.8199357,1287.996785,13758.45016,1250.909968,176.4758842,1782.697749,9966.266881,1845.649518,336.681672,2791.311897,8378.241158,671.8938907,255.2411576,942.5369775,4223.18328,1604.170418,380.5209003,1298.736334,2438.646302,596.2379421,148.755627,1922.88746,2611.617363,1166.530547,1447.987138,3184.897106,912.2829582,995.5016077,311,26.43935848,15.26151902,0.816583532,0.933933934,0.747596154,-1.46424017
+4644,36128.08392,990.3356643,619.8811189,1126.706294,35322.4965,818.5174825,919.4055944,1751.657343,15841.65734,710.993007,1443.811189,1832.818182,20709.12587,1390.867133,3460.944056,4112.41958,7435.447552,1367.741259,343.5384615,2397.965035,16638.58741,415.4825175,828.0839161,991.1258741,20553.20979,733.9300699,211.0559441,3313.685315,16154.94406,2210.734266,413.5454545,2818.895105,14331.01399,712.1678322,304.027972,1391.517483,7778.496503,1446.958042,438.2377622,1356.79021,4851.384615,805.2797203,166.1118881,3747.356643,4608.097902,1387.363636,595.4055944,3277.573427,388.2027972,995.1538462,143,16.12372549,11.62688931,0.692826422,0.928571429,0.647058824,-1.298963949
+4645,21073.84,1165.1,853.335,1131.56,18409.25,744.48,743.245,1632.785,9723.18,629.23,957.815,1803.945,12230.165,1326.59,2579.54,2718.73,4522.475,1621.645,307.39,2407.84,9888.085,550.84,579.465,681.535,12774.725,766.945,129.195,3211.785,9828.39,1681.13,401.12,2813.64,8665.56,633.925,269.055,1379.41,5248.375,1204.85,427.01,1341.885,3364.01,765.045,161.575,5626.93,3295.025,1313.455,485.04,3375.48,440.08,999.385,200,22.6797008,12.09450997,0.845942153,0.884955752,0.634920635,0.359098046
+4646,33260.83696,932.4347826,489.7065217,1086.217391,29530.21739,729.4456522,847.5652174,1606.336957,16957.88043,602.5869565,1449.423913,1702.217391,20028.07609,1310.543478,2082.23913,3159.804348,7238.173913,1664.304348,293.5,2349.586957,15102.66304,439.6195652,237.0326087,896.1086957,19035.59783,1390.608696,145.25,1368.771739,14371.48913,1683.282609,422.8586957,2787.891304,12862.28261,619.1195652,271.8152174,1136.086957,8401.75,1485.98913,406.9456522,1292.423913,5519.23913,663.3478261,155.2065217,3652.967391,4938.184783,1334.673913,211.1630435,3244.663043,629.8152174,994.6304348,92,14.58479062,8.279632447,0.823242756,0.93877551,0.544378698,-0.679920183
+4647,15907.70513,1003.230769,585.1538462,1088.705128,12934.42308,596.3333333,571.7948718,1550.320513,6396.576923,532.0128205,903.0897436,1788.012821,8724.846154,1131.730769,1304.615385,1482.423077,3360.423077,1124.833333,267.5897436,2278.012821,7002.75641,342.2692308,130.1025641,772.3461538,8796.820513,745.4358974,108.6153846,929.4871795,6752.910256,1267.102564,332.6410256,2790.653846,5771.935897,575.4358974,226.2948718,1122.051282,3568.205128,1237.166667,374.6282051,1309.076923,2124.512821,1277.358974,146.6923077,1813.153846,2169.512821,1164.102564,947.6282051,3217.448718,867.4615385,993.4487179,78,10.77409469,9.312622204,0.502885383,0.962962963,0.709090909,1.324447551
+4648,24730.48529,1039.955882,655.3970588,1123.911765,22516.60294,804.9117647,809.6029412,1696.823529,12663.35294,693.1470588,993.9852941,1791.029412,14761.13235,1470.5,1000.544118,2660.955882,5326.117647,1481.632353,347.9558824,2433.661765,11466.20588,482.6764706,351.0882353,1348.955882,14155,951.7794118,138.7205882,1243.808824,11039.91176,1712.352941,564.5441176,2818.220588,10099.57353,825.3676471,307.7205882,1876.161765,6623.573529,1386.544118,467.75,1358.470588,4381.117647,675.3676471,179.9852941,2807.75,3630.720588,1447.955882,752.7058824,3231.441176,545.2647059,994.7647059,68,10.04019848,8.852342327,0.471829197,0.957746479,0.686868687,0.044464458
+4649,32466.98008,979.5219124,528.1474104,1071.721116,28648.25498,763.3984064,585.3027888,1490.677291,16627.93227,644.063745,1475.171315,1741.187251,19303.44622,1404.290837,1155.864542,2712.633466,7185.059761,1408.191235,321.8167331,2318.49004,15690.14343,455.3346614,175.0199203,1021.876494,20775.60558,679.1553785,214.2231076,1240.705179,15542.52988,1579.187251,432.4780876,2811.494024,14047.43028,706.4741036,300.1912351,1658.095618,9364.266932,1776.673307,450.7250996,1322.904382,6301.649402,656.5418327,177.7569721,2206.115538,5553.027888,1509.741036,3802.191235,3230.14741,570.6414343,998.752988,251,19.72891052,16.88464754,0.517252667,0.896428571,0.6275,0.584476194
+4650,23751.88462,898.6153846,556.2,1101.007692,21389.65385,707.5692308,840.1692308,1623.653846,10932.92308,550.8923077,1087.907692,1787.384615,14379.06154,1246.669231,2360.623077,1851.384615,5259.807692,1199.961538,289.2461538,2272.884615,11427.79231,390.8692308,119.1307692,1350.069231,14565.93077,474.6923077,116.1153846,1132.930769,11320.34615,1718.061538,365.6538462,2800.138462,9763.446154,654.4769231,260.1307692,1275.130769,6000.430769,1567.538462,399.0230769,1317.953846,3635.123077,751.6153846,151.2846154,1556.246154,3679.430769,1299.176923,766.7846154,3247.707692,819.8769231,997.4846154,130,14.36804366,11.87198117,0.563264277,0.935251799,0.666666667,-0.143353238
+4651,32567.15015,1030.795796,707.9189189,1121.249249,28041.36336,751.4324324,702.6426426,1665.294294,13555.85285,610.7717718,1304.882883,1795.342342,17576.43844,1355.432432,2380.204204,3173.996997,6482.132132,1339.387387,331.1291291,2424.291291,14501.96396,410.8228228,243.2012012,805.7687688,17745.62763,653.6456456,130.5405405,2050.285285,13764.8979,1815.246246,389.1771772,2827.858859,12478.35435,658.0840841,294.2402402,1383.777778,6885.603604,1450.537538,443.978979,1331.498498,4337.204204,639.5315315,165.2642643,2737.399399,4024.243243,1345.138138,1138.405405,3371.975976,405.6396396,1002.726727,333,26.37268756,16.49010187,0.780406935,0.938028169,0.660714286,-0.568511512
+4652,35118.95775,961.7535211,506.5985915,1083.246479,30419.54225,744.7253521,616.7394366,1592.626761,17348.83099,598.8802817,1065.619718,1761.239437,20790.16901,1317.387324,1753.760563,2518.394366,7692.809859,1275.795775,307.5915493,2268.394366,15486.83803,397.8380282,130.8028169,745.2253521,20505.16901,460.4647887,204.8098592,1685.676056,15690.02113,1826.584507,431.7042254,2779.507042,13675.40141,714.5352113,279.0985915,1190.985915,9330.901408,1143.549296,408.0211268,1311.478873,5927.943662,604.1478873,159.6901408,1637.042254,5344.535211,1406.725352,2719.725352,3248.330986,659.2676056,998.028169,142,16.59453295,11.46081585,0.723200585,0.898734177,0.596638655,0.98887274
+4653,19287.86842,969.0438596,534.2368421,1071.026316,16833.83333,707.3333333,664.7368421,1716.236842,8863.421053,558.8859649,444.0350877,1855.324561,11395.44737,1234.947368,1849.052632,1585.921053,4293.763158,1161.184211,268.5087719,2236.675439,9099.535088,469.0526316,237.1754386,535.9385965,11429.52632,438.745614,114.0964912,768.6666667,9039.912281,1346.736842,349.754386,2801.701754,7659.991228,693.8947368,252.4824561,1058.166667,4951.175439,1042.535088,388,1315.412281,3073.421053,2986.359649,145.2982456,566.8508772,2992.807018,2696.587719,237.1666667,3277.54386,779.9912281,998.7017544,114,13.47116457,10.84410046,0.593293646,0.95,0.74025974,-0.157026363
+4654,24728.50435,892.2695652,1042.913043,1166.191304,22951.48696,718.3304348,777.226087,1685.356522,12197.66957,556.7913043,596.1304348,1788.234783,14912.16522,1276.182609,1261.695652,1265.226087,5540.773913,1315.426087,320.0695652,2416.773913,12349.75652,447.6173913,213.2956522,476.573913,15552.54783,448.7826087,130.5652174,1125.26087,12110.61739,1441.991304,442.4434783,2842.617391,10538.18261,873.4521739,300.4956522,1597.26087,6658.878261,903.2869565,458.1913043,1360.33913,4293.73913,623.8608696,166.5217391,1372.556522,4104.678261,1392.852174,1154.356522,3279.208696,482.5043478,999.0782609,115,14.15859914,11.1788285,0.613694729,0.8984375,0.68452381,-0.435445923
+4655,21022.42105,923.8631579,769.4,1147.978947,19518.42105,710.1684211,813.9473684,1613.631579,10453.67368,556.9263158,566.9473684,1781.536842,12529.83158,1294.168421,794.3578947,897.7263158,4672.715789,1349.821053,314.3578947,2363.810526,9980.315789,434.1684211,123.0315789,492.4105263,12873.82105,472.5473684,124.8315789,930.4210526,9790.157895,1423.410526,369.7368421,2805.189474,8680.168421,820.7684211,293.4421053,1594.452632,5538.452632,853.5052632,453.1368421,1337.147368,3461.273684,601.8210526,166.1052632,1354.978947,3392.821053,1411.821053,1119.157895,3256.768421,492.0315789,999.2842105,95,13.13251376,9.573938353,0.684486461,0.95,0.730769231,-0.324159635
+4656,31136.17757,1010.336449,477.953271,1055.976636,26906.36449,728.6448598,763.9018692,1607.761682,15585.33178,601.9439252,1297.518692,1753.042056,18457.85514,1279.696262,1831.598131,2274.696262,6747.453271,1309.686916,287.4392523,2319.948598,14259,402.1775701,229.0233645,1155.490654,18081.41589,559.3411215,116,1132.327103,14216.84112,1558.845794,382.1775701,2792.672897,12768.80841,593.2476636,267.1261682,1277.205607,8435.186916,1278.761682,394.2943925,1310.182243,5400.551402,760.864486,148.9065421,1855.780374,5221.462617,1292.850467,228.8831776,3270.602804,611.5514019,1001.630841,214,19.71939558,14.03291528,0.702554349,0.959641256,0.629411765,-1.219492397
+4657,27734.60759,959.7468354,463.1012658,1054.721519,25066.50633,737.1139241,821.4936709,1562.822785,14168.86076,601.8481013,1319.949367,1825.974684,16974.39241,1276.582278,1974.708861,3194.544304,6088.417722,1302.189873,281.4050633,2326.518987,13161.03797,403.9367089,274.3417722,1597.303797,16772.49367,583.4556962,129.7848101,1167.265823,12786.91139,2152.417722,404.3544304,2802.202532,11222.53165,607.6962025,264.2531646,1132.126582,7490.987342,1787.56962,396.4177215,1314.43038,4950.177215,667.5189873,153.7848101,1595.341772,4374.683544,1323.075949,1138.974684,3257.050633,647.6962025,997.5063291,79,11.2545097,9.300085777,0.563167096,0.908045977,0.718181818,1.064210769
+4658,28760.44214,857.8694362,559.0326409,1103.910979,25250.29674,698.9317507,777.727003,1637.608309,10993.09199,523.9910979,1588.41543,1737.94362,15999.44214,1257.433234,2491.344214,3163.896142,5919.05638,1191.231454,295.7032641,2465.139466,12819.94955,440.6735905,170.8041543,1464.403561,16315.19288,987.5192878,180.0356083,1585.498516,11962,1744.881306,357.2818991,2808.593472,10119.52522,634.347181,265.8545994,965.8635015,5435.884273,1544.64095,402.2344214,1303.252226,3088.341246,629.4035608,154.8575668,2381.023739,3195.62908,1281.246291,1721.169139,3206.186944,889.9376855,1004.014837,337,24.44893189,19.4628181,0.605217636,0.875324675,0.563545151,-0.200651161
+4659,34077.60584,996.5182482,607.7737226,1091.211679,29262.38686,740.4671533,698.3284672,1592.481752,14794.42336,593.7956204,1296.781022,1741.817518,18840.94891,1294.49635,1951.905109,2633.664234,7015.620438,1323.328467,319.5328467,2460.087591,15271.92701,395.7883212,151.1532847,930.2554745,19686.83942,612.5839416,226.4744526,2125.678832,15076.91971,1779.10219,415.4525547,2854.941606,13337.24088,861.4817518,299.5912409,1501.065693,7785.19708,1437.781022,441.4087591,1329.372263,4927.810219,622.1824818,164.7810219,2224.313869,4596.328467,1344.175182,2165.839416,3292.240876,421.810219,1001,137,15.37671679,12.12354368,0.615117914,0.88961039,0.652380952,0.270119871
+4660,20568.49333,953.8933333,579.4133333,1082.826667,18293.02667,701.7866667,459.2266667,1565.546667,9333.8,630.6933333,633.96,1763.933333,11688.69333,1353.226667,2207.56,2577.826667,4295.213333,1270.12,305.9466667,2302.96,9332.973333,690.1733333,298.6,563.44,12028.12,585.5866667,122.4933333,3444.933333,9252,1471.133333,469.28,2804.4,8202.04,745.1466667,270.8533333,1388.6,4977.4,1018.533333,415.92,1323.56,3204.706667,635.48,165.7066667,3717.533333,3028.306667,1347.933333,2282,3194.88,431.1466667,999.7333333,75,13.26294046,7.266300391,0.836566783,0.9375,0.625,0.530823306
+4661,27575.17647,843.0882353,557.1372549,1093.401961,24577.32353,653.9019608,616.4313725,1795.382353,13347.31373,528.0784314,380.5490196,1846.107843,16823.29412,1194.637255,2433.627451,2483.137255,6310.990196,1224.431373,285.2647059,2262.784314,13398.34314,389.754902,214.754902,472.4215686,16751.15686,426,114.0490196,1459.284314,13227.2451,1320.784314,425.9117647,2811.078431,11556.62745,649.1862745,273.7843137,1325.745098,7308.215686,1253.117647,394.2647059,1281.45098,4615.941176,3067.215686,149.3823529,807.2156863,4566.333333,3348.088235,404.1078431,3242.745098,744.4117647,999.5588235,102,13.69270124,10.05556143,0.678745225,0.902654867,0.56043956,0.52032285
+4662,29691.95575,911.0353982,532.5044248,1082.415929,25670.9469,707.6106195,708.079646,1651.884956,13794.35398,551.8938053,701.4247788,1770.185841,17359.61947,1247.814159,1851.876106,2076.132743,6465.884956,1221.115044,288.1769912,2271.327434,13863.42478,389.1858407,137.6725664,639.6902655,17373,442.9557522,127.4778761,1749.238938,13778.42478,1533.814159,416.380531,2802.433628,12022.82301,615.7345133,268.5132743,1343.929204,7563.415929,1104.39823,395.8584071,1302.353982,4737.610619,1570.628319,156.5044248,1472.230088,4614.327434,1672.115044,300.7079646,3308.141593,764.5840708,999.7876106,113,12.77525434,11.28679186,0.468452617,0.957627119,0.724358974,0.918511914
+4663,40534.10628,1051.884058,632.6135266,1143.217391,30871.65217,690.3188406,542.4927536,1667.565217,15010.53623,560.0724638,1019.879227,1727.792271,19978.77778,1280.990338,5491.995169,3007.898551,7305.236715,1307.468599,313.115942,2341.975845,16083.27536,370.9275362,222.4830918,807.352657,18895.42029,667.7342995,122.5362319,4520.541063,15340.61353,1786.304348,372.294686,2813.36715,13429.71981,600.1690821,284.7004831,1519.043478,6480.956522,1301.908213,415.1062802,1308.932367,4183.671498,637.4975845,159.0821256,2770.719807,3952.545894,1277.512077,1569.154589,3235.927536,376.468599,1004.415459,207,18.10356874,15.58319548,0.50897668,0.851851852,0.638888889,1.482300262
+4664,42073.20313,990.078125,571.3125,1139.90625,36572.25,826.03125,501.625,1681.21875,19779.3125,604.40625,590.78125,1745.21875,23380.51563,1382.828125,1723.203125,2618.75,8373.859375,1394.984375,351.546875,2296.0625,18669.82813,426.453125,150.75,518.28125,23149.71875,445.03125,136.75,2012.515625,18748.5,1545.015625,493.609375,2805.609375,16315.39063,620.609375,310.109375,1452.0625,9839.359375,929.828125,464.296875,1305.28125,6262.140625,643,170.546875,1901.796875,5987.0625,1451.9375,573.5,3245.875,470.890625,998.453125,64,10.47980848,8.043447749,0.641026697,0.927536232,0.646464646,-1.402393559
+4665,38566.71765,996.4235294,526.1764706,1099.223529,33275.84706,736.3294118,587.4352941,1544.741176,18913.43529,711.5294118,1623.847059,1726.729412,22274.51765,1362.164706,2708.247059,3198.905882,8186.976471,1610.223529,403.9294118,2323.835294,17947.18824,430.7764706,386.8470588,1439.105882,23949.48235,1252.729412,135.5058824,1197.247059,17867.69412,1787.964706,467.8705882,2847.352941,15723.32941,746.9058824,315.8588235,1404.694118,10276.87059,1423.117647,462.4941176,1342.823529,6559.811765,706.8705882,177.1647059,2719.188235,6232.082353,1453.776471,466.3176471,3235.788235,536.6470588,1000.847059,85,11.7291489,9.321119018,0.607006373,0.95505618,0.643939394,-0.662357845
+4666,42111.71429,1093.785714,525.8571429,1094.514286,36927.4,810.7571429,650.4714286,1659.971429,21221.1,639.7428571,958.9857143,1750.042857,24480.37143,1378.714286,2773.671429,2676.114286,8547.314286,1351.542857,292.5285714,2303.985714,17656.38571,415.8714286,147.0714286,853.2857143,22310.44286,692.3142857,130.5,2611.3,16999.14286,1932.957143,400.5428571,2799.114286,15093.72857,623.9428571,274.1857143,1145.242857,9975.814286,1134.242857,392.2857143,1302.728571,6285.814286,616.4285714,155.4714286,1527.814286,5423.657143,1286.3,202.2,3350.457143,634.9285714,999.8714286,70,13.21043133,6.91136406,0.852225431,0.95890411,0.583333333,-0.917491603
+4667,17878.91736,884.9586777,508.892562,1064.165289,15672.43802,658.768595,736.9338843,1593.38843,8165.859504,533.8347107,432.0165289,1794.22314,10554.95868,1186.31405,1920.024793,1684.173554,4025.297521,1148.917355,269.5619835,2266.099174,8127.22314,472.9256198,147.0578512,538.0165289,10390.01653,447.5867769,111.4710744,778.7933884,8100.487603,1338.628099,347.9173554,2788.950413,6896.380165,643.9256198,243.6280992,1229.528926,4395.280992,1150.115702,372.4876033,1307.933884,2682.991736,2764.727273,145.0495868,1201.520661,2645.942149,1807.256198,588.6198347,3326.842975,791.1900826,1001.809917,121,14.76360697,10.56989496,0.69815916,0.96031746,0.720238095,0.646717423
+4668,17187.06977,782.4573643,459.7131783,1070.651163,15459.91473,642.6124031,573.2093023,1516.410853,7647.968992,474.7209302,382.2945736,1715.217054,10008.13953,1174.96124,1421.775194,939.8449612,3913.44186,1292.596899,279.1085271,2246.395349,8313.139535,366.0155039,276.9922481,491.5968992,10372.51163,463.8217054,112.4341085,938.2790698,8275.348837,1300.744186,365.7209302,2822.20155,7286.945736,704.620155,251.4031008,1588.79845,4480.573643,801.9534884,381.5271318,1302.790698,2742.581395,862.8682171,156.9534884,1512.705426,2716.465116,1362.992248,9793.713178,3214.193798,831.5658915,1003,129,15.79260262,10.75651105,0.732180427,0.908450704,0.614285714,1.231887254
+4669,17828.84127,805.6507937,426.010582,1034.089947,15952.67196,646.2857143,564.7301587,1447.021164,8650.481481,517.010582,608.4973545,1681.62963,10595.32804,1230.190476,1437.084656,1015.878307,4013.116402,1155.761905,278.8571429,2244.455026,8363.365079,383.5925926,149.010582,661.6772487,10513.57672,537.2169312,116.3121693,830.3333333,8207.767196,1353.566138,397.5661376,2839.502646,7412.15873,618.1164021,249.4761905,1812.068783,4946.767196,920.4285714,388.7830688,1315.042328,3231.883598,630.9365079,152.1481481,1380.941799,2994.042328,1357.021164,5197.957672,3177.52381,677.8624339,1005.190476,189,19.91519392,12.65095786,0.772313553,0.908653846,0.75,0.154141617
+4670,20810.34615,812.3076923,426.8974359,1054.700855,18164.56838,645.2008547,622.0897436,1534.15812,9759.692308,509.8846154,414.7179487,1749.970085,12491.74359,1175.542735,857.2735043,1054.837607,4794.252137,1170.833333,275.7735043,2257.452991,9658.166667,365.7307692,132.9700855,504.7777778,12581.69231,475.2008547,113.6880342,903.8119658,9633.764957,1288.961538,386.1538462,2824.299145,8456.380342,745.3504274,260.6794872,1576.055556,5569.029915,877.6282051,385.4487179,1301.858974,3500.311966,1027.15812,148.8504274,1230.957265,3400.452991,1298.363248,3651.119658,3140.149573,718.9529915,1003.75641,234,22.80985969,13.66350544,0.800735923,0.886363636,0.655462185,1.207297886
+4671,20657.42748,812.6183206,490.2137405,1073.152672,18960.45802,641.0152672,667.4961832,1607.832061,9958.206107,507.8396947,375.0610687,1726.70229,12497.8855,1176.114504,1202.435115,1421.534351,4836.458015,1173.587786,281.7862595,2249.29771,10067.67939,408.0763359,173.0610687,483.3282443,12553.16794,452.8778626,112.3282443,929.7557252,9865.816794,1279.137405,372.3282443,2826.48855,8628.129771,809.2748092,254.2137405,1443.70229,5539.89313,1049.427481,382.9923664,1292.40458,3566.977099,2529.534351,147.3816794,1072.931298,3444.534351,1958.89313,1874.320611,3222.580153,735.389313,1003.435115,131,15.6522612,10.8365287,0.721581101,0.942446043,0.668367347,0.680724413
+4672,24192.58095,895.7047619,559.8095238,1098.552381,21942.25714,726.9619048,587.3428571,1556.285714,11517.88571,570.7333333,707.3047619,1755.409524,14124.3619,1365.847619,3675.533333,3788.428571,5192.342857,1399.552381,328.4761905,2324.2,12235.25714,398.3809524,193.6095238,584.4857143,15017.3619,551.5428571,132.4285714,2975.257143,11840.70476,1524.790476,406.5142857,2806.12381,10586.06667,773.9714286,284.1809524,1414.161905,6364.704762,1013.533333,445.447619,1330.152381,4193.171429,637.8,175.7142857,2741,3966.885714,1412.628571,2998.819048,3206.704762,463.2666667,1004.219048,105,13.70303526,9.846314459,0.695475419,0.972222222,0.673076923,0.600491952
+4673,33425.21739,906.8043478,521.6304348,1091.478261,30502.82609,729.3478261,744.7173913,1620.597826,16604.1087,640.4891304,2157.206522,1743.75,19945.77174,1331.586957,2130.206522,4415.097826,7334.206522,1354.543478,336.5543478,2493.23913,16623.95652,431.1847826,333.2608696,1383.119565,20788.45652,1769.793478,138.1086957,1390.445652,15887.48913,1629.032609,563.0543478,2811.913043,14341.17391,718.7391304,309.1304348,1427.619565,9040.108696,1289.054348,452.4565217,1338.402174,6012.597826,670.673913,166.6195652,2827.836957,5481.076087,1407.336957,401.173913,3205.043478,520.673913,1003.228261,92,16.17953525,7.680625965,0.880140977,0.876190476,0.522727273,1.090418251
+4674,18658.29545,756.1666667,423.530303,1053.878788,16449.63636,598.5681818,557.2878788,1452.931818,8773.575758,483.6060606,429.6363636,1676.856061,11086.33333,1131.575758,868.9772727,838.9621212,4393.416667,1128.318182,268.1212121,2255.878788,8388.25,356.280303,91.06818182,518.2272727,10880.43182,464.1060606,114.0378788,894.2727273,8303.507576,1254.30303,384.6136364,2817.44697,7427.045455,645.6590909,245.6060606,1456.924242,4890.5,756.5227273,372.4772727,1316.643939,3168.469697,588.8030303,148.4318182,1496.992424,2935.924242,1238.25,3229.583333,3155.575758,689.1287879,1004.583333,132,15.20161527,11.24066648,0.673223614,0.942857143,0.733333333,-0.262999702
+4675,38370.58042,1003.213287,515.1048951,1077.706294,33986.02448,770.9440559,751.2587413,1631.160839,18995.87063,636.7412587,1545.79021,1835.423077,22424.13287,1399.818182,2461.48951,3112.951049,8274.727273,1406.70979,376.4335664,2433.979021,17356,412.6153846,133.9020979,1110.765734,22109.25874,965.8566434,200.8776224,1838.954545,16823.08392,2091.909091,393.1748252,2803.898601,15013.09091,635.3356643,308.2377622,1071.905594,9900.534965,1372.632867,435.9160839,1315.017483,6423.874126,637.1608392,160.7552448,1869.22028,5745.863636,1368.566434,208.0804196,3351.041958,641.020979,1013.129371,286,26.79517095,14.87697561,0.831709483,0.856287425,0.578947368,0.414773456
+4676,22821.17751,1058.011834,537.852071,1046.224852,20094.46746,764.3668639,437.8461538,1407.639053,11075.77515,702.9940828,1145.195266,1724.378698,13473.60355,1397.384615,829.3076923,1507.95858,5033.443787,1438.491124,331.6213018,2299.538462,11143.21302,436.1360947,372.8047337,891.7810651,14716.38462,538.887574,238.2544379,921.8106509,11092.43195,1606.615385,426.0473373,2799.923077,10204.05917,728.8934911,283.0532544,1325.254438,6786.325444,1274.112426,434.3727811,1323.538462,4567.491124,668.5443787,174.4260355,1686.455621,4242.727811,1462.639053,3545.266272,3167.059172,560.8639053,1009.319527,169,15.08901544,14.77487848,0.202988686,0.928571429,0.704166667,-0.53901796
+4677,17100.04348,956.5797101,478.6304348,1058.101449,15735.8913,734.8913043,462.9710145,1409.391304,8456.181159,583.0289855,663.6304348,1699.724638,10396.44203,1388.456522,842.2391304,1808.963768,3888.688406,1236.652174,300.7463768,2301.427536,8546.862319,439.8768116,179.3115942,728.942029,10968.45652,802.4782609,121.4565217,1071.884058,8459.065217,1462.594203,432.5434783,2799.181159,7563.471014,600.6666667,271.8695652,1643.115942,5124.688406,1053.492754,414.5869565,1327.26087,3430.152174,666.1449275,164.0869565,2588.804348,3263.123188,1456.826087,2971.224638,3169.449275,592.5,1008.014493,138,15.93239937,11.37038805,0.70048766,0.926174497,0.624434389,-0.473526005
+4678,22415.77922,864.2251082,690.1818182,1106.17316,18920.00433,637.4329004,582.3982684,1495.194805,8153.861472,505.7402597,718.8917749,1659.554113,11886.31602,1221.298701,1681.930736,1533.554113,4517.82684,1161.614719,285.4891775,2289.95671,9571.515152,363.9004329,307.1298701,816.1341991,12135.2684,547.8484848,116.047619,1791.982684,9062.805195,1714.406926,345.8268398,2845.532468,7685.229437,649.9393939,253.3549784,932.025974,3906.822511,951.6277056,384.5930736,1287.177489,2248.670996,622.8614719,152.2640693,2188.78355,2422.774892,1221.939394,3931.904762,3091.497835,904.3506494,1010.65368,231,19.49141882,16.20189306,0.555925526,0.905882353,0.679411765,-1.203638237
+4679,21261.82249,797.1715976,505.2781065,1063.207101,19589,653.2721893,668.5798817,1533.088757,10041.38462,519.1360947,517.8047337,1764.242604,12251.65089,1172.260355,2226.928994,2418.284024,4621.414201,1246.284024,316.5680473,2298.449704,10374.42604,364.0946746,561.4497041,585.8047337,12812.78698,533.5621302,121.035503,1551.059172,10063.56805,1534.769231,416.4674556,2819.591716,8895.686391,888.8698225,268.9526627,1333.414201,5381.869822,1064.455621,414.4260355,1325.295858,3407.573964,758.443787,157.739645,1768.16568,3380.609467,1304.236686,2173.514793,3203.544379,475.2248521,1010.763314,169,16.39776535,13.21241055,0.592263178,0.965714286,0.710084034,0.304554772
+4680,45412.93333,881.9666667,448.7333333,1109.333333,41441.23333,804.7,843.0333333,1661.133333,23226.56667,619.1333333,1360.5,1956.8,27673.1,1300.866667,1293.733333,3230.266667,10585.96667,1371.533333,361.1333333,2376.8,21574.43333,433.0333333,113.9,1278.266667,28060.5,525.2333333,440.6666667,1444.4,21133.93333,2020.033333,406.0333333,2816.333333,18644,643.3,315.4,1112.166667,12595.3,1484.9,472.5333333,1331.133333,8178.833333,647.6333333,163.3333333,1575.933333,7204.366667,1468.733333,213.2,3295.666667,648.4666667,1004.866667,30,7.533379014,5.490535348,0.684697141,1,0.714285714,1.036351385
+4681,41996.30435,1030.043478,486.0434783,1094.608696,35740.43478,770.1304348,606.9347826,1649.934783,21062.93478,728.7608696,1058.130435,2077.043478,24749.5,1503.847826,1427.217391,2374.23913,8862.369565,1340.869565,386.5434783,2408.086957,18680.5,421.2826087,305.3913043,967.3478261,25108.65217,487.4130435,409.6521739,1270.23913,18780.8913,1897.891304,417.4565217,2847.586957,16655.52174,638.8478261,360.9782609,1068.673913,11747.5,1215.913043,515.9347826,1377.065217,7268.630435,825.8043478,204.4347826,1308.652174,7232.804348,1495.108696,877.9130435,3506.782609,656.0434783,1006.891304,46,9.718437718,6.482926717,0.744990578,0.867924528,0.575,1.265391984
+4682,22620.96053,942.8421053,654.6184211,1122.763158,20949.22368,696.8947368,853.5394737,1633.460526,10980.18421,658.9210526,1645.960526,1755.644737,13574.36842,1262.105263,2331.552632,3594.065789,5068.697368,1307.25,317,2636.039474,11374.84211,401.2631579,668.8421053,937.4473684,14579.03947,732.4868421,128.4210526,1763.776316,10841.19737,1920.118421,455.6842105,2815.171053,9915.092105,981.4605263,277,1406.526316,6300.947368,1139.697368,434.1184211,1349.131579,4138.815789,729,166.5921053,2299.710526,3959.144737,1372.710526,945.7105263,3215.565789,515.0789474,1009.197368,76,12.88569221,8.244561033,0.76852238,0.835164835,0.487179487,1.11252695
+4683,29075.37895,1042.747368,588.9210526,1091.036842,25597.43158,766.8315789,963.5526316,1634.778947,14349.64737,619.9736842,1398.368421,1778.405263,16738.3,1303.768421,2039.8,2736.626316,6290.884211,1273.036842,291.3315789,2341.915789,12714.9,544.2105263,274.3894737,1714.536842,15970.64737,906.3684211,210.9263158,897.0368421,12241.03158,1913.189474,351.9473684,2789.657895,10949.62105,1444.847368,266.4684211,1198.7,7405.573684,1348.563158,401.4,1314.215789,4563.826316,744.2631579,148.7842105,2185.257895,4110.705263,1267.826316,223.9631579,3317.184211,625.7210526,1012.773684,190,18.4006919,13.71217467,0.666842302,0.88372093,0.666666667,0.152825527
+4684,31873.22581,1071.591398,540.827957,1075.419355,27457.54839,781.3978495,713.7634409,1611.311828,13269.77419,640.0645161,1802.032258,1802.182796,17517.73118,1328.451613,2549.989247,3485.204301,6517.44086,1324.376344,304.9784946,2360.591398,14495.89247,369.688172,239.0107527,1697.537634,17719.37634,565.516129,135.0215054,1468.645161,13775.34409,2233.88172,335.0537634,2870.107527,12594.37634,739.1075269,282.5698925,1042.602151,6906.032258,2143.225806,413.3010753,1313.354839,4374.956989,616.827957,156.7096774,2083.569892,4056.548387,1278.849462,1465.236559,3341.870968,414.7849462,1011.215054,93,13.25097578,9.69904562,0.681358842,0.877358491,0.550295858,-0.909065362
+4685,34174.80583,1030.805825,505.0485437,1058.194175,30780.49515,779.1067961,613.0776699,1524.572816,16740.94175,655.8640777,2160.271845,1743.495146,20055.47573,1369.912621,1431.728155,3233.864078,7181.359223,1357.339806,338.368932,2466.475728,16038.26214,428.0194175,174.6990291,2812.262136,20898.32039,973.6116505,435.2135922,1349.194175,15774.52427,1799.15534,422.5825243,2800.92233,13915.50485,642.2718447,299.4854369,1277.368932,8951.252427,1498.203883,444.4951456,1323.029126,5627.533981,625.4174757,168.2524272,2447.504854,5319.61165,1392.893204,672.7572816,3217.194175,531.8058252,1012.621359,103,14.97775689,9.058211139,0.796394446,0.944954128,0.686666667,-0.147982308
+4686,29250.97799,859.4654088,527.4402516,1087.040881,25573.42767,688.4433962,725.091195,1616.902516,12005.36164,523.4339623,1599.603774,1772.455975,16137.86478,1230.77044,2575.996855,3026.015723,5955.066038,1200.644654,300.5283019,2453.100629,12954.20755,382.7735849,182.8144654,1392.295597,16463.91195,480.9339623,258.9748428,1747.694969,12564.22327,1847.616352,370.6194969,2812.880503,10636.53145,632.4056604,266.1666667,1004.465409,6017.41195,1400.31761,395.9150943,1297.974843,3485.927673,617.7578616,155.0660377,1673.852201,3493.924528,1257.720126,1479.078616,3222.811321,849.8867925,1015.993711,318,23.28327242,18.9450849,0.581315944,0.878453039,0.630952381,-0.804070098
+4687,26715.14537,844.3744493,541.6651982,1097.303965,24041.96476,676.3876652,770.4669604,1622.497797,10458.68722,529.0176211,948.2378855,1723.23348,14763.19383,1236.488987,3527.211454,3131.281938,5540.740088,1166.348018,294.4889868,2513.810573,12042.21586,433.061674,222.1629956,850.7004405,15232.3348,585.7268722,118.4229075,2711.449339,11308.59912,1695.572687,357.6035242,2786.268722,9712.819383,600.0484581,259.5022026,1083.828194,5258.621145,891.7092511,389.9911894,1306.409692,3021.69163,636.3524229,154.1497797,2881.23348,3066.132159,1249.361233,987.753304,3182.321586,875.4669604,1013.215859,227,23.58955696,12.86472277,0.838204079,0.926530612,0.675595238,1.437224574
+4688,36324.875,1041.357143,600.0714286,1111.357143,32365.57143,809.125,656.4107143,1751.857143,16074.42857,627.0357143,664.5357143,1720.732143,20853.41071,1424.928571,3284.339286,3067.392857,7292.303571,1424.017857,353.75,2323.660714,17413.51786,414.1964286,244.7678571,590.6071429,22599.69643,553.5178571,142.5,3795.142857,17384.26786,1923.125,495.8928571,2802.142857,15468.30357,656.9642857,317.4285714,1352.839286,8341.571429,1041.803571,451.2142857,1322.803571,5203.535714,693.25,174.0535714,2625.035714,5137.267857,1449.053571,1814.589286,3283.357143,426.7678571,1010.839286,56,9.527658623,7.668464894,0.593459946,0.965517241,0.691358025,-1.070635423
+4689,24116.9434,950.9150943,567.1132075,1076.613208,21961.43396,725.9716981,725.9339623,1599.339623,10840.93396,651.4811321,622.1981132,1779.254717,13422.64151,1284.254717,1816.556604,1911.443396,5025.254717,1474.04717,319.1226415,2261.830189,11068.31132,486.8207547,619.7735849,557.8962264,14093.62264,449.5,132.0566038,1573.830189,10758.80189,1643.235849,415.6509434,2833.075472,9453.084906,689.6509434,276,1217.235849,5439.188679,921.1509434,422.7830189,1317.254717,3471.867925,858.3490566,165.4716981,4457.509434,3361.735849,1273.792453,323.9056604,3250.660377,455.0283019,1011.462264,106,13.3221863,10.18659763,0.644464683,0.954954955,0.757142857,1.451699156
+4690,25236.28729,1122.187845,1186.066298,1218.049724,17810.19337,719.2707182,786.718232,1891.779006,7959.944751,576.8895028,605.2928177,1775.066298,10825.18232,1275.121547,2255.850829,1612.441989,4022.563536,1338.066298,309.5248619,2478.845304,8688.127072,372.3314917,220.3646409,599.5027624,10478.57459,626.519337,115.7127072,2002.607735,8057.342541,1800.198895,337.6243094,2845.718232,7075.574586,671.8121547,273.2486188,1134.917127,3409.154696,897.7403315,405.878453,1321.519337,2181.801105,594.3370166,152.9392265,1953.243094,2147.093923,1190.19337,761.4364641,3394.436464,388.2872928,1017.370166,181,20.34961832,11.3864303,0.828803186,0.967914439,0.822727273,-0.010954761
+4691,32102.76429,1172.035714,586.2785714,1182.778571,29635.51786,991.5392857,755.5821429,1990.364286,14118.24286,706.9535714,880.0464286,1795.882143,17704.21071,1588.010714,2144.889286,1470.910714,6809.310714,1522.175,391.1178571,2328.303571,14910.58214,1989.525,331,723.8392857,19064.87857,528.9642857,487.0857143,1236.328571,14367.28571,2519.896429,389.7392857,2881.546429,12643.53929,889.1571429,354.9857143,1097.767857,7048.207143,1152.621429,496.9821429,1339.714286,4475.328571,871.1892857,182.7178571,2827.996429,4337.278571,1568.714286,2372.771429,3324.253571,437.6714286,1017.9,280,25.13359168,14.98621536,0.802789615,0.840840841,0.589473684,-1.30573461
+4692,35961.33962,991.3584906,537.4716981,1099.132075,32861.58491,750.9056604,698.1132075,1608.320755,17856.07547,611.5660377,1789.792453,1763.943396,21793.67925,1389,3416.245283,3962.754717,7541.981132,1371.056604,348.3584906,2415.226415,18116.0566,431,189.4528302,1377.981132,22708.39623,965.6603774,142.0566038,2858.433962,17673.30189,1790.641509,489.6226415,2826.301887,15854.69811,679.9433962,303.5849057,1347.169811,10108.73585,1500.981132,459.3962264,1308.622642,6544.509434,659.1320755,174.6037736,2149.169811,6179.622642,1436.698113,602.0377358,3219.226415,523.4528302,1013.283019,53,9.820690379,7.130260818,0.68764744,0.981481481,0.841269841,-0.269674258
+4693,29886.72,928.31,501.2,1060.34,27255.91,715.61,702.65,1473.23,15036.3,585.07,1499.48,1719.26,18117.79,1323.71,1363.77,2461.77,6729.75,1324.58,331.69,2294.57,14818.7,418.93,140.37,1288.26,19596.91,1234.39,138.59,1015.68,14841.77,1499.04,428.95,2816.84,13163.12,671.79,282.67,1439.16,8662.38,1418.54,436.54,1330.96,5581.86,620.61,162.21,1717.34,5272.56,1458.24,4913.94,3172.14,540.5,1015.39,100,13.52125025,9.896574741,0.681382529,0.934579439,0.595238095,-0.483980722
+4694,38409.44898,883.4285714,502.6734694,1089.897959,34388.65306,712.4081633,653.5102041,1681.061224,19742.10204,1460.77551,2224.44898,2877.22449,23931.46939,3022.918367,1843.204082,2362,9363.571429,2935.469388,1284.530612,2999.387755,21735.32653,733.6122449,239.9183673,1151.591837,28703.81633,757.4489796,319.8367347,1839.142857,21780.5102,3343.346939,745,2992.204082,21920.87755,1189.77551,944.2244898,1249.816327,16627.08163,2007.081633,1127.081633,1597.387755,12638.89796,1185.836735,425.7755102,2595.836735,13563.77551,3150.77551,383.1020408,4174.612245,650.877551,1013.142857,49,8.288124256,7.600064067,0.398927662,0.942307692,0.680555556,-0.451454904
+4695,21828.73684,846.3368421,456.2421053,1043.463158,20202.42105,678.1473684,521.8105263,1433.536842,10611.70526,581.4631579,383.5894737,1658.515789,13259.4,1260.326316,1313.263158,1630.642105,4923.284211,1207.473684,304.5684211,2235.494737,10488.54737,373.8947368,126.5473684,593.7052632,13383.06316,412.3263158,116.3894737,1060.157895,10524.30526,1304.578947,387.2631579,2789.610526,9245.105263,677.2736842,262.9789474,1145.463158,5826.105263,787.4421053,398.7894737,1285.210526,3778.936842,640.6105263,155.5473684,1544.052632,3638.052632,1450,9255.147368,3140.684211,716.8736842,1014.157895,95,13.75826127,8.98380184,0.757379388,0.969387755,0.664335664,0.89314231
+4696,16725.32283,831.2598425,456.9606299,1051.377953,15140.88189,676.1338583,608.9685039,1518.944882,7559.740157,721.6535433,398.5275591,1707.992126,9736.464567,1249.787402,2004.488189,1398.480315,3729.007874,1383.173228,304.4488189,2248.992126,7804.322835,378.1653543,469.8661417,515.4094488,9849,444.2755906,117.6614173,1094.708661,7717.535433,1482.102362,430.6220472,2803.244094,6800.362205,766.2440945,261.3464567,1058.370079,4334.448819,770.2992126,392.1653543,1298.929134,2664.629921,791.9055118,156.9685039,1908.811024,2594.551181,1386.488189,6148.086614,3398.433071,772.9133858,1014.897638,127,13.77041362,11.817903,0.513299185,0.940740741,0.651282051,1.32706388
+4697,27626.33028,952.8899083,855.1834862,1174.137615,24833.50459,752.5045872,830.5412844,1767.844037,12833.07339,625.6513761,710.6055046,1790.091743,16131.00917,1330.082569,1596.055046,1669.33945,5796.311927,1348.238532,329.3944954,2390,13169.75229,447.2110092,291.6697248,563.440367,16821.54128,853.5779817,130.3119266,1164.614679,12780.91743,1528.669725,386.3486239,2834.073394,11518.90826,680.5779817,302.412844,1363.733945,6960.229358,1208.46789,457.0183486,1339.87156,4503.715596,658.7981651,172.8440367,1895.055046,4359.449541,1390.688073,187.8899083,3316.559633,502.0733945,1016.137615,109,12.7439589,11.07731492,0.494424004,0.956140351,0.707792208,0.073841164
+4698,25108.60251,911.8577406,475.5774059,1055.719665,22506.95397,698.7447699,669.7698745,1509.640167,12135.19665,623.8158996,1305.619247,1827.426778,14663.35983,1253.029289,2552.384937,3117.472803,5565.76569,1223.297071,298.4728033,2447.485356,10962.84937,388.3430962,531.832636,2269.481172,14178.5523,538,119.5439331,1579.16318,10565.9749,1904.728033,377.748954,2790.585774,9402.577406,657.1715481,263.0251046,1147.435146,6345.615063,1389.317992,394.2761506,1342.054393,4088.8159,942.9958159,158.041841,2185.702929,3625.430962,1300.870293,1681.238494,3193.569038,659.3640167,1019.338912,239,21.98442054,14.2784377,0.760378821,0.91221374,0.628947368,-0.681858255
+4699,28334.94949,1001.030303,698.8686869,1132.959596,25607.39394,758.6969697,725.5959596,1713.10101,12048.33333,564.7474747,1015.555556,1767.080808,15846.59596,1369.080808,2782.747475,3240.141414,5261.373737,1218.090909,305.030303,2299.090909,12050.60606,398.5454545,175.7171717,1027.646465,14841.67677,531.4444444,126.8686869,2579.939394,11503.88889,2091.121212,387.8686869,2811.262626,9857.030303,626.3333333,280.3636364,1089.909091,5584.353535,1335.989899,402.7070707,1307.717172,3457.626263,625.7171717,167.3434343,1595.444444,3297.838384,1350.292929,2556.313131,3358.444444,836.8686869,1016.151515,99,11.88692251,10.80017279,0.417719534,0.942857143,0.634615385,-0.153358149
+4700,22788.35507,968.1521739,474.9927536,1053.971014,19767.14493,746.1304348,448.8695652,1479.782609,10691.54348,601.8405797,570.7971014,1684.289855,12780.49275,1377.73913,831.7391304,1124.188406,4627.92029,1223.833333,291.9202899,2273.101449,9657.514493,492.3043478,292.6884058,771.8695652,12610.96377,518.9565217,120.615942,839.6376812,9705.065217,1420.797101,402.9782609,2827.188406,8674.971014,613.7971014,277.1956522,1523.275362,5854.826087,1026.355072,420.8333333,1316.355072,3681.782609,807.8333333,163.0797101,1235.282609,3451.115942,1503.188406,7171.210145,3190.818841,596.6521739,1019.442029,138,16.01163711,11.26300894,0.710768063,0.93877551,0.58974359,-0.414491475
+4701,23356.12987,833.9025974,577.8961039,1079.616883,21569.34416,666.6103896,861.9350649,1560.636364,10620.64286,554.9935065,1421.149351,1755.428571,13191.00649,1222.62987,2523.272727,4475.87013,4884.844156,1248.564935,309.8766234,2566.155844,10839.64935,378.7337662,700.9480519,847.9285714,13568.9026,1775.324675,122.7922078,1749.376623,10204.31818,1488.818182,559.3311688,2808.175325,9094.038961,642.4025974,285.9675325,1296.883117,5391.915584,1238.766234,428.1753247,1344.662338,3423.324675,799.6168831,166.6493506,3542.844156,3372.38961,1300.084416,1529.850649,3206.62987,487.2337662,1018.675325,154,19.77784189,10.55551306,0.845671363,0.88,0.6015625,-0.687054163
+4702,27681.41584,938.7821782,838.4752475,1181.168317,25055.85149,738.990099,839.3762376,1758.267327,13199.18812,670.3762376,867.5049505,1818.950495,16410.0198,1344.851485,1090.445545,1953.386139,5793.069307,1424.613861,339.1089109,2419.70297,13691.91089,447.1287129,253.9009901,687.9108911,16939.83168,507.8811881,132.9405941,1415.752475,13036.62376,1583.940594,406.2871287,2833.861386,11842.0198,705.0990099,293.049505,1463.950495,7304.722772,1058.19802,461.6633663,1354.059406,4655.217822,640.6930693,172.6039604,2120.277228,4455.910891,1427.980198,551.3861386,3284.524752,512.2871287,1018.148515,101,12.55772875,10.78308954,0.512509567,0.926605505,0.647435897,0.134291725
+4703,23316.5,884.5983607,435.8196721,1041.385246,20835.97541,682.147541,481.6557377,1447.508197,11223.98361,550.9180328,1035.377049,1705.204918,14403.21311,1323.639344,2499.213115,2219.893443,5340.418033,1228.213115,300.0409836,2245.581967,11175.83607,388.147541,112.4262295,1765.081967,14711.40164,466.0983607,120.1967213,1246.811475,11482.88525,1489.754098,375.8606557,2787.868852,10027.39344,677.9590164,267.147541,1239.655738,6459.762295,1176.114754,408.8278689,1316.631148,4057.02459,611.0491803,162.1147541,1296.139344,4017.590164,1407.47541,2728.147541,3126.795082,707.0901639,1018.631148,122,12.92250281,12.15799196,0.338854486,0.93129771,0.67032967,0.367832725
+4704,38535.36364,1029.636364,593.5324675,1149.714286,33352.12987,821.8701299,916.3636364,1777.428571,15624.45455,623.6623377,1907.077922,1822.012987,20620.49351,1380.064935,3200.558442,5423.922078,7539.974026,1345.285714,337.025974,2392.116883,16095.07792,403.1558442,156.7922078,1826.363636,20087.33766,934.1558442,257.5064935,2361.922078,15495.76623,2620.909091,352.7662338,2843.038961,13517.83117,643.987013,301.2987013,1243.311688,7026.675325,1401.467532,439.8571429,1315.194805,4354.428571,639.1948052,165.6493506,2976.337662,4126.831169,1305.25974,744.7662338,3301.545455,419.3636364,1018.584416,77,11.11143162,9.478335113,0.521869145,0.905882353,0.534722222,-0.599183756
+4705,19652.01527,982.5114504,598.1908397,1136.152672,17300.41221,744.1450382,574.4122137,1568.206107,9330.450382,600.5648855,835.6335878,1749.946565,11677.75573,1405.412214,653.8091603,1200.381679,4315.458015,1282.251908,316.351145,2345.236641,9369.839695,461.5114504,131.1984733,674.1679389,12542.36641,693.8091603,129.870229,891.6335878,9751.740458,1555.366412,414.1145038,2816.656489,8970.656489,641.9541985,302.0229008,2254.374046,5828.450382,1399.541985,451.3587786,1370.877863,3783.328244,660.7099237,173.9618321,1879.083969,3555.152672,1479.40458,2901.10687,3298.312977,571.4351145,1020.236641,131,16.86744547,10.60278577,0.777733104,0.897260274,0.623809524,-0.470678975
+4706,23683.45238,1031.357143,533.0238095,1091.154762,20014.09524,727,501.3333333,1615.22619,10618.20238,566.9404762,497.0714286,1736.035714,12876.70238,1378.797619,2110.809524,2208.904762,4282.72619,1202.761905,305.3571429,2335.428571,8767.357143,385.547619,109.2619048,580.25,11242.72619,462.8571429,118.2261905,1963.619048,8713.285714,1354.333333,401.3928571,2771.761905,7757.47619,779.0595238,263.8452381,1219.404762,4871.166667,886.2738095,389.547619,1306.297619,3060.059524,598.3928571,160.9285714,1455.178571,2896.916667,1417.52381,3835.321429,3159.333333,692.1071429,1017.928571,84,11.32091525,9.589187874,0.531540438,0.933333333,0.636363636,-1.380229167
+4707,30207.77551,872,598.3527697,1113.367347,27686.99417,707.7813411,620.8629738,1646.306122,13157.74344,571.1428571,703.2069971,1775.790087,15688.33528,1240.221574,3202.241983,2872.848397,5903.906706,1336.046647,312.7492711,2308.311953,12733.23032,464.7959184,540.0670554,664.361516,15968.08163,442.7696793,127.3294461,2843.504373,11811.97085,1526.740525,489.0204082,2810.653061,10403.99708,652.941691,272.877551,1431.379009,5847.790087,999.5247813,417.6588921,1314.48688,3618.046647,736.6151603,161.8979592,4080.463557,3494.367347,1274.944606,454.4723032,3217.982507,460.0816327,1024.087464,343,26.68036602,16.96915946,0.771675258,0.902631579,0.668615984,1.39678328
+4708,18812.90517,1111.189655,489.8017241,1029.767241,17379.03448,764.137931,480.2931034,1361.724138,9390.232759,626.6724138,1178.310345,1716.439655,11450.27586,1333.284483,897,1503.818966,4058.37069,1262.103448,302.5258621,2262.508621,9340.094828,403.9482759,98.25,880.0948276,12475.87931,797.8793103,279.9482759,854.8189655,9476.818966,1475.086207,352.112069,2801.818966,8450.836207,606.8275862,267.7672414,1160.387931,5465.784483,1116.801724,406.7241379,1322.008621,3560.793103,585.0344828,162.3189655,1297.37931,3413.87069,1429.517241,8803.655172,3129.086207,547.9051724,1021.862069,116,13.08230897,11.69105548,0.448756992,0.943089431,0.637362637,-0.526143902
+4709,23174.95062,999.8888889,498.4938272,1097.382716,20570.39506,756.7407407,528.8765432,1487.308642,10920.02469,622.3950617,1283.148148,1721.925926,13155.18519,1443.876543,818.6296296,1567.864198,4730.049383,1298.45679,328.7160494,2326.283951,10592.44444,437.7160494,138.4567901,1098.728395,13532.24691,541.0987654,139.5802469,911.617284,10386.44444,1648.814815,384.4938272,2826.765432,9563.691358,591.5432099,297.0246914,1432.148148,6476.08642,1319.382716,454.4444444,1344.320988,4139.37037,634.8148148,174.8641975,1687.555556,3472.790123,1504.45679,6394.259259,3204.222222,561.4938272,1020.518519,81,11.23210516,9.694424434,0.5050339,0.931034483,0.669421488,-1.370649154
+4710,33636.03846,1100.634615,543.8076923,1084.240385,29637.09615,820.4903846,850.0673077,1635.644231,16615.08654,658.5384615,2019.057692,1783.336538,19347.81731,1405.192308,1827.461538,2880.432692,7158.278846,1349.307692,315.4711538,2296.836538,15427.75962,442.5096154,198.4807692,2508.192308,19339.54808,577.1538462,166.4326923,829.6057692,15076.69231,2220.288462,356.1538462,2802.336538,13424.43269,672.7019231,291.5,1347.548077,8453.557692,1743.865385,415.4038462,1318.980769,5633.442308,707.9615385,158.8942308,1422.75,4824.307692,1379.067308,391.0865385,3246.923077,617.9134615,1023.471154,104,17.2756083,8.304136519,0.876893,0.845528455,0.509803922,0.324891089
+4711,25539.2562,827.6446281,527.0495868,1071.735537,23566.61983,726.8512397,869.3636364,1623.016529,11130.2562,536.7933884,1659.495868,1788.330579,14866.43802,1201.495868,1836.396694,2437.07438,5423.421488,1172.545455,292.7603306,2352.859504,11800.64463,400.4049587,290.3305785,2258.107438,14921.59504,966.6694215,655.8677686,1183.561983,11460.84298,1779.380165,342.9173554,2798.123967,9681.545455,816.2892562,259.3553719,1005.132231,5683.198347,1059.586777,393.8264463,1305.429752,3360.652893,644.9090909,157.0991736,2906.380165,3282.983471,1263.404959,1995.710744,3193.016529,818.7190083,1021.785124,121,14.15102413,11.55916241,0.576860306,0.9453125,0.775641026,1.416154778
+4712,23719.19178,963.0821918,1124.479452,1165.863014,20385.47945,756,852.7808219,1756.90411,9895.479452,559.8082192,1071.876712,1812.136986,13067.13699,1263.356164,1627.534247,2168.205479,4842.60274,1204.136986,301.0958904,2359.863014,10391.09589,432.260274,409.8356164,1015.835616,13209.06849,751.1780822,662.8356164,2267.657534,10211.93151,1749.465753,369.5479452,2797.260274,8696.205479,612.890411,257,1391.671233,5055.712329,905.3150685,397.4520548,1339.986301,2902.013699,667.3013699,144.3561644,2513.356164,2957.164384,1196.191781,880.4383562,3409.136986,828.6164384,1022.369863,73,12.35848392,8.128200913,0.753278128,0.948051948,0.623931624,-0.121691093
+4713,29764.37425,858.1736527,555.5628743,1091.862275,25874.73054,686.9610778,795.8682635,1626.050898,11498.51497,556.9670659,1597.008982,1751.452096,15727.53293,1195.997006,2959.655689,3064.766467,6040.98503,1165.982036,292.1886228,2435.197605,12680.48802,375.9071856,388.008982,1266.143713,16232.06886,842.8502994,387.7694611,2031.077844,12229.2515,2110.847305,346.6646707,2802.673653,10225.71257,895.991018,260.242515,978.5898204,5473.062874,1359.886228,387.6437126,1302.805389,3176.535928,654.5838323,153.0449102,2715.110778,3191.116766,1179.45509,1155.311377,3192.353293,856.0449102,1029.976048,334,26.73364869,17.53562439,0.754814501,0.865284974,0.580869565,-1.023897536
+4714,34536.57328,1122.409483,663.9525862,1133.331897,27870.13362,700.3189655,572.6681034,1661.047414,12310.13793,549.4310345,1046.241379,1758.017241,16541.95259,1216.418103,3710.724138,3756.663793,6001.405172,1221.267241,291.6637931,2324.590517,13372.75862,883.3793103,192.1637931,1231.650862,15823.21983,1188.62931,117.4525862,3144.073276,12130.31897,1620.866379,346.2715517,2817.918103,10738.14655,615.0387931,270.3793103,1081.551724,5208.280172,1231.810345,395.4439655,1302.310345,3324.237069,598.3793103,155.012931,3034.357759,3152.491379,1172.823276,572.0172414,3244.913793,407.7543103,1026.637931,232,19.75284407,16.1395778,0.57652976,0.865671642,0.560386473,-1.310521036
+4715,33807.40143,1005.182796,643.688172,1121.752688,31009.53047,732.0573477,742.9032258,1690.519713,15104.22939,601.5949821,1108.774194,1750.541219,19417.89247,1311.784946,2392.781362,3117.670251,7042.236559,1245.802867,310.6630824,2300.659498,15351.72043,405.1577061,230.4802867,983.344086,19312.32258,634.688172,134.8494624,1647.802867,15051.40143,1820.21147,394.6451613,2804.362007,12763.2043,619.6845878,277.1075269,1073.752688,7506.0681,1056.953405,415.0035842,1310.057348,4428.473118,640.6774194,160.1397849,1654.827957,4362.935484,1324.874552,1001.422939,3312.523297,791.3691756,1026.663082,279,22.40826502,16.27964726,0.687164449,0.891373802,0.634090909,1.237345935
+4716,28319.45455,844.1969697,558.6818182,1109.909091,19301.62121,551.6060606,524.0151515,1419.515152,8484.5,454.3636364,667.0909091,1696.742424,11982.12121,1034.378788,2436.287879,2392.924242,4743.772727,1039.227273,242.4242424,2276.19697,9723.969697,318.3333333,213.2272727,777.7121212,12578.89394,490.1969697,106.6515152,3019.363636,9313.393939,1703.651515,339.9545455,2772,7902,538.1818182,222.9545455,947.8636364,4335.212121,964.1666667,363.2424242,1299.318182,2474.939394,588.469697,139.4090909,2666.469697,2510.393939,1073.439394,416.0909091,3060.772727,869.8030303,1022.227273,66,10.28926131,9.254922977,0.436974293,0.891891892,0.545454545,-1.11329029
+4717,19613.99065,835.8130841,710.2056075,1112.037383,18603.83178,669.1214953,697,1611.607477,9378.635514,616.4953271,675.2990654,1784.570093,11635.8972,1189.803738,2173.728972,3118.859813,4338.514019,1263.719626,306.9252336,2355,9860.074766,406.1495327,1467.242991,532.6168224,12410.82243,831.7663551,123.1121495,1570.943925,9405.345794,1584.523364,441.8598131,2816.71028,8492.420561,644.8971963,266.2242991,1277.476636,5205.71028,1008.915888,412.6915888,1342.121495,3307.317757,1344.074766,161.5233645,2295.420561,3245.542056,1312.719626,390.8785047,3255.990654,495.2803738,1024.906542,107,12.24864352,11.32251731,0.381449964,0.938596491,0.633136095,0.821471516
+4718,13182.56442,976.8343558,606.8466258,1110.730061,11894.31902,704.3496933,464.6257669,1524.128834,6368.742331,574.0797546,468.7239264,1753.705521,7900.766871,1298.840491,473.3067485,755.6134969,3079.533742,1267.257669,284.7177914,2341.981595,6625.711656,436.3680982,135.208589,538.0184049,8546.07362,653.3251534,118.1226994,858.0797546,6688.263804,1320.742331,410.1042945,2842.165644,6100.042945,622.7361963,269.3496933,2133.07362,4076.196319,853.1717791,423.7361963,1361.920245,2556.312883,728.2883436,155.993865,1254.93865,2566.748466,1396.527607,2566.03681,3296.754601,586.7300613,1028.110429,163,18.27239177,11.61648671,0.77190343,0.920903955,0.696581197,0.040929829
+4719,23744.82759,887.8275862,558.2931034,1082.448276,20538.08621,704.7758621,766.4310345,1639.810345,10725.60345,546.2413793,676.2586207,1771.362069,13292.7931,1261.913793,1401.327586,2229.568966,5059.137931,1242.87931,296.7068966,2336.37931,10168.62069,389.7068966,137.7413793,898.6034483,13093.96552,480.1551724,119.5689655,1167.758621,10235.75862,1580.810345,360.6724138,2807.637931,8821.758621,973.862069,269.9137931,1117.87931,5656.948276,1250.758621,411.3965517,1298.810345,3511.482759,607.3965517,155.6724138,2374.086207,3335.344828,1346.103448,2103.465517,3234.913793,697.4655172,1024.551724,58,11.1160388,6.743537532,0.79496955,0.966666667,0.644444444,-0.65697036
+4720,20717.34328,1184,499.3134328,1021.164179,18172.49254,788.5373134,412.2238806,1350.552239,10076.85075,642.0447761,1246.328358,1652.044776,11663.41791,1362.104478,618.8507463,1502.208955,4404.985075,1243.164179,293.7313433,2251.910448,9268.358209,404.6716418,106.3731343,1642.149254,11727.79104,501.0298507,259.4776119,799.6865672,8971.014925,1564.223881,347.0597015,2782.089552,7965.41791,563.8059701,263.8507463,1270.865672,5380.134328,1160.731343,384.3134328,1312.656716,3462.074627,596.1343284,149.6567164,897.7462687,3213.552239,1334.791045,1663.134328,3141.970149,610.8656716,1025.910448,67,11.04816158,7.820671158,0.706341919,0.957142857,0.744444444,0.593112598
+4721,22888.26923,913.8230769,639.8307692,1086.407692,19887.90769,739.6230769,826.7384615,1603.484615,10022.44615,590.4846154,1037.230769,1783.723077,12638.14615,1224.884615,2469.684615,3073.3,4979.815385,1261.515385,288.6076923,2314.792308,10017.77692,386.3307692,328.5846154,1098.430769,12734.66923,613.8846154,307.0076923,1299.361538,9881.015385,1957.876923,424.5230769,2792.961538,8522.615385,615.0923077,262.0692308,1063.315385,5285.530769,1357.030769,395.8769231,1301.330769,3112.638462,662.5846154,149.7230769,2632,3084.730769,1284.069231,1048.546154,3251.9,769.3384615,1027.861538,130,15.98465536,10.66758182,0.744731787,0.955882353,0.787878788,-0.157997836
+4722,33554.21875,939.1953125,637.3671875,1128.046875,28735.28125,722.4609375,568.2578125,1674.71875,13161.08594,636.1796875,1409.210938,1754.695313,17262.79688,1244.726563,2608.992188,3549.453125,6668.828125,1275.703125,324.3125,2359.453125,14369.40625,385.671875,381.2734375,1111.960938,17904.57813,516.8046875,181.4375,2730,13590.92969,2248.007813,381.5078125,2842.070313,11699.8125,784.3828125,286.984375,1104.445313,5971.429688,1302.5625,433.5703125,1341.304688,3792.59375,719.3359375,161.625,3463.507813,3613.414063,1305.054688,1170.9375,3193.71875,422.28125,1028.617188,128,18.79264588,9.332797509,0.867968264,0.888888889,0.533333333,-0.958342894
+4723,21439.78261,1234.663043,729.1521739,1140.380435,18783.67391,851.2282609,453.326087,1689.782609,10173.71739,678.2282609,570.2717391,1700.391304,11962.02174,1553.891304,2820.021739,2038.608696,4664.945652,1360.456522,359.0869565,2296.304348,9626.467391,476.3695652,343.576087,1730.771739,12185.13043,509.0326087,132.6304348,806.9021739,9486.934783,1967.815217,351.4673913,2785.445652,8708.358696,721.6847826,293.0869565,1184.01087,5732.25,1297.076087,434.0543478,1325.456522,3727.467391,833.0869565,170.326087,1092.717391,3498.75,1458.73913,235.9782609,3272.173913,627.0869565,1027.673913,92,12.51905858,9.76544466,0.625721866,0.92,0.696969697,-0.428672525
+4724,30662.9875,1164.95,613.4125,1143.1375,27134.4625,798.1875,824.35,1691.05,14240.1125,643.025,1048.525,1846.6625,17174.2625,1363.4125,2482.675,3847.0125,5813,1268.2375,304.575,2420.5375,12243.6,381.2125,125.1375,1156.3875,15400.825,903.2,121.1125,2260.7875,11919.3875,1867.5875,409.575,2832.7125,10327.275,654.825,277.6375,1231.7125,6373.775,1236.625,406.9875,1361.725,4096.375,592.9,157.7875,2151.1625,3688.55,1277.9375,1383.4,3465.2125,686.3625,1026.3,80,12.34999977,8.350748804,0.73674196,0.930232558,0.740740741,-1.359985527
+4725,21683.57616,894.7417219,491.8675497,1053.099338,19967.46358,735.807947,607.5364238,1489.417219,10820.63576,612.192053,719.4966887,1720.774834,12915.70861,1333.099338,1475.562914,2431.543046,4734.715232,1583.139073,332.4701987,2274.251656,10827.94702,446.8807947,915.384106,679.9006623,14126.0596,581.986755,136.2582781,1402.874172,10640.59603,1575.10596,637.3311258,2805.099338,9574.887417,750.8874172,288.6490066,1438.278146,6239.119205,1066.377483,428.9470199,1326.89404,3780.490066,830.192053,165.4768212,1476.278146,3715.423841,1418.324503,1438.728477,3161.430464,534.9801325,1031.231788,151,16.58092042,11.65147287,0.711482689,0.967948718,0.683257919,0.439455776
+4726,14765.48077,997.5576923,500.7051282,1053.403846,13174.85897,717.4423077,455.5064103,1486.628205,7227,582.8910256,461.974359,1690.865385,8631.596154,1343.512821,467.3141026,879.9166667,3669.891026,1233.179487,280.1794872,2286.987179,7533.160256,430.0384615,222.3333333,619.9871795,9398.339744,561.3333333,117.6089744,824.1730769,7312.794872,1343.108974,391.5,2820.019231,6675.339744,604.0961538,264.1538462,1719.916667,4509.647436,878.0576923,409.0897436,1335.051282,2965.391026,728.6089744,154.0192308,1381.858974,2691.532051,1428.00641,6019.314103,3284,601.8846154,1033.217949,156,21.38734336,10.22156029,0.878400284,0.876404494,0.619047619,0.161742399
+4727,25416.85714,1121.571429,506.8979592,1066.112245,21677.68367,758.9795918,739.1428571,1577.22449,12066.09184,702.2857143,1010.387755,1760.05102,14427.14286,1358.520408,2675.122449,2463.173469,4823.530612,1248.234694,303.7244898,2309.214286,10434.59184,373.5204082,276.122449,1478.030612,13428.32653,589.6734694,118.877551,1050.326531,10254.30612,1975.5,361.1530612,2787.887755,9092.826531,624.1122449,268.8673469,1009.27551,5561.918367,1293.193878,391.9489796,1333.336735,3447.397959,676.4081633,155.3367347,1547.581633,3058.653061,1278.132653,999.5102041,3256.244898,672.5612245,1028.306122,98,12.94074284,9.791618034,0.653819697,0.924528302,0.685314685,1.381178399
+4728,25922.05263,887.8,609.3578947,1080.642105,23341.93684,698.3684211,627.1578947,1595.589474,11985.91579,561.4,625.1368421,1763.915789,15360.16842,1248.936842,3145.147368,3339.094737,5637,1287.084211,291.2947368,2273.178947,12371.78947,398.6631579,407.5578947,704.8947368,15651.74737,434.8842105,126,3643.642105,12199.09474,1566.715789,796.1263158,2794.084211,10419.12632,609.0105263,267.8947368,1274.715789,6353.189474,965.4526316,396.9789474,1339.368421,3867.694737,664.2526316,160.1473684,4860.778947,3777.736842,1310.936842,1573.147368,3164.463158,759.5263158,1028.936842,95,13.26228369,9.891787231,0.666104402,0.871559633,0.608974359,0.285343886
+4729,29016.97041,884.3017751,612.7810651,1110.402367,25599.12426,724.9408284,697.0532544,1642.940828,13152.97633,624.6213018,1589.828402,1762.905325,16539.38462,1263.781065,2566.065089,4527.378698,6189.597633,1317.514793,319.739645,2417.100592,13628.49704,406.9053254,258.6331361,1190.278107,17488.9645,959.6982249,213.4319527,2549,13190.01775,1693.905325,421.8402367,2797.64497,11739.2426,661.852071,288.7928994,1438.366864,7212.627219,1482.147929,432.7573964,1329.088757,4390.213018,648.4911243,166.5443787,3293.514793,4304.940828,1358.502959,995.887574,3206.112426,507.6923077,1030.863905,169,15.99359172,14.06000795,0.476632595,0.918478261,0.586805556,0.89221266
+4730,27642.8301,902.8592233,748.3398058,1106.364078,24569.43689,701.6165049,909.2427184,1650.694175,11219.78641,547.1941748,1542.5,1775.097087,15335.30097,1223.014563,2777.320388,2825.029126,5683.087379,1198.31068,295.8834951,2385.441748,12417.63107,395.5679612,145.3786408,1048.723301,15741.57767,1425.509709,308.8592233,1975.184466,12017.95631,1710.485437,337.9660194,2798.878641,10065.12621,617.7718447,262.961165,1042.18932,5561.15534,1300.912621,387.7135922,1303.5,3183.043689,587.8737864,157.2815534,2658.213592,3277.529126,1203.237864,418.0825243,3325.985437,836.8786408,1033.208738,206,20.83789013,12.99869405,0.78158331,0.927927928,0.572222222,0.53460285
+4731,36704.125,1058.416667,530.5416667,1101.520833,32080.34375,765.5520833,747.75,1638.645833,17652.8125,617.4791667,1386.5,1764.375,20975.95833,1363,1780.40625,3807.760417,7495.145833,1321.760417,299.6979167,2346.4375,15965.1875,421.8958333,140.7395833,1807.979167,20339.08333,1367.75,141.9895833,1555,15434.83333,1826.677083,370.71875,2784.229167,13778.07292,619.1770833,287.6145833,1171.375,8701.197917,1444.0625,404.09375,1306.4375,5600.354167,631.5416667,156.5416667,1520.78125,4900.010417,1337.322917,348.03125,3332.760417,643.1354167,1030.177083,96,12.71322774,10.84337132,0.522040982,0.880733945,0.571428571,0.439114027
+4732,31997.18987,886.2278481,517.0379747,1086.329114,28030.27848,720.3544304,872.6075949,1614.64557,14861.26582,554.1139241,1764.544304,1726.632911,18541.40506,1273.721519,2064.759494,2801.151899,6816.810127,1252.265823,303.9367089,2357.582278,14269.60759,466.6835443,110.721519,1671.506329,18591.65823,636.0886076,129.4936709,1126.063291,14642.5443,2074.594937,384.9493671,2794.43038,12482.91139,940.1898734,274.4303797,1129.417722,7658.075949,1686.620253,408.4303797,1300.721519,4646.227848,596.4177215,152.4050633,1352.443038,4550.455696,1365.025316,1216.607595,3228.683544,709.4303797,1030.607595,79,13.6376268,8.198823775,0.799105072,0.887640449,0.626984127,0.318396001
+4733,26550.68613,1003.124088,969.2116788,1205.372263,24797.37956,793.2554745,668.620438,1888.226277,11623.83212,712.8394161,1383.510949,1817.058394,14458.48175,1401.058394,2798.474453,2995.591241,5400.474453,1369.824818,374.0656934,2334.182482,12159.82482,564.0656934,310.9635036,767.0145985,15366.54015,453.1678832,196.8759124,2233.014599,11502.12409,2145.430657,348.7664234,2814.021898,10261.09489,690.5547445,295.5839416,1161.080292,5546.167883,1794.722628,438.4890511,1337.927007,3475.547445,773.0072993,169.3284672,2391.810219,3365.824818,1373.941606,704.0437956,3213.686131,440.7664234,1030.49635,137,15.7795497,11.35883711,0.69413437,0.958041958,0.713541667,1.439949994
+4734,30754.34146,856.2926829,465.0365854,1065.256098,26854.79268,683.0731707,798.2317073,1584.5,14293.08537,538.195122,1969.231707,1803.439024,17877.20732,1264.682927,2021.780488,2992.597561,6648.670732,1218.426829,292.2195122,2397.134146,13919.80488,754.0365854,115.0487805,2434,18066.34146,465.1463415,123.5365854,1055.353659,14137.56098,2065.097561,379.4390244,2803.585366,11988.08537,743.5121951,270.0731707,1089.609756,7457.439024,1781.268293,398.097561,1300.109756,4554.780488,590.1829268,154.1463415,1928.121951,4494.939024,1300.073171,503.4268293,3210.414634,699.6463415,1032.536585,82,12.41076035,8.765185145,0.707955641,0.931818182,0.630769231,-0.580481361
+4735,25961.24419,951.244186,899.4418605,1162.476744,22868.98837,747.7325581,1007.825581,1811.430233,11590.9186,592.5581395,713.1046512,1789.081395,14227.32558,1326.732558,913.3255814,1228.965116,5476.418605,1321.755814,316.3139535,2352.151163,11071.23256,526.6395349,137.255814,702.2906977,14320.44186,531.0116279,128.5813953,1009.918605,11027.04651,1505,357.744186,2795.523256,9655.72093,1809.872093,281.1395349,1240.325581,5918.581395,953.4186047,425.2906977,1325.965116,3583.453488,621.8372093,163.127907,897.9418605,3425.860465,1403.604651,2581.290698,3366.244186,717.7325581,1030.802326,86,12.2885835,9.117460568,0.670460076,0.977272727,0.796296296,-0.148951894
+4736,29530.9697,912.7435897,562.4778555,1104.328671,26698.87646,724.4289044,844.2191142,1655.081585,13610.64336,562.5221445,1413.561772,1785.354312,17076.02564,1293.920746,2683.757576,3278.400932,6423.424242,1240.822844,313.7575758,2510.5338,13501.65967,501.6177156,181.0722611,1032.755245,17242.19114,976.955711,175.8554779,1621.011655,13238.18881,1798.090909,423.7972028,2797.801865,11531.17716,797.4498834,278.6083916,1176.72028,6872.268065,1389.107226,405.8228438,1312.37296,4233.237762,626.9254079,154.3076923,1917.745921,4071.282051,1349.463869,1786.969697,3260.216783,730.2797203,1037.193473,429,29.46937776,19.35868235,0.753970377,0.910828025,0.662037037,-0.780997237
+4737,27872.9096,820.5084746,537.9943503,1078.355932,24890.76836,648.220339,746.1299435,1558.084746,11619.70056,530.6327684,979.700565,1761.553672,15370.36158,1166.129944,2647.242938,3100.519774,5742.045198,1139.909605,276.5706215,2357.779661,12203.88701,381.2711864,216.9435028,981.2090395,15501.68927,793.5423729,123.5367232,2012.237288,12051.57062,1577.293785,379.0056497,2796.022599,10004.9435,566.8700565,258.480226,999.5254237,5784.062147,1173.655367,385.1355932,1305.898305,3316.40113,611.8870056,147.7062147,2192.502825,3301,1194.169492,294.9548023,3225.440678,817.6214689,1032.785311,177,20.24170244,11.50732756,0.822686003,0.893939394,0.665413534,1.270190362
+4738,27046.11688,920.512987,575.5,1103.292208,24037.53247,715.6233766,753.0194805,1695.409091,12252.18831,549.1233766,1287.694805,1822.993506,15553.12338,1261.88961,2546.272727,3058.766234,5763.519481,1313.162338,309.525974,2389.948052,12444.25974,726.5324675,347.0974026,1388.37013,15645.12338,474.1428571,257.7467532,1933.532468,12002.44805,2638.324675,591.0454545,2795.324675,10243.13636,626.474026,276,1092.636364,6202.084416,1403.422078,410.0519481,1320.61039,3694.246753,811.1558442,166.7857143,4458.155844,3659.253247,1278.941558,535.4545455,3266.62987,748.7922078,1034.74026,154,17.3462877,11.43637035,0.75188186,0.950617284,0.647058824,-0.521608172
+4739,32998.50948,896.3199052,585.7867299,1111.554502,29641.22038,735.0023697,815.8649289,1655.973934,15383.9218,630.4004739,992.049763,1785.637441,19253.35782,1367.327014,1741.672986,3146,7133.862559,1344.85545,333.4312796,2421.677725,16028.87441,465.7772512,260.5450237,818.7985782,20672.45024,709.6018957,138.7867299,2188.827014,15714.52607,1585.71327,573.9004739,2806.677725,14230.37441,966.3530806,305.0616114,1550.665877,8723.552133,1174.976303,442.7582938,1329.746445,5045.566351,643.3270142,167.7701422,3011.599526,5035.398104,1413.684834,1190.635071,3207.981043,521.3127962,1042.21327,422,27.01022427,20.45323128,0.653136337,0.923413567,0.632683658,-0.053113041
+4740,14497.71166,937.1226994,494.0858896,1043.748466,13196.07362,701.1840491,478.9079755,1415.411043,6898.263804,575.1717791,476.4110429,1703.97546,8397.496933,1274.300613,625.0184049,928.4110429,3193.754601,1227.993865,308.5705521,2277.717791,7152.460123,398.5398773,139.8650307,606.0245399,9183.423313,523.3680982,123.0368098,960.208589,7160.03681,1367.104294,400.3374233,2836.779141,6550.368098,595.0122699,275.4171779,1523.067485,4280.325153,820.2699387,414.2147239,1334.214724,2702.570552,616.7055215,158.9202454,1455.441718,2793.208589,1437.484663,5953.312883,3272.190184,550.5214724,1034.907975,163,17.16933321,12.08218106,0.710490231,0.976047904,0.783653846,1.104463187
+4741,15156.9703,970.8019802,502.950495,1032.70297,14190.9901,723.3465347,473.6732673,1315.742574,7258.524752,587.029703,460.6732673,1677.722772,9124.544554,1409.445545,437.8217822,1056.821782,3474.792079,1219.376238,295.4752475,2278.435644,7916.990099,444.6039604,156.1287129,613.7920792,9931.881188,603.029703,124.6039604,859.980198,7648.762376,1340.653465,480.4356436,2817.138614,7035.534653,581.0594059,271.1881188,2231.524752,4365.089109,847.5148515,423.8217822,1342.237624,2867.168317,661.3564356,157.3069307,733.6039604,2644.524752,1386.940594,3190.881188,3238.178218,611.8118812,1035.257426,101,13.71663726,10.53845521,0.640093179,0.89380531,0.597633136,1.050541156
+4742,24176.96842,851.0631579,700.9473684,1089.010526,21968.46316,670.8526316,1041.442105,1629.505263,10599.62105,531.8105263,1674.252632,1761.231579,13866.52632,1204.873684,3349.063158,4457.189474,5202.389474,1196.284211,291.2210526,2485.210526,11248.35789,490.6842105,473.8736842,1878.652632,13800.25263,2284.410526,118.4947368,1157.252632,10844.4,1533.189474,376.2315789,2798.168421,9326.442105,584.2736842,260.8421053,1162.484211,5504.894737,1743.8,398.7894737,1330.557895,3301.210526,700.0631579,153.8105263,2645.810526,3215.6,1219.305263,246.7157895,3367.989474,781.4315789,1034.726316,95,13.24652635,9.379337782,0.706152099,0.95959596,0.664335664,0.964788241
+4743,27646.0146,969.5766423,1269.29927,1225.350365,25128.41606,755.7664234,1052.10219,1885.445255,12275.83942,784.0948905,1331.781022,1891.474453,15617.40146,1331.766423,2276.160584,2427.087591,5496.963504,1540.379562,372.8175182,2440.50365,12370.9635,476.9562044,547,792.1459854,15741.70803,557.5839416,144.0583942,1189.788321,12066.05109,1762.029197,486.649635,2820.963504,10466.13869,775.379562,297.2627737,1253.562044,5913.832117,1087.262774,451.620438,1356.430657,3649.605839,718.1313869,169.8613139,3369.569343,3560.452555,1358.087591,319.5109489,3310.043796,489.8540146,1037.291971,137,15.22782348,11.73862489,0.636996265,0.919463087,0.619909502,-0.204444493
+4744,35926.82639,1019.736111,527.0902778,1081.368056,31884.45139,759.4166667,675.9166667,1562.201389,17518.61111,615.25,1605.395833,1730.354167,20836.43056,1340.159722,1312.4375,2527.333333,7799.152778,1314.090278,318.7986111,2415.472222,16390.49306,411.7152778,197.9583333,1876.694444,20826.36111,753.0138889,146.9375,822.4652778,15909.84722,2015.229167,346.7291667,2796.486111,14195.56944,627.7916667,281.9930556,1107.791667,9169.638889,1654.361111,414.0486111,1309.319444,5856.930556,829.4722222,156.7569444,1240.770833,5369.875,1396.590278,2411.423611,3227.590278,636.7986111,1038.215278,144,17.51362659,11.24940524,0.766434054,0.917197452,0.571428571,0.373795857
+4745,32491.33,1050.415,501.105,1066.485,28450.245,765.09,641.41,1779.36,15698.945,647.855,982.82,1886.65,18895.45,1332.57,1852.04,2495.945,6891.46,1266.05,302.545,2308.095,13941.1,394.68,161.49,1242.67,18327.005,575.61,257.11,1777.825,13898.68,1817.24,371.83,2787.03,12221.34,609.705,266.355,1110.53,7764.94,1247.49,387.51,1318.415,4867.015,619.39,153.245,1405.085,4504.33,1295.1,843.59,3302.21,656.495,1035.205,200,20.87281461,12.6258786,0.796304609,0.952380952,0.732600733,-1.447851881
+4746,31115.7,998.05,554.4333333,1097.25,27064.32917,750.4208333,1053.079167,1645.5625,13829.12917,599.5583333,1649.466667,1856.708333,17508.67083,1316.05,2928.733333,3589.195833,6637.841667,1267.679167,311.9,2605.933333,13011.02917,392.2625,157.0666667,1948.620833,16748.52083,523.4083333,131.1458333,1440.641667,12716.03333,2378.391667,427.7833333,2820.7875,11108.43333,666.9875,270.5291667,1206.333333,6821.966667,1497.816667,410.9375,1325.6625,4283.616667,610.0291667,158.1208333,1982.8,3910.541667,1301.8125,1058.429167,3435.7375,688.3666667,1039.895833,240,20.33254972,15.46380828,0.649285844,0.902255639,0.705882353,-0.042830754
+4747,25520.97967,859.203252,631.504065,1076.00813,23486.56504,684.0934959,677.9105691,1589.569106,10719.89837,534.9065041,1333.020325,1776.613821,14492.23171,1220.430894,2069.906504,2628.577236,5415.585366,1214.012195,290.0731707,2327.573171,11538.23171,376.0284553,407.5243902,1691.146341,14303.3374,498.0569106,314.8658537,1307.796748,11254.80488,2019.585366,387.1869919,2794.219512,9452.174797,682.2479675,255.4146341,1017.300813,5481.849593,1380.979675,386.6788618,1314.03252,3263.402439,664.3455285,152.3821138,2081.073171,3194.845528,1226.711382,692.1097561,3247.682927,801.1422764,1040.276423,246,23.82105311,14.06325788,0.807132043,0.904411765,0.602941176,1.411836843
+4748,26680.61111,1053.079365,689.2777778,1117.912698,24323.77778,756.952381,518.0555556,1673.777778,10786.53968,593.1587302,518.0793651,1789.261905,14454.3254,1275.603175,1285.492063,1159.888889,5454.730159,1273.301587,312.3730159,2290.357143,12150.98413,363.6984127,172.5793651,568.2936508,15506.95238,430.7460317,120.6031746,1699.111111,11454.68254,1573.595238,330.1825397,2923.888889,10105.68254,1111.873016,271.0873016,1018.198413,5164.68254,856.468254,421.3253968,1308.904762,3268.968254,619.9047619,157.8333333,1909.888889,3175.468254,1270.626984,1872.563492,3186.912698,426.7460317,1037.079365,126,14.77400528,11.25853983,0.647517458,0.940298507,0.617647059,-1.246869728
+4749,23310.67241,1068.974138,1048.336207,1202.448276,21364.7931,747.9310345,1040.612069,1817.62069,9972.655172,656.6724138,697.0603448,1862.163793,12352.2069,1286.301724,1106.25,1385.663793,4470.672414,1410.336207,350.5862069,2572.887931,9848.612069,416.8706897,395.9396552,590.75,12543.16379,438.9396552,125.2068966,1346.301724,9229.439655,1656.482759,444.4827586,2842.137931,8294.741379,905.4655172,296.2931034,1290.112069,4532.784483,884.9655172,430.5344828,1374.206897,2750.689655,657.6465517,168.7413793,2312.051724,2755.637931,1330.043103,975.0603448,3343.568966,471.5431034,1037.724138,116,12.29734579,12.08919565,0.183211223,0.943089431,0.743589744,0.299653715
+4750,38058.64211,1172.221053,545.1578947,1079.010526,33152.89474,828.3684211,859.2,1670.568421,17430.55789,661.3894737,1685.631579,1783.505263,21067.93684,1398.115789,2895.652632,2914.178947,7854.547368,1320.652632,315.4526316,2317.042105,14776.18947,394.7473684,135.6,1668.821053,18351.08421,666.2947368,274.8736842,1247.673684,14216.36842,2347.305263,373.9052632,2817.747368,12417.46316,584.3368421,267.6105263,964.6736842,7401.736842,1558.084211,388.6315789,1330.705263,4913.473684,589.9157895,151.0105263,1309.463158,4281.463158,1238.336842,310.2421053,3445.947368,676.1578947,1037.736842,95,12.32350287,11.24900624,0.408386394,0.848214286,0.608974359,0.521310556
+4751,24534.49057,888.3962264,693.1320755,1147.924528,22349.16981,697.009434,788.1603774,1672.95283,10176.0283,550.0188679,1175.386792,1800.981132,12357.9434,1232.320755,2948.09434,2349.424528,4434.518868,1251.716981,307.6226415,2374.858491,10135.73585,367.9339623,325.745283,1717.292453,12662.19811,505.754717,121.5,1413.896226,9226.528302,1776.386792,356.009434,2804.04717,8105.924528,651.6320755,264.8396226,1122.45283,4339.028302,1239.613208,408.5283019,1316.443396,2663.311321,653.6320755,161.6320755,1536.971698,2644.745283,1268.962264,910.9528302,3239.792453,460.6603774,1039,106,13.1374878,10.6564965,0.584835707,0.946428571,0.803030303,0.155932194
+4752,14509.45977,991.5747126,548.5172414,1072.172414,13683.89655,811.3678161,458.6321839,1362.448276,7011.137931,576.5402299,644.7356322,1659.862069,8906.862069,1518.091954,527.0114943,1632.816092,3366.942529,1245.54023,316.7931034,2262.735632,7910.172414,459.5057471,122.2643678,676.3218391,10128.16092,524.091954,138,894.4827586,7809.781609,1550.206897,427.2643678,2802.689655,7168.816092,591.8275862,287.091954,1777.517241,4395.873563,1008.367816,411.5172414,1322.54023,3137.344828,645.0114943,170.4022989,850.0229885,2792.195402,1482.586207,598.5517241,3334.16092,620.5862069,1040.126437,87,12.26849116,10.16898662,0.559440975,0.87,0.557692308,-0.25915005
+4753,23057.57627,1075.644068,554.9661017,1017.847458,21047.49153,748.9661017,473.9661017,1439.40678,11538.98305,595.3050847,1077.152542,1694.016949,13564.62712,1314.847458,940.1694915,1574.169492,5303.898305,1247.661017,295.9491525,2295.694915,10439.83051,388.2711864,141.1864407,1187.525424,12850.49153,452.0338983,319.8813559,809.5762712,9693.084746,1720.830508,346.5932203,2785.79661,8560.474576,551.1694915,245.2033898,1102.440678,5770.237288,1271.440678,377.6610169,1293.305085,3965.372881,665.0677966,149.8305085,932.5423729,3410.118644,1271.711864,344.2881356,3186.338983,628.3559322,1038.898305,59,12.30090375,6.226273355,0.862437309,0.893939394,0.702380952,0.174954242
+4754,25178.93103,779.5724138,462.3034483,1077.434483,22373.88276,629.7241379,821.6482759,1566.227586,11261.81379,507.5310345,1243.4,1763.2,14113.29655,1198.606897,1551.22069,1994.772414,5663.986207,1148.634483,266.0413793,2542.055172,11155.78621,4729.386207,125.8137931,1420.2,14500.0069,497.6758621,113.8,1007.62069,11259.95862,1799.710345,373.4068966,2784.013793,9693.717241,670.7103448,252.9724138,1182.2,6061.448276,1551.275862,379.1793103,1309.634483,3569.524138,587.8896552,145.6413793,1640.213793,3525.372414,1235.337931,304.6965517,3184.055172,704.7310345,1041.710345,145,15.29270817,12.70536497,0.556553208,0.947712418,0.56640625,-1.011349282
+4755,39601.61017,934.9745763,670.0932203,1153.957627,35315.22881,778.5169492,1060.20339,1776,17771.28814,606.3220339,2374.177966,1852.881356,22445.69492,1349.872881,2481.101695,3830.101695,8373.262712,1350.559322,346.0677966,2576.711864,18477.76271,446.3559322,165.8474576,1500.898305,23912.28814,962.6610169,166.4152542,1241.635593,18136.62712,2066.533898,362.5932203,2835.338983,15838.01695,660.0932203,313.8050847,1174.991525,9217.050847,1966.09322,459.7966102,1318.364407,5477.711864,632.2288136,170.7288136,3087.228814,5393.313559,1406.864407,463.1779661,3301.652542,502.6779661,1041.008475,118,15.70779374,9.791627036,0.781934129,0.944,0.702380952,0.98320973
+4756,23072.21875,1060.6875,559.3958333,1075.083333,20558.94792,760.6979167,556.1770833,1662.322917,10500.78125,800.9791667,836.9583333,1820.239583,12526.375,1291.5,2107.6875,2801.854167,4871.791667,1246,286.6666667,2307.958333,7371.645833,355.1354167,898.1666667,802.46875,9274.177083,976.4375,115.25,1859.083333,7139.864583,1503.447917,405.2083333,2756.46875,6288.8125,643.4270833,241.8645833,1175.395833,3988.760417,1120.072917,366.1041667,1339.125,2553.78125,845.125,143.2916667,2768.125,2243.75,1156.302083,739.5416667,3270.75,666.8958333,1041.90625,96,12.34388873,10.36729674,0.542783227,0.989690722,0.623376623,-0.230621759
+4757,24340.49,805.43,592.71,1075.51,21549.17,660.03,1119.66,1587.79,10646.07,508.12,1957.47,1742.16,13749.08,1188.21,3793.67,4128.05,5132.63,1241.42,287.34,2599.19,11279.09,433.73,467.91,2666.89,13985.61,2429.24,118.02,985.25,10896.21,1671.74,488.26,2808.19,9317.32,591.31,254.05,963.52,5445.8,2152.53,395.96,1327.13,3241.57,751.62,150.66,5433.85,3226.19,1242.38,477.38,3155.54,772.39,1041.01,100,12.09622312,10.72036316,0.463193718,0.952380952,0.641025641,-0.168241197
+4758,30880.11864,1135.144068,919.1355932,1130.567797,26252.28814,775.4830508,645.1864407,1676.364407,11441.83898,630.4152542,575.0932203,1781.788136,15389.13559,1368.991525,2120.245763,1991.847458,5517.533898,1314.771186,315.1186441,2330.033898,12756.29661,382.8644068,135.440678,619.9322034,16008.52542,459.2542373,121.1016949,2565.016949,11921.71186,1630.728814,357.0932203,2883.822034,10412.5339,795.2711864,275.6610169,962.5423729,5153.161017,910.6016949,414.7966102,1323.550847,3221.59322,581.3220339,157.220339,1971.644068,3250.635593,1243.194915,1588.635593,3240.779661,434.4067797,1043.847458,118,16.52677159,9.310932101,0.826194622,0.959349593,0.631016043,-0.492241305
+4759,35168.2967,928.5824176,728.956044,1108.274725,30633.81319,729.4065934,637.0769231,1673.120879,13901.67033,607.2527473,976.1208791,1811.252747,18379.96703,1242.989011,3866.32967,3530.978022,6864.989011,1282.263736,309.7802198,2308.89011,14863.64835,453.9120879,866.2527473,637.0989011,19382.57143,854.2087912,125.4285714,4374.835165,14148.26374,1822.483516,399.9120879,2807.978022,12471.52747,599.7912088,278.5274725,1044.56044,6037.384615,1745.527473,414.3626374,1330.131868,3731.593407,834.956044,156.9450549,2794.087912,3812.813187,1261.989011,315.8021978,3284.263736,445.3626374,1041.417582,91,11.72661207,10.05529502,0.514523025,0.989130435,0.827272727,-1.073761547
+4760,17911.10132,948.5022026,540.2731278,1103.643172,15993.34361,720.0352423,561.3039648,1564.788546,8230.572687,577.0660793,369.9603524,1724.590308,10378.77533,1345.0837,898.8942731,1011.180617,4132.894273,1247.53304,304.0969163,2274.246696,9018.427313,440.2026432,118.9911894,486.092511,11844.30396,490.8193833,117.7665198,923.7180617,8938.920705,1335.295154,334.9118943,2836.577093,8151.960352,669.0440529,276.3480176,1434.687225,5309.334802,899.1409692,419.6167401,1311.515419,3271.806167,1435.440529,160.2290749,964.2334802,3308.603524,1625.696035,5361.471366,3245.22467,585.0792952,1048.30837,227,22.2344127,13.51944284,0.79390534,0.890196078,0.720634921,0.05518181
+4761,25995.21538,1015.753846,460.7692308,1035.353846,21154.49231,726.8461538,497.2769231,1481.646154,11751.81538,582.1076923,1199.307692,1723.446154,14541.61538,1288.6,678.5538462,1814.092308,5521.076923,1238.138462,296.4615385,2372.492308,11007.38462,388.8923077,98.61538462,1196.061538,15178.69231,641.6615385,113.7538462,790.5538462,11288.15385,1531.430769,347.9538462,2793.184615,10065.86154,724.0769231,260.5076923,1069.230769,6676.338462,1178.738462,386.6769231,1317.246154,3996.430769,585.8923077,155.9230769,1273.861538,3977.446154,1451.569231,11826.2,3183.507692,646.6307692,1043.969231,65,11.11773678,8.075572043,0.687305631,0.844155844,0.5,-1.316573025
+4762,28168.90761,898.7880435,577.7391304,1078.108696,25246.68478,709.951087,812.0108696,1607.152174,11433.00543,655.701087,905.0923913,1796.201087,15695.08152,1227.630435,3111.755435,3261.771739,5847.461957,1218.11413,304.5706522,2365.021739,12552.70652,364.8695652,1559.684783,1185.168478,16077.29891,427.7445652,153.8913043,2908.847826,12277.1087,1970.266304,399.5815217,2789.413043,10066.89674,684.5923913,259.7228261,1067.788043,5543.815217,1015.413043,387.4782609,1351.706522,3186.309783,1003.11413,150.5054348,3054.608696,3226.608696,1190.375,433.5923913,3248.413043,819.173913,1046.461957,184,16.84929562,14.43827253,0.515471715,0.915422886,0.721568627,-0.059834265
+4763,25172.61702,967.4893617,677.1276596,1104.553191,23230.38298,728.5425532,762.393617,1670.053191,9921.457447,543.8829787,766.393617,1749.659574,13554.76596,1248.37234,2917.957447,2507.702128,5033.308511,1181.297872,294.8829787,2303.723404,11033.09574,380.4042553,266.4468085,876.8617021,13516.84043,832.7234043,136.3617021,4059.957447,10333.32979,1680.319149,362.5425532,2787.606383,8511.276596,1428.138298,267.6914894,1041.095745,4476.117021,939.4042553,378.4787234,1306.670213,2652.819149,594.2234043,150.0744681,3057.361702,2600.808511,1167.446809,267.9255319,3534.287234,833.3085106,1044.744681,94,12.94184861,9.762396726,0.656497911,0.895238095,0.55952381,1.363533246
+4764,31727.97531,942.4938272,487.2469136,1057.08642,28326.19753,708.8518519,834.962963,1524.888889,14452,551.4814815,1219.518519,1743.592593,18092.03704,1221.296296,1458.604938,2686.876543,6903.617284,1198.308642,299.1111111,2413.691358,14695.7037,1908.802469,128.8765432,1142.691358,18602.59259,906.3580247,117.0864198,1302.753086,14467.93827,1633.716049,398.382716,2774.703704,12550.71605,588.4814815,259.7654321,995.2345679,7362.82716,1535.098765,397.037037,1294.098765,4480.617284,605.2839506,149.8395062,1543.08642,4449.222222,1243.308642,948.9012346,3289.617284,741.345679,1045.37037,81,11.76469011,9.243159246,0.618646342,0.91011236,0.623076923,1.393205262
+4765,24402.95798,778.7647059,510.2521008,1063.823529,21423.15126,629.210084,1111.436975,1523.512605,10380.35294,502.3277311,1090.731092,1743.554622,13841.68908,1176.12605,2323.176471,3468.319328,5180.714286,1152.151261,281.5378151,2403.142857,11244.72269,395.9579832,663.8823529,3086.957983,13982.77311,1119.504202,110.7142857,1178.117647,10753.2521,1522.411765,348.8739496,2781.428571,9242.168067,773.8235294,252.5630252,943.5630252,5285.07563,2408.907563,390.8991597,1306.378151,3132.554622,1367.504202,152.8319328,3177.10084,3185.159664,1222.319328,1995.672269,3359.386555,781.7394958,1046.420168,119,13.61545007,11.54398904,0.53022092,0.888059701,0.566666667,-0.83181548
+4766,24406.52041,907.122449,1438.091837,1211.795918,22430.65306,722.0102041,943.1428571,1786.510204,10644.97959,697.1428571,564.2857143,1804.377551,13671.66327,1294.306122,901.0612245,826.6734694,5007.214286,1546.581633,370.7653061,2396.05102,11524.53061,430.2346939,335.1632653,543.8265306,15101.93878,446.3367347,129.6836735,1004.602041,11107.7449,1527.469388,753.8673469,2883.357143,9922.081633,756.0204082,290.9591837,1237.255102,5532.94898,855.8877551,443.8571429,1370.510204,3412.857143,661.5612245,162.2653061,1451.510204,3409.877551,1354.428571,227.6122449,3294.326531,482.5,1047.612245,98,14.40393958,8.843217347,0.78934931,0.924528302,0.7,0.187493886
+4767,33845.75,911.55,936.32,1135.16,31345.09,771.24,995.02,1713.62,15015.66,620.02,1550.53,1873.4,19487.11,1316.2,2706.34,3119.2,7077.98,1391.17,350.08,2366.56,16933.92,453.5,299.42,1491.45,21597.4,1154.25,516.84,1576.48,16545.32,1813.23,446.68,2828.62,14616.88,674.32,304.53,1132.86,8260.3,1551.43,463.4,1340.52,5088.9,657.1,170.19,4622.58,4856.89,1391.12,269.1,3354.61,492.68,1049.17,100,15.56139984,8.355958053,0.843603254,0.952380952,0.606060606,-0.581910566
+4768,35875.07947,932.6490066,585.0794702,1141.456954,31914.74172,756.4900662,784.7417219,1688.682119,16063.45695,610.1192053,564.3509934,1729.344371,19935.40397,1396.596026,1505.443709,2805.059603,7285.013245,1330.556291,340.4370861,2317.701987,16389.70199,453.1788079,283.4701987,1215.496689,21290.01325,495.0662252,133.2913907,1889.596026,15991.62252,1498.284768,504.6291391,2814.576159,14468.63576,814.1523179,309.1523179,1480.423841,8652.211921,1139.337748,453.0264901,1316.099338,5025.503311,712.7350993,168.0927152,2256.781457,5044.629139,1421.119205,1307.754967,3250.10596,535.2582781,1050.225166,151,16.82696936,11.70531175,0.718402135,0.94375,0.599206349,-0.373761232
+4769,26599.89431,1036.325203,495.3495935,1100.365854,23441.10569,787.0569106,497.2439024,1531.504065,11797.36585,633.9186992,947.4065041,1739.373984,14330.98374,1429.195122,1067.227642,1940.593496,5333.227642,1345.577236,336.1219512,2293.731707,11806.97561,445.9186992,128.4146341,855.6829268,15089.17073,497.1544715,189.5121951,1398.544715,11607.43089,1563.065041,419.5203252,2818.479675,10282.63415,776.9105691,299.7235772,1396.01626,6278.504065,1019.398374,439.6504065,1314.943089,3727.666667,619.7804878,172.8536585,1312.829268,3622.487805,1519.439024,8651.097561,3213.658537,549.6341463,1047.065041,123,14.52021327,11.06498144,0.647530104,0.931818182,0.675824176,1.168317797
+4770,19428.36134,984,627.7478992,1149.327731,17272.7395,752.789916,592.2352941,1674.268908,8826.764706,603.0756303,396.7226891,1740.428571,10890.63866,1379.87395,1437.714286,1267.983193,4196.12605,1266.773109,313.1764706,2284.411765,8309.235294,651.5042017,174.0084034,501.3277311,10874.77311,517.4789916,121.3109244,898.7394958,8185.529412,1329.378151,326.9579832,2816.504202,7452.596639,697.8571429,280.6470588,1381.731092,4827.058824,1023.310924,412.5714286,1329.747899,2981.235294,2399.857143,161.9159664,871.7731092,2824.647059,1659.773109,1253.697479,3244.521008,596.7647059,1047.89916,119,14.04862869,10.80496101,0.639114697,0.967479675,0.832167832,0.381479712
+4771,33274.83984,969.265625,702.71875,1127.871094,26341.77734,660.9960938,620.21875,1548.828125,11679.55469,548.390625,523.5625,1731.90625,15353.14844,1177.910156,3357.597656,1915.558594,5805.5625,1203.214844,299.5664063,2299,12845.125,342.515625,431.7929688,513.8671875,15769.83594,746.0078125,117.4960938,2686.226563,11745.75781,1528.035156,335.6445313,2816.945313,10183.27734,598.5351563,265.5507813,921.6171875,4866.164063,915.5,397.8164063,1304.929688,2976.753906,714.1757813,149.4453125,1640.15625,3003.308594,1171.714844,444.9882813,3239.359375,444.8007813,1052.164063,256,27.37652673,12.99606133,0.880139309,0.859060403,0.602352941,-1.245150133
+4772,23746.43077,932.6076923,500.7692308,1045.815385,20820.95385,691.6153846,650.3769231,1503.461538,10487.57692,551.0538462,1287.715385,1719.7,13634.02308,1271.753846,2716.630769,2500.030769,5011.523077,1179.053846,282.3384615,2642.876923,10717.67692,435.1307692,129.8461538,2106.638462,13891.40769,461.4230769,269.0076923,1176.453846,10681.52308,2087.776923,341.0846154,2784.823077,9217.753846,680.0153846,255.3461538,981.9461538,5495.492308,1309.053846,381.6923077,1293.269231,3287.884615,571.3230769,154.9153846,1599.638462,3230.669231,1255.438462,2475.584615,3260.953846,713.6538462,1049.761538,130,13.29561176,12.70129137,0.29563973,0.977443609,0.619047619,-1.419280784
+4773,23820.06364,982.6636364,1285.245455,1306.709091,21862.47273,774.7727273,1059.581818,1925.136364,9687.590909,656.0181818,598.4454545,1866.981818,12427.21818,1330.890909,836.0909091,1303.790909,4275.709091,1450.945455,337.3181818,2397.581818,9928.318182,445.0909091,372.9636364,593.7818182,12578.55455,469.8909091,125.7545455,1221.345455,9197.745455,1594.236364,417.2818182,2831.409091,8276.063636,667.6636364,288.5,1281.354545,4352.281818,874.2818182,437.0181818,1361.2,2647.918182,660.5909091,162.0090909,1579.145455,2651.409091,1340.918182,234.4636364,3260.745455,473.6363636,1050.818182,110,13.86896879,10.31449925,0.668501703,0.924369748,0.654761905,-0.007230265
+4774,24459.46486,817.8972973,500.4972973,1062.762162,22118.02162,725.9297297,1106.427027,1558.010811,10512.48649,526.6324324,1722.502703,1753.562162,13505.34054,1178.535135,2736.702703,3324.421622,4996.664865,1176.081081,295.3189189,2562.994595,11057.4,578,536.4648649,1720.875676,13544.6,1023.854054,404.1945946,1390.108108,10391.45405,1916.313514,427.2972973,2796.810811,8799.718919,587.3783784,254.5945946,973.427027,5004.189189,1456.616216,379.6756757,1320.010811,3029.043243,687.8486486,153.1189189,2765.097297,2936.578378,1212.454054,458.5567568,3220.87027,757.0108108,1052.778378,185,17.39642178,13.59385881,0.624009258,0.953608247,0.734126984,0.23081254
+4775,17891.77273,907.0045455,514.8545455,1083.177273,15687.55909,697.0727273,479.9636364,1612.395455,8078.695455,555.0909091,513.8090909,1784.663636,9753,1271.645455,913.7363636,1555.436364,3934.395455,1273.7,291.2363636,2312.590909,7679.277273,453.85,237.5909091,741.9454545,9781.240909,561.3727273,116.1636364,880.8272727,7434.204545,1378.259091,366.4636364,2809.122727,6700.459091,679.4363636,261.7636364,1732.954545,4342.445455,1126.631818,401.9590909,1340.704545,2751.586364,2930.686364,154.4454545,1376.831818,2614.686364,2110.690909,7448.868182,3250.472727,612.7272727,1053.686364,220,24.77090018,11.77989007,0.879686762,0.909090909,0.555555556,1.01503659
+4776,23158.62698,817.7619048,511.1190476,1067.97619,20040.94444,631.4126984,733.8571429,1536.603175,9355.960317,504.3015873,1667.246032,1795.920635,12655.19841,1148.293651,3114.547619,2496.904762,4770.84127,1133.873016,272.3650794,2303.111111,10138.79365,369.8412698,220.6031746,1224.214286,12729.9127,631.8968254,114.3174603,1077.269841,9610.206349,1887.388889,349.1507937,2785.253968,8316.619048,607.5396825,242.3412698,908.3095238,4637.126984,1374.142857,368.5555556,1320.103175,2702.365079,598.6269841,148.3968254,2366.888889,2761.412698,1164.738095,765.7063492,3214.246032,793.5079365,1051.142857,126,14.07131264,11.54511454,0.571687068,0.926470588,0.692307692,1.20332611
+4777,24926.66667,923.6504065,1006.121951,1209.154472,21685.53659,703.8780488,789.902439,1794.617886,10011.52846,568.1219512,622.5284553,1830.837398,13183.57724,1283.642276,2167.520325,1693.186992,4957.03252,1328.422764,327.8455285,2373.219512,10803.77236,394.0243902,509.1219512,570.1056911,14101.44715,492.601626,122.4715447,1456.130081,10093.68293,1608.788618,362.0650407,2846,8884.569106,678.1544715,280.2682927,1127.195122,4538.243902,935.097561,413.0894309,1343.138211,2738.268293,795.0162602,162.2601626,2228.658537,2862.439024,1333.04878,1066.235772,3321.764228,461.2439024,1051.650407,123,13.83394729,11.41347816,0.565082954,0.968503937,0.788461538,-0.400029361
+4778,36580.14232,966.6104869,563.9513109,1115.775281,32582.54307,782.3258427,894.4419476,1665.35206,16013.69663,618.6966292,1476.632959,1793.726592,20440.44944,1347.494382,2588.58427,3399.134831,7335.17603,1306.385768,337.5730337,2354.576779,17048.54307,419.7265918,300.2846442,1280.41573,21713.49813,672.7565543,309.1610487,2050.674157,16385.76779,1923.464419,393.5355805,2823.76779,14586.19476,649.9325843,301.6853933,1183.456929,8274.891386,1294.494382,444.3970037,1335.108614,4828.314607,656.3183521,168.906367,2440.640449,4669.191011,1369.730337,672.5280899,3266.47191,503.3033708,1055.595506,267,20.80344333,16.60769374,0.602240573,0.930313589,0.669172932,-1.145631913
+4779,28448.76744,977.0174419,466.755814,1052.587209,25415.69767,727.3604651,599.1511628,1526.709302,13256.59884,576.2616279,868.4476744,1684.930233,16078.99419,1317.19186,993.6511628,1324.465116,6008.389535,1238.598837,301.4418605,2389.482558,12246.9593,412.6453488,102.9593023,687.6395349,15542.92442,938.0406977,113.7906977,832.8372093,11899.87209,1432.104651,330.7034884,2803.918605,10505.45349,630.3255814,264.6511628,1178.360465,6366.906977,1100.069767,384.5813953,1302.69186,4043.290698,590.5406977,150.0348837,1941.180233,3696.203488,1399.645349,6966.906977,3195.75,647.7209302,1052.901163,172,18.15911556,13.74544164,0.653479233,0.807511737,0.573333333,1.532274438
+4780,20826,901.1048387,432,1037.709677,18641.54839,674.3064516,712.8548387,1441.137097,9398.298387,549.8306452,751.3709677,1742.145161,11836.49194,1236.266129,1609.5,2046.169355,4444.395161,1149.290323,289.3387097,2387.935484,9151.935484,362.2741935,121.8387097,613.6612903,11662.03226,471.5967742,111.5967742,875.3225806,8983.145161,1599.983871,360.5967742,2785.548387,7945.258065,657.9758065,242.4677419,1093.08871,4739.274194,1023.669355,375.8790323,1293.677419,2958.596774,581.1854839,149.6209677,1714.596774,2910.693548,1396.572581,4699.879032,3095.637097,676.7741935,1051.685484,124,14.23376129,11.1312498,0.623238896,0.96875,0.738095238,-1.102055152
+4781,30870.225,882.9416667,605.7666667,1121.991667,27615.01667,707.3083333,857.9166667,1692.075,11843.85,568.3416667,1041.383333,1718.375,16720.925,1243.791667,3818.316667,2829.966667,6075.45,1265.591667,304.0833333,2311.066667,13353.58333,393.7916667,812.6166667,742.7083333,16469.29167,426.9583333,512.925,2041.025,12397.575,1766.466667,438.4416667,2806.175,10250.45,649.925,264.3166667,937.7083333,5453.316667,916.9583333,391.6333333,1353.208333,3136.108333,789.3583333,153.175,2997.75,3142.583333,1223.241667,395.775,3228.5,810.0583333,1055.808333,120,17.25351871,9.455538225,0.83645517,0.845070423,0.512820513,0.382894346
+4782,17081.60526,1090.561404,481.8157895,1039.798246,15408.31579,760.622807,445.0263158,1452.350877,7831.754386,632.7280702,409.1754386,1707.315789,9750.429825,1346.307018,695.3245614,1018.026316,3694.780702,1246.561404,284.5964912,2240.596491,7675.122807,385.7192982,107.3947368,531.9122807,10085.63158,464.1578947,112.377193,976.8684211,7647.491228,1344,361.9298246,2778.885965,6865.192982,576.7105263,250.3333333,1365.377193,4310.166667,835.8508772,379.9473684,1309.815789,2775.377193,822.4385965,151.9298246,1645.508772,2689.526316,1479.552632,7028.77193,3151.333333,634.5438596,1054.640351,114,12.5931812,11.5870107,0.39167893,0.966101695,0.791666667,0.57763986
+4783,28489.87586,856.9448276,477.4758621,1061.217241,25199.3069,664.6482759,732.8413793,1529.67931,12134.08966,521.7517241,827.5241379,1744.124138,15627.91379,1201.441379,3052.531034,2694.751724,5859.865517,1168.672414,289.5655172,2283.548276,12621.54138,757.9517241,347,927.3758621,15923.30345,705.3689655,114.0482759,1762.455172,12081.1069,1692.468966,389.2482759,2791.234483,10376.22414,616.7896552,251.0724138,972.1413793,5794.068966,1214.996552,383.4931034,1313.489655,3532.196552,641.2724138,147.8689655,1743.534483,3438.293103,1223.437931,1036.717241,3244.368966,739.6931034,1057.634483,290,23.1918836,16.3617149,0.708716743,0.911949686,0.604166667,1.307742274
+4784,33259.44444,967.7070707,728.7979798,1162.282828,30705.88889,776.6464646,806.4747475,1722.626263,15239.56566,610.8686869,766.2323232,1764.131313,18941.89899,1385.434343,1392.818182,2049.090909,7111.828283,1386.10101,352.3939394,2448.626263,16406.63636,485.9494949,137.8080808,907.7979798,21159.41414,969.2323232,136.0909091,1936.757576,16072.74747,1589.424242,454.3232323,2832.79798,14669.94949,755.4040404,318.3030303,1914.89899,8945.959596,1028.434343,485.1515152,1350.767677,5249.222222,649.8787879,179.8181818,2549.30303,5102.505051,1510.949495,2469.181818,3355.575758,544.7171717,1056.434343,99,12.77340459,10.73352062,0.542118186,0.846153846,0.507692308,-1.500329263
+4785,16082.94304,909.3227848,435.1835443,1024.056962,14563.79114,685.5759494,481.4873418,1385.651899,7130.506329,566.0189873,421.7468354,1685.379747,8898.189873,1268.64557,726.3481013,1218.943038,3301.411392,1201.518987,297.8607595,2276.981013,7479.626582,394.6139241,97.20886076,634.7405063,9653.71519,438.3481013,115.6392405,879.2278481,7596.411392,1576.873418,395.2088608,2798.303797,6847.132911,555.2974684,268.0189873,1237.329114,4182.620253,1011.829114,400.9683544,1316.71519,2503.702532,597.9556962,161.2278481,889.778481,2584.183544,1311.158228,1364.075949,3125.708861,569.8544304,1059.202532,158,16.16435037,12.59684282,0.626653752,0.963414634,0.658333333,-0.404150934
+4786,18986.51553,800.7267081,403.9968944,1037.751553,16734.8913,632.9875776,517.0745342,1451.139752,8476.596273,498.6987578,500.9006211,1684.481366,10711.01242,1195.065217,780.4006211,959.6055901,4220.614907,1135.928571,273.1273292,2251.406832,8609.024845,365.7484472,109.1677019,689.0652174,11181.28571,514.4068323,110.0838509,947.7546584,8509.161491,1263.549689,356.636646,2812.531056,7482.701863,656.8229814,256.2701863,1222.47205,4598.298137,937.0931677,375.8043478,1303.52795,2818.313665,588.5217391,150.1956522,1715.97205,2791.099379,1317.372671,4316.338509,3106.298137,666.8074534,1060.639752,322,29.39927514,14.80286366,0.863988712,0.891966759,0.596296296,1.310459542
+4787,30825.56494,912.5844156,526.7272727,1108.103896,27820.48052,749.9285714,748.6948052,1605.571429,13318.28571,590.9415584,1057,1761.428571,17089.34416,1369.350649,2024.662338,3215.051948,6332.305195,1301.201299,351.4805195,2282.844156,14342.05844,438.4480519,524.2337662,1106.402597,18709.93506,468.0194805,243.5,1851.993506,13871.53896,1734.181818,489.8961039,2818.194805,12402.19481,724.5909091,298.5519481,1395.532468,7162.272727,1162.383117,437.8831169,1318.876623,4053.902597,810.4090909,174.1753247,2476.448052,4169.922078,1399.019481,1417.318182,3222.493506,525.538961,1061.948052,154,17.18159561,11.87152473,0.722908044,0.916666667,0.647058824,-1.376946507
+4788,22957.40945,841.6299213,511.2125984,1056.787402,19791.47244,654.6299213,699.8503937,1500.622047,9441.779528,519.1811024,1504.307087,1724.267717,12108.6378,1173.354331,2546.188976,3634.464567,4640.874016,1122.141732,278.8267717,2497.125984,9594.275591,362.2598425,206.2913386,1234.614173,12414.29921,2064.755906,114.3779528,1685.07874,9414.779528,1501.913386,364.9606299,2780.19685,8157.637795,875.6850394,243.9606299,1103.96063,4557.637795,1713.259843,368.5433071,1308.897638,2683.133858,609.1417323,150.5275591,2848.724409,2696.401575,1200.086614,1694.645669,3190.944882,720.519685,1062.377953,127,14.86433643,11.04196923,0.669458129,0.940740741,0.705555556,0.270000148
+4789,33883.98,908.29,659,1140.53,28827.81,717.35,831.14,1721.8,12747.23,533.71,619.93,1755.44,17573.74,1254.88,3367.83,2332.86,6313.85,1244.97,306.45,2276.69,13727.01,491.53,457.49,718.79,17108.95,465.4,119.44,1930.83,12459.75,1773.62,411.28,2801.47,10283.03,614.79,268.33,1088.85,5346.84,1068.91,394.16,1299.9,3031.63,664.81,153.79,3112.57,3046.88,1209.74,336.32,3218.31,801.93,1060.85,100,13.89115792,9.626906655,0.720914456,0.934579439,0.606060606,1.263036259
+4790,22610.30973,889.079646,874,1160.938053,19668.0354,696.1061947,754.7256637,1666.20354,9121.743363,777.7610619,788.3362832,1826.283186,11983.37168,1223.522124,2653.362832,1762.646018,4457.752212,1311.318584,344.8938053,2352.654867,9680.061947,391.8938053,610.2654867,784.2035398,12733.30973,455.3185841,124.3628319,1586.044248,9097.831858,1828.477876,340.8849558,2825.247788,7960.584071,830.8584071,273.9911504,1042.362832,4114.59292,927.3185841,418.0530973,1366.80531,2444.80531,724.2123894,158.6283186,2209.300885,2645.734513,1314.185841,344.1150442,3306.415929,478.3716814,1061.424779,113,14.44723379,10.06806492,0.717182593,0.926229508,0.684848485,-1.345878463
+4791,18141.02874,892.954023,471.2068966,1046.781609,15951.74138,703.0057471,452.5287356,1427.95977,7867.66092,681.8218391,340.7873563,1672.074713,9854.724138,1368.982759,1161.867816,1100.367816,3735.109195,1541.37931,285.2758621,2246.574713,8221.597701,407.1091954,548.1264368,473.1091954,10566.76437,419.1551724,118.8678161,1102.448276,8145.729885,1405.189655,466.4597701,2800.097701,7415.097701,655.5114943,270,1114.747126,4571.413793,820.6091954,401.316092,1312.373563,2730.091954,735.0287356,163.2701149,1213.017241,2792.810345,1531.022989,9732.741379,3164.626437,599.5689655,1064.143678,174,16.09614417,14.06886761,0.485832312,0.945652174,0.6796875,-1.228590075
+4792,22525.23776,861.027972,516.7412587,1079.552448,20331.83916,676.6363636,630.6223776,1546.265734,9331.65035,668.4475524,1130.832168,1775.874126,12195.41958,1231.174825,2455.13986,3404.972028,4456.51049,1175.251748,285.3076923,2276.293706,9731.608392,355.9020979,397.8321678,1263.20979,12264.76224,750.972028,133.9370629,1663.874126,9119.041958,1834.377622,390.4335664,2799.685315,7853.895105,701.958042,252.7762238,1135.65035,4370.412587,1497.167832,374.3426573,1315.979021,2621.433566,665.1748252,150.3006993,2525.762238,2572.272727,1257.979021,1643.972028,3152.538462,710.3496503,1065.657343,143,16.40202738,11.54039623,0.710600497,0.940789474,0.647058824,0.158414576
+4793,27302.64327,859.7836257,529.5964912,1085.929825,24749.74854,677.5321637,685.1345029,1592.561404,10842.80117,540.7953216,1077.690058,1744.473684,14773.61404,1198.081871,3387.222222,2925.315789,5323.561404,1187.426901,291.6783626,2330.035088,11816.02924,419.8888889,427.2631579,984.6432749,14476.60234,798.9532164,125.9766082,2771.19883,10791.94737,1674.140351,366.5263158,2788.619883,9040.397661,643.1578947,258.4035088,1031.380117,4806.578947,1004.619883,389.2163743,1302.005848,2985.222222,692.4152047,142.3859649,2492.77193,2818.45614,1186.239766,896.1578947,3245.666667,766.251462,1065.368421,171,15.57633683,14.12707941,0.421221603,0.960674157,0.7125,0.416310223
+4794,34750.58333,980.7361111,632.2638889,1119.125,29753.83333,778.3888889,874.2361111,1668.013889,14510.27778,614.1666667,1064.180556,1785.569444,18241.27778,1422.027778,2335.944444,3440.194444,6717.444444,1366.291667,353.2222222,2324.611111,15056.73611,453.8194444,129.1666667,1356.25,19313.19444,537.4444444,155.2222222,3168.361111,14735.83333,1866.597222,419.6111111,2795.847222,13246.45833,648.9444444,299.8888889,1574.944444,7557.569444,1399.625,449.8888889,1345.875,4293.75,622.3611111,162.0277778,3089.638889,4290.791667,1399.958333,918.9305556,3277,538.0138889,1063.958333,72,11.52649677,9.018382904,0.622770587,0.837209302,0.5,-0.850510248
+4795,29211.48718,1023.945055,493.8681319,1084.56044,25821.13187,762.1831502,468.4615385,1531.710623,12622.78388,617.9047619,587.6556777,1684.996337,15751.85348,1386.395604,944.2417582,2100.967033,5845.772894,1321.131868,310.7838828,2267.047619,12875.2967,421.0622711,152.003663,559.2490842,16476.1978,446.0659341,120.2490842,1504.567766,12538.27839,1450.080586,454.0769231,2815.010989,11225.19414,618.3223443,280.7472527,1414.589744,6606.692308,1006.85348,420.4065934,1323.179487,3849.197802,620.4871795,157.2967033,1396.410256,3762.369963,1375.347985,1225.490842,3190.186813,584.9267399,1069.25641,273,20.70105099,17.37116136,0.543909421,0.944636678,0.758333333,0.339435932
+4796,18436.92742,951.1209677,496.75,1063.854839,16801.94355,703.8225806,487.6935484,1443.008065,8134.66129,566.9354839,512.0322581,1655.564516,9799.153226,1331.919355,941.1532258,1262.887097,3615.548387,1164.556452,290.9596774,2241.879032,7405.08871,365.0725806,152.3387097,598.8306452,9254.306452,411.0403226,122.4516129,1422.491935,7076.008065,1282.604839,371.6854839,2786.258065,6260.814516,600.266129,249.5725806,1172.741935,3697.258065,855.0564516,369.6290323,1277.58871,2302.846774,590.6612903,150.2741935,1594.387097,2163.637097,1330.983871,4518.370968,3136.322581,641.6935484,1066.798387,124,14.98539306,10.70398765,0.699844986,0.932330827,0.681318681,0.570226752
+4797,23839.61212,880.3393939,517.1939394,1061.084848,20848.06061,667.5212121,614.3090909,1480.490909,10580.97576,612.7818182,705.5272727,1694.09697,13217.9697,1212.678788,1503.527273,1893.733333,5057.060606,1211.393939,286.0727273,2503.975758,10735.81212,367.3515152,531.830303,1156.806061,13865.35758,545.8,113.2666667,1559.018182,10662.21818,1550.412121,382.630303,2786.49697,9456.448485,750.3757576,251.5090909,1201.175758,5562.557576,1075.363636,374.2848485,1325.230303,3449.587879,681.6363636,154.6242424,2185.727273,3359.272727,1355.624242,7283.260606,3146.139394,655.1212121,1068.436364,165,22.54146782,9.867942881,0.899087763,0.89673913,0.515625,0.947708204
+4798,16170.33333,858.75,596.9444444,1054.319444,14433.52778,677.6805556,547.4444444,1485.652778,6682.083333,513.7222222,707.1111111,1747.833333,8887.902778,1178.152778,5027.541667,3317.347222,3287.611111,1129.944444,262.5694444,2363.972222,7383.972222,515.4444444,231.9861111,696.625,9376.819444,648.3333333,108.375,2276.625,7130.722222,1764.819444,488.2083333,2797.944444,6225.763889,741.0972222,242.2638889,1128.083333,3472.819444,1064.527778,377.0555556,1301.861111,2181.138889,595.25,151.3194444,5151.763889,2147.069444,1179.694444,1128.25,3228.180556,730.7777778,1066.541667,72,10.84778039,9.028164788,0.554386743,0.947368421,0.654545455,0.936922052
+4799,30589.21138,946.8943089,565.1300813,1110.317073,25864.62602,708.3414634,766.3414634,1630.03252,11951.87805,573.9674797,915.5691057,1748.682927,15840.68293,1245.373984,2982.130081,2404.300813,5751.780488,1180.682927,328.195122,2390.365854,12459.33333,375.6666667,939.7723577,862.2357724,15787.35772,519.8780488,121.3170732,2051.926829,11551.91057,1852.463415,345.2276423,2810.99187,9695.764228,732.9512195,263.5284553,977.9105691,5164.292683,959.6585366,387.9837398,1330.918699,3105.593496,828.8617886,144.6504065,2550.495935,3071.97561,1213.910569,835.3821138,3289.243902,748.4146341,1069.252033,123,17.76600294,9.142972134,0.857410539,0.953488372,0.516806723,-0.7322273
+4800,36591.42446,945.6618705,506.7985612,1100.230216,32449.86331,760.6043165,687.6115108,1592.956835,15992.58273,604.4028777,1470.539568,1757.827338,19960.27338,1359.251799,1968.23741,2743.726619,7273.561151,1330.597122,335.705036,2475.194245,16101.92806,525.5323741,135.2446043,783.3597122,20961.51799,920.7266187,227.2158273,2241.438849,15939.30216,1756.611511,428.6115108,2834.446043,14208.4964,623.3956835,300.9136691,1442.359712,7736.47482,1501.136691,438.1223022,1332.071942,4465.834532,625.5035971,172.2733813,3050.129496,4467.791367,1431.079137,2613.280576,3238.165468,555.0071942,1069.81295,139,17.10145886,11.24934739,0.753192249,0.908496732,0.643518519,0.224781074
+4801,22499.2638,849.4294479,642.3803681,1104.153374,19364.34969,669.3803681,706.7668712,1591.07362,8123.552147,507.6319018,1375.01227,1774.668712,11357.69325,1187.883436,4933.582822,3782.251534,4234.760736,1159.325153,284.3067485,2466.625767,8922.509202,419.0368098,722.2331288,1304.834356,11100.55828,680.0122699,124.8404908,2643.08589,7998.141104,2110.834356,442.8159509,2813.398773,6722.595092,650.5092025,248.6564417,1031.018405,3462.944785,1363.441718,370.4969325,1313.766871,2074.08589,720.196319,150.5889571,2835.705521,2098.907975,1145.472393,606.398773,3147.276074,787.9263804,1069.220859,163,15.98932889,13.63734773,0.522069296,0.931428571,0.639215686,0.624189469
+4802,23029.04587,860.6238532,1005.183486,1161.119266,19857.28899,664.2981651,805.5412844,1656.591743,8614.481651,620.9082569,1248.697248,1803.137615,11437.50459,1168.348624,3371.779817,2844.619266,4170.545872,1195.87156,292.4770642,2422.068807,9264.119266,379.4862385,469.6788991,969.7293578,11525.65596,706.0275229,116.4770642,2449.298165,8199.926606,1777.944954,340.8669725,2818.174312,7088.142202,600.3990826,248.766055,1003.444954,3427.706422,1093.56422,389.4311927,1332.495413,2120.293578,659.9082569,146.5321101,2143.068807,2166.119266,1139.770642,418.2981651,3185.307339,488.5,1072.279817,218,20.81652941,13.49777718,0.761285945,0.956140351,0.741496599,-0.006868039
+4803,17261.27551,852.5612245,411.4387755,1027.704082,14568.87755,653.7244898,485.1020408,1401.040816,7341.479592,604.8061224,364.5306122,1625.163265,9180.816327,1238.326531,652.1632653,1168.77551,3596.193878,1252.622449,275.5918367,2231.132653,7888.642857,375.5918367,325.122449,545.9591837,10078.12245,396.2755102,108.5714286,1000.602041,7809.071429,1304.367347,354.4489796,2799.622449,7125.571429,811.1326531,259.5306122,1155.102041,4199,795.3571429,371.1734694,1321.469388,2491.27551,665.255102,149.4387755,1051.918367,2580.55102,1466.214286,12060.18367,3122.27551,611.6734694,1068.632653,98,12.83376749,10.10560406,0.61641299,0.890909091,0.636363636,-1.398471384
+4804,18794.78704,821.3703704,508.4722222,1063.546296,17145.16667,671.3611111,522.1666667,1429.083333,8521.361111,546.4074074,810.3333333,1731.009259,10593.59259,1294.175926,1014.435185,1889.37963,4065.722222,1273.046296,306.2685185,2544.546296,9116.388889,404.0740741,346.4259259,1027.074074,11684.23148,425.3148148,119.1111111,1154.824074,8927.212963,1502.462963,352.4259259,2802.731481,8031.175926,579.4351852,263.3888889,1192.916667,4660.583333,1127.814815,409.1018519,1334.722222,2770.157407,628.2407407,166.4814815,2918.796296,2861.305556,1341.916667,1959.768519,3108.916667,565.2222222,1071.268519,108,13.84214344,10.28876638,0.668966161,0.923076923,0.642857143,0.613997034
+4805,31072.72274,990.3115265,539.0560748,1142.049844,28316.45794,760.3115265,612.6137072,1647.560748,12872.1215,616.2024922,746.7352025,1733.507788,16551.42991,1372.523364,1962.34891,2628.227414,5807.94704,1354.417445,333.2554517,2348.161994,13095.33022,427.1090343,149.9345794,633.423676,16656.86604,478.7102804,141.6417445,2104.975078,12371.07165,1613.417445,447.9065421,2816.161994,10939.64798,636.4984424,294.1931464,1367.336449,5911.130841,998.8193146,432.1246106,1323.682243,3439.358255,615.1838006,164.4267913,2064.049844,3435.728972,1360.738318,1063.274143,3204.087227,546.3800623,1079.71028,321,26.41768806,17.38862769,0.752826391,0.881868132,0.587912088,0.276998166
+4806,18232.04317,961.2374101,529.676259,1053.23741,16454.20863,671.381295,655.1294964,1482.94964,7856.906475,553.5251799,961.8057554,1711.352518,10285.1223,1252.294964,2182.784173,2694.532374,3920.913669,1145.381295,284.2446043,2468.517986,8533.553957,353.4604317,436.9280576,829.4460432,11064.23741,444.6690647,111.0719424,2031.007194,8287.28777,1764.94964,362.7625899,2793.165468,7276.877698,624.1366906,249.6978417,1154.467626,4109.079137,1296.942446,369.6690647,1301.359712,2550.158273,678.7697842,147.2302158,2618.223022,2401.971223,1213.719424,1734.079137,3268.705036,686.3165468,1072.366906,139,14.37730296,12.35724369,0.511141383,0.945578231,0.712820513,1.181165756
+4807,24445.95,865.0333333,863.225,1129.858333,15548.68333,604.9833333,657.9583333,1443.425,6896.841667,573.7333333,651.15,1733.416667,8596.1,1084.75,3871.066667,2325.266667,3231.875,1100.6,271.15,2309.633333,7174.225,313.5416667,331.5083333,889.9416667,8301.866667,416.3333333,109.4416667,2427.658333,6150.933333,1722.1,349.3166667,2814.325,5444.491667,557.8333333,233.4166667,998.4333333,2471.333333,921.8916667,364.225,1313.158333,1513.066667,588.6666667,142.4333333,2172.366667,1576.491667,1070.933333,381.3916667,3084.083333,475.8416667,1072.958333,120,12.72280328,12.16969136,0.291647263,0.94488189,0.769230769,0.109413252
+4808,32778.04348,940.2536232,668.3478261,1123.731884,28790.77536,724.4855072,694.8333333,1657.021739,12814.30435,648.6086957,831.4275362,1815.869565,17091.28986,1284.326087,1977.173913,3188.007246,6122.144928,1272.811594,335.2173913,2358.905797,13928.76812,422.2536232,713.2391304,819.942029,17602.75362,641.2753623,148.4492754,2359.594203,13120.7029,1719.65942,358.3985507,2811.123188,11513.53623,877.8550725,291.6304348,1161.15942,6077.797101,1286.673913,425.3188406,1351.768116,3545.108696,883.7536232,161.615942,2623.456522,3535.804348,1325.65942,1009.101449,3261.014493,516.9130435,1072.166667,138,17.90533174,10.44483305,0.812230608,0.884615385,0.660287081,-1.298206662
+4809,30556.76966,927.9719101,560.9831461,1094.258427,27251.58427,702.0842697,731.3370787,1568.780899,12572.8427,576.5730337,939.3202247,1733.08427,16523.19101,1263.926966,1966.747191,1841.882022,6034.488764,1254.280899,331.5898876,2289.061798,13858.70225,443.3595506,193.1741573,915.0337079,17501.8764,685.8483146,339.505618,1927.196629,13359.67978,1623.539326,320.2022472,2802.977528,11749.44944,709.8988764,275.1011236,1033.533708,6460.337079,1124.803371,418.2191011,1304.662921,3675.573034,626.9044944,159.9775281,2047.421348,3735.657303,1277.224719,707.3595506,3216.101124,530.1067416,1076.286517,178,17.5424078,13.50753682,0.638051947,0.903553299,0.585526316,-0.203951662
+4810,15474.28916,1056.204819,533,1082.831325,13832.16867,850.4216867,542.6626506,1675.831325,6593.036145,651.2168675,424.3855422,1696.722892,8256.168675,1453.421687,1539.072289,1811.156627,3191.518072,1404.301205,353.6506024,2264.722892,7189.168675,458.9036145,545.2048193,568.8795181,9395.253012,485.7108434,121.2891566,1209.506024,6992.759036,1652,390.6144578,2806.361446,6374.46988,662.8674699,309.4819277,1141.144578,3826.554217,1111.686747,430.3012048,1307.445783,2312.168675,960.8313253,160.3855422,1287,2446.53012,1521.13253,2560.180723,3114.457831,624.1204819,1071.156627,83,11.9824211,8.922110148,0.667510985,0.93258427,0.768518519,1.5634626
+4811,19662.48315,837,527.8202247,1100.05618,17461.82022,651.8314607,662.8988764,1565.752809,7984.921348,599.4606742,758.4606742,1750.089888,10627.06742,1151.786517,1614.842697,2164.539326,3901.359551,1157.573034,295.0561798,2467.044944,8816.089888,368.5842697,468.8651685,847.5505618,11006.07865,559.6853933,111.0337079,1456.033708,8218.910112,1670.370787,366.0224719,2790.134831,7097.123596,660.4831461,252.258427,1054.88764,3847.505618,1091.539326,382.494382,1277.921348,2332.393258,727.258427,149.3033708,1858.11236,2344.460674,1220.932584,1225.842697,3162.47191,704.2696629,1074.168539,89,13.44971799,8.707708494,0.7621276,0.946808511,0.622377622,1.018829707
+4812,34056.93233,1069.766917,666.0902256,1134.864662,27998.54135,753.1578947,623.6992481,1714.488722,12493.85714,607.7744361,935.924812,1797.714286,16791.28571,1308.721805,3866.714286,3419,6024.977444,1193.578947,310.2030075,2361.744361,12566.65414,369.8496241,557.7293233,1073.864662,15881.28571,648.6090226,120.5714286,3491.984962,11570.74436,1721.676692,356.406015,2785.428571,9487.330827,603.2406015,260.9774436,966.7067669,4781.593985,1198.586466,384.9774436,1308.315789,2824.954887,729.8646617,145.443609,2467.203008,2821.165414,1172.556391,395.3759398,3280.571429,754.2706767,1076.518797,133,16.56223616,10.52759306,0.771986945,0.956834532,0.633333333,-0.76149213
+4813,29851.11864,907.1016949,603.1355932,1096.855932,25880.90678,691.0423729,709.2118644,1646.338983,11602.27966,528.5,1038.169492,1750.847458,15451.88983,1235.118644,2773.305085,3738.372881,5613.822034,1162.70339,297.3220339,2375.466102,12128.02542,355.7288136,241.8305085,1833.127119,15294.92373,452.7033898,130.7881356,2436.432203,11421.63559,1917.042373,370.3644068,2783.788136,9527.847458,753.2627119,256.0084746,1039.305085,4880.822034,1277.788136,381.2966102,1305.084746,2862.279661,625.3474576,145.1694915,2620.737288,2840.686441,1219.330508,988.279661,3271.601695,719.6186441,1076.813559,118,12.67232743,11.8602121,0.352227875,0.967213115,0.819444444,1.033448945
+4814,25881.00806,855.9032258,1045.733871,1176.862903,23233.27419,668.2096774,826.3145161,1686.104839,10255.84677,523,1138.943548,1804.225806,13891.84677,1184.580645,2160.201613,2858.427419,5102.129032,1165.16129,284.6854839,2345.41129,11088.08871,361.9596774,418.8306452,1558.919355,14201.67742,544.1935484,117.233871,2077.064516,10511.05645,1871.177419,367.6854839,2796.298387,8786.685484,838.8548387,264.6129032,1034.637097,4573.548387,1118.443548,387.2822581,1321.419355,2746.693548,656.8225806,146.0806452,2470.459677,2744.072581,1193.120968,652.3387097,3228.16129,732.3467742,1077.193548,124,13.11782817,12.11686947,0.383129149,0.976377953,0.794871795,0.93241688
+4815,25806.50746,855.6776119,529.5373134,1068.710448,22229.64179,670.6119403,646.7074627,1589.81791,10618.08358,560.2537313,762.3522388,1736.901493,13370.65373,1208.734328,1997.949254,2309.143284,5194.41194,1202.113433,295.8776119,2312.746269,11422.94627,388.7910448,299.4089552,1011.170149,14263.88955,464.2447761,139.3850746,1588.552239,10855.38209,1671.131343,423.319403,2806.480597,9697.18806,740.7791045,261.1940299,1171.026866,5339.459701,1102.552239,380.4597015,1310.262687,3162.576119,631.280597,147.4895522,1821.379104,3136.737313,1292.79403,1039.510448,3151.585075,607.9522388,1081.489552,335,28.48304087,15.79071863,0.832256877,0.883905013,0.629699248,-1.323135754
+4816,19072.52866,844.9426752,545.343949,1053.197452,16549.00637,645.8535032,552.7643312,1493.751592,7834.140127,540.3949045,838.343949,1739.318471,9757.643312,1166.757962,2217.993631,2052.22293,3919.165605,1209.146497,274.3057325,2273.280255,8276.031847,395.866242,720.3566879,899.955414,10407.04459,469.6687898,109.2738854,1601.312102,7921.949045,1660.267516,515.0127389,2806.617834,7045.687898,688.5095541,244.2993631,1149.503185,3951.433121,1063.942675,367.8407643,1298.910828,2372.369427,774.6433121,140.6815287,2702.541401,2414.012739,1226.764331,706.2101911,3149.866242,629.5987261,1081.878981,157,16.73517703,12.29062626,0.678696718,0.94011976,0.654166667,0.651491473
+4817,31024.8742,936.4520256,569.0255864,1102.833689,26969.57783,698.8678038,718.7420043,1603.643923,12564.11514,596.1940299,894.8336887,1739.906183,16426.48827,1247.61194,2246.38806,2978.091684,6190.660981,1214.98081,290.0149254,2469.4371,13210.70789,376.8315565,361.0234542,1073.895522,16765.72921,585.0533049,181.3304904,2673.334755,12602.1258,1685.481876,402.4690832,2796.17484,10876.53731,785.1172708,268.5181237,1185.006397,5773.377399,1074.317697,384.4776119,1316.733475,3510.364606,670.7292111,147.6972281,2186.304904,3410.795309,1263.501066,782.2324094,3218.724947,651.4115139,1082.816631,469,32.97851969,18.61382976,0.825485831,0.907156673,0.697916667,1.421254527
+4818,28411.14957,890.6330435,553.8104348,1087.022609,23989.22087,681.0017391,621.8121739,1582.116522,10719.48174,540.7965217,921.6434783,1728.994783,14137.50087,1209.085217,2631.846957,2949.213913,5282.038261,1145.285217,282.8121739,2309.766957,11304.92696,343.0052174,212.7791304,978.2643478,14520.84,640.0104348,145.8156522,2896.622609,10279.70087,1560.954783,363.653913,2791.349565,8803.483478,618.2765217,244.9965217,1082.309565,4345.690435,1058.871304,365.7947826,1287.166957,2625.53913,594.1634783,144.2278261,2102.516522,2618.737391,1181.17913,700.853913,3142.972174,684.4295652,1089.692174,575,38.00190453,20.17417052,0.84745163,0.912698413,0.579637097,0.828814205
+4819,33469.1694,953.7595628,623.7486339,1115.431694,29655.91257,764.0273224,886.0273224,1670.125683,13566.60109,649.6120219,1690.289617,1832.989071,17800.43716,1314.666667,2917.218579,3977.737705,6765.868852,1234.218579,301.1256831,2430.273224,14604.83607,411.3169399,323.9180328,1442.710383,18849.91803,498.2404372,181.4535519,2023.120219,13930.3388,2236.448087,390.8469945,2813.213115,12239.57923,687.6229508,288.2295082,1279.142077,6634.191257,1477.060109,413.8797814,1350.497268,3841.349727,654.9562842,155.0928962,2809.896175,3778.759563,1328.770492,1566.830601,3201.169399,589.4754098,1085.513661,183,18.96655285,13.23331402,0.716372077,0.879807692,0.598039216,0.825679894
+4820,18029.71591,698.8863636,475.9090909,981.4204545,16357.47727,557.7045455,687.3295455,1381.409091,6497.295455,464.5909091,1087.954545,1708.022727,8616.204545,1064.079545,3466.704545,2985.647727,3181.965909,1032.340909,240.0340909,2393.147727,6480.659091,297.0454545,248.8295455,1392.738636,7762.011364,536.0795455,103.9659091,2944.659091,5869.909091,1975.034091,311.1704545,2774.715909,4753.454545,508.6136364,232.9545455,879.8863636,2242.443182,1146.852273,338.8977273,1270.75,1436.261364,599.4772727,145.2840909,1646.204545,1463.897727,1019.875,270.5,3031.022727,752.75,1087.875,88,12.88562484,9.253094799,0.69594573,0.897959184,0.666666667,0.957043206
+4821,16663.31818,918.8896104,592.4220779,1113.168831,14460.98701,669.512987,551.6103896,1553.292208,6450.363636,570.5974026,743.5714286,1773.409091,8279.136364,1203.538961,2151.24026,2188.558442,3193.402597,1600.701299,283.2857143,2290.266234,7050.883117,374.8181818,199.7012987,1060.61039,8511.383117,471.6948052,110.8376623,2289.331169,6521.811688,1532.798701,298.3051948,2842.896104,5753.175325,595.7662338,249.8376623,1114.045455,2975.525974,988.7857143,384.8571429,1316.785714,1767.123377,604.5714286,155.0064935,3352.824675,1826.668831,1162.292208,518.961039,3162.61039,559.5974026,1091.577922,154,18.15030705,11.68328834,0.76528091,0.900584795,0.57037037,-0.342314995
+4822,24303.67339,847.4919355,682.3991935,1087.040323,20231.05645,641.4959677,761.8145161,1550.205645,9459.254032,542.6048387,1148.193548,1756.467742,12225.40726,1147.822581,3659.919355,3115.084677,4849.274194,1120.846774,267.8024194,2366.669355,10215.43548,345.1048387,475.7096774,1330.322581,12767.6129,598.9516129,115.375,2522.350806,9422.931452,2069.883065,513.6935484,2786.955645,8182.576613,999.9677419,246.9475806,1026.133065,3994.149194,1323.616935,352.0967742,1324.274194,2428.96371,664.2862903,141.9274194,4181.064516,2517.875,1156.274194,511.3629032,3163.528226,619.983871,1092.959677,248,21.73441363,15.5658204,0.697912404,0.864111498,0.551111111,1.432242241
+4823,28656.2561,878.2560976,585.3292683,1109,26340.39024,704.0731707,780.1707317,1667.987805,10873.62195,554.097561,917.597561,1754.121951,13894.54878,1200.146341,3076.402439,2854.682927,5523.829268,1184.47561,287.5365854,2339.085366,12032.81707,380.597561,234.695122,745.7926829,14771.08537,533.0487805,131.6219512,2374.512195,10363.86585,1905.060976,349.4146341,2797.317073,9098.963415,700.6341463,272.7560976,1087.865854,4526.353659,1215.573171,388.9268293,1316.890244,2884.390244,635.4268293,145.5609756,2076.585366,2662.47561,1233.182927,1243.54878,3194.195122,583.3170732,1093.573171,82,12.06003923,9.539788552,0.611784252,0.964705882,0.630769231,0.203022727
+4824,22054.81818,685.8484848,424.8522727,999.3674242,19502,564.1212121,533.6401515,1392.80303,8292.32197,522.5,666.6287879,1670.159091,10429.95076,1008.814394,2310.219697,1606.685606,4121.117424,1026.170455,232.2878788,2289.689394,8755.742424,307.3939394,305.0530303,920.5757576,10190.22727,440.8939394,187.3295455,2048.893939,7579.159091,1631.219697,316.6780303,2784.416667,6559.219697,660.6287879,221.9734848,876.6439394,3082.431818,860.8030303,338.7878788,1294.844697,1929.806818,611.5265152,135.1818182,1765.609848,1834.310606,1031.242424,313.3257576,3038.810606,607.0643939,1101.583333,264,22.54949397,15.90532077,0.708857655,0.882943144,0.661654135,0.69183765
+4825,23992.8526,850.2514451,529.8988439,1038.630058,18614.19075,589.2572254,482.265896,1413.858382,7905.135838,495.265896,572.5,1692.979769,10212.27746,1042.635838,2429.346821,1848.277457,3843.011561,1033.361272,243.0144509,2259.849711,8138.063584,1081.375723,194.1127168,673.8468208,9755.317919,408.5606936,100.1936416,3065.66763,7173.176301,1507.528902,315.8150289,2788.537572,6309.33526,562.4682081,221.1965318,922.517341,3052.216763,873.6907514,335.0635838,1286.430636,1860.872832,573.0144509,133.7456647,1829.913295,1734.875723,1000.557803,285.982659,3087.300578,641.5924855,1100.132948,346,23.1498058,19.37556441,0.547257266,0.945355191,0.791762014,-1.39051567
\ No newline at end of file
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/phenotype_workflow.csv	Tue Jul 19 20:30:34 2022 +0000
@@ -0,0 +1,23 @@
+,,ASMA,CD163,CD206,CD68,CD20,CD21,CD3D,CD45,CD56,CD8A,FOXP3,CD11B,CD11C,CD15,CD4,PD1,HLADR,CD25
+all,Other Immune cells,,,,,,,,pos,,,,,,,,,,
+all,ASMA+ cells,pos,,,,,,,,,,,,,,,,,
+Other Immune cells,T cells,,,,,,,pos,,,,,,,,,,,
+Other Immune cells,B cells,,,,,pos,,,,,,,,,,,,,
+Other Immune cells,Myeloid Lineage,,anypos,anypos,anypos,,,,,,,,anypos,anypos,,,,,
+Other Immune cells,NK cells,,,,,,,,,pos,,,,,,,,,
+Other Immune cells,Granulocytes,,,,,,,,,,,,,,pos,,,,
+Myeloid Lineage,T cells,,,,,,,pos,,,,,,,,,,,
+Myeloid Lineage,B cells,,,,,pos,,,,,,,,,,,,,
+Myeloid Lineage,NK cells,,,,,,,,,pos,,,,,,,,,
+Myeloid Lineage,Granulocytes,,,,,,,,,,,,,,pos,,,,
+T cells,CD4 T cells,,,,,,,,,,,,,,,pos,,,
+T cells,CD8 T cells,,,,,,,,,,pos,,,,,,,,
+CD4 T cells,Regulatory T cells,,,,,,,,,,,pos,,,,,,,
+CD4 T cells,Follicular Helper T cells,,,,,,,,,,,,,,,,pos,,
+CD8 T cells,PD1+ T cells,,,,,,,,,,,,,,,,pos,,
+Myeloid Lineage,CD68+ Macrophages,,,,pos,,,,,,,,,,,,,,
+Myeloid Lineage,M2 Macrophages,,anypos,anypos,,,,,,,,,,,,,,,
+Myeloid Lineage,Myeloid Dendritic cells,,,,,,,,,,,,,,,,,pos,
+Myeloid Lineage,Follicular Dendritic cells,,,,,,pos,,,,,,,,,,,,
+CD68+ Macrophages,M1 Macrophages,,,,,,,,,,,,,,,,,pos,
+Myeloid Dendritic cells,CD25+ Dendritic cells,,,,,,,,,,,,,,,,,,pos
\ No newline at end of file
Binary file test-data/tutorial_data.h5ad has changed
Binary file test-data/tutorial_data_pheno.h5ad has changed